Skip to main content

Multiple sequence alignments of partially coding nucleic acid sequences

Abstract

Background

High quality sequence alignments of RNA and DNA sequences are an important prerequisite for the comparative analysis of genomic sequence data. Nucleic acid sequences, however, exhibit a much larger sequence heterogeneity compared to their encoded protein sequences due to the redundancy of the genetic code. It is desirable, therefore, to make use of the amino acid sequence when aligning coding nucleic acid sequences. In many cases, however, only a part of the sequence of interest is translated. On the other hand, overlapping reading frames may encode multiple alternative proteins, possibly with intermittent non-coding parts. Examples are, in particular, RNA virus genomes.

Results

The standard scoring scheme for nucleic acid alignments can be extended to incorporate simultaneously information on translation products in one or more reading frames. Here we present a multiple alignment tool, codaln, that implements a combined nucleic acid plus amino acid scoring model for pairwise and progressive multiple alignments that allows arbitrary weighting for almost all scoring parameters. Resource requirements of codaln are comparable with those of standard tools such as ClustalW.

Conclusion

We demonstrate the applicability of codaln to various biologically relevant types of sequences (bacteriophage Levivirus and Vertebrate Hox clusters) and show that the combination of nucleic acid and amino acid sequence information leads to improved alignments. These, in turn, increase the performance of analysis tools that depend strictly on good input alignments such as methods for detecting conserved RNA secondary structure elements.

Background

Multiple sequence alignments are a crucial prerequisite for a diverse set of methods ranging from the reconstruction of phylogenies and the quantification of adaptive evolution, to the detection of conserved RNA secondary structures and protein motifs. In this contribution we present a novel alignment tool that has been developed primarily with the aim of improving multiple alignments of viral genomes. The genomes of RNA viruses often carry conserved RNA structures that perform vital functions during the life cycle of the virus. In many cases only a small part of the viral genome is functionally relevant at the level of RNA. Algorithms for the systematic search of conserved secondary structure patterns in large RNA, such as QRNA [1], alidot [2–4], RNAz [5], and RNAdecoder [6] are based on the observation that a small number of point mutations is very likely to cause large changes in the secondary structures [7]. Secondary structure elements that are consistently present in a group of sequences with less than, say, 95% average pairwise identity are therefore most likely the result of stabilizing selection, not a consequence of the high degree of sequence conservation.

A comprehensive analysis of the genomic secondary structure features using alidot is available for Picornaviridae [8], Flaviviridae [9], and Hepadnaviridae [10, 11]. A preliminary survey across a large subset of the available sequence data was presented very recently [12].

The comparative approach to detect conserved RNA structures is obviously dependent upon high-quality multiple alignments: even a relative small number of alignment errors, which act like randomly placed mutations, will obscure the signals from consistent and compensatory point mutations and, hence, decrease the sensitivity of the RNA detection algorithms. While we eventually need an alignment of the genomic nucleic acid sequence, we observe that an overwhelming part of a viral genome codes for one or more proteins in one or more (overlapping) frames.

In contrast to the protein sequences, which are often easily alignable, the sequence similarities are drastically reduced on the nucleic acid level due to the redundancies of the genetic code, see Fig. 1. It is desirable, therefore, to utilize the amino acid sequence when aligning coding nucleic acid sequences with higher sequence divergence. This is sometimes done by aligning protein sequences and subsequently back-translating to nucleic acids. In many cases, however, only a part of the sequence of interest is translated in vivo. In addition, there may be alternative proteins encoded in overlapping reading frames within the same nucleic acid sequences. Such overlapping reading frames are best known from viruses, including Hepatitis B [13, 14], Influenza [15], and Umbraviruses [16]. Recently, however, examples have been found in prokaryotic [17, 18] and even in eukaryotic genomes [19, 20].

Figure 1
figure 1

Example for the higher sequence heterogeneity on the level of nucleic acids. A hypothetical amino acid alignment on top represents a high degree of similarity. See the same sequences below on the level of nucleic acids with very low sequence similarity. The pairwise identity is only 33%, just slightly above the 25% identity expected for two random nucleic acid sequences.

In this contribution we describe a progressive alignment tool that implements an extended scoring scheme to incorporate simultaneously information on translation products in one or more ([partly] overlapping) reading frames which allows the user to combine all information from both the nucleic acid and amino acid sequences (if any). It makes explicit use of information about overlapping open reading frames, as they occur in many functional sequences, and allows arbitrary weighting for almost all scoring parameters, in order to gain more reliable scoring at certain regions of the nucleic acid sequences where additional amino acid scoring of underlying protein sequence can be utilized.

Implementation

The codaln program implements Gotoh's algorithm for pairwise sequence alignments with affine gap cost functions [21]. The only change compared to this standard recursive algorithm for nucleic acid sequence alignment concerns the (mis)match score σ(x i , y j ) of position i from sequence x with position j from sequence y. Instead of taking into account only the nucleic acid letters, each position is considered as a vector containing the nucleic acid letter and the amino acid that would arise from translation in each of the three possible reading frames provided the frame in question is actually translated. Thus, we have

σ(x i , y j ) = β0σ n (x i , y j ) +

β1σ p (π[x i xi+1xi+2], π[y j yj+1yj+2]) +

β2σ p (π[xi-1x i xi+1], π[yj-1y j yj+1]) +     (1)

β3σ p (π[xi-2xi-1x i ], π[yj-2yj-1y j ])

where π[uvw] denotes the amino acid corresponding to the codon uvw. Here β k = 1, k = 1, 2, 3, if both x and y are translated in the k-th reading frame, while β k = 0 if the k-th reading frame is not actually translated in either x or y (or if one chooses to ignore a particular reading frame). β0 is the relative weight of the the nucleic acid match score, usually 1. In non-coding (untranslated) regions we therefore retain only the nucleic acid score. Fig. 2 gives an example. Further, it is possible that one gives different weights for alternative reading frames, maybe dependent upon parameters such as preferred codon usage. Default is no preference.

Figure 2
figure 2

Application of the scoring model to a hypothetical alignment. Note that there are no amino acid contributions in the right hand part of the example because of the single indel that causes a frameshift. For illustration we show BLOSUM62 scores and simple scores for nucleic acids and gaps rather than the rescaled default values (His/Gln has score 0).

The score model is much simpler than the one proposed by Hein [22, 23] and implemented in combat [24] and CAT [25]. In contrast to these approaches, which enforce gap lengths that are multiples of three in order to maintain the reading frame, codaln does not use special gap penalties at all. Instead, it relies on the match scores from the coding regions to guide the alignment back into the correct reading frame after a frameshift insertion or deletion. This results in an algorithm that is both faster and able to handle overlapping reading frames.

In its current implementation codaln can deal with 18 different codon tables, including the standard genetic code (default), various non-canonical tables for certain groups of organisms, and 11 distinct codon tables for mitochondrial genomes.

The codon tables link the nucleic acid triplets with their encoded amino acids. They are used both for an automatic search for start and stop codons and for translation in the scoring function; see Tab. 1.

Table 1 18 codon tables can be utilized by the program for linking the nucleic acid triplets with their corresponding amino acids.

The program furthermore provides a flexible scheme for modifying the scoring model. Both amino acid and nucleic acid scores can be either taken from built-in defaults or read in from parameter files. A number of scaling factors can be specified in order to determine the relative weights of nucleic acids and/or amino acids in all the different reading frames. Tab. 2 summarizes the most important defaults. The program reads sequences in Pearson's (FASTA) format, GenBank file format, ViennaRNA format as well as completely unformatted sequences in any combination.

Table 2 Default scoring parameters (can be arbitrarily weighted or changed by user defined settings).

The program uses the information about translated regions, if contained in the input file. Alternatively, codaln attempts to detect all theoretically possible open reading frames which have a user-defined minimal length. Exons and fragmented coding regions are joined, translated, and the resulting amino acid sequences are then used for the scoring function in addition to the nucleic acid sequences. The program can optionally regard a sequence as circular so that a coding region can wrap around the ends of the sequence and is still scored correctly. An intermediate output reports the structure of annotated and inferred exons and open reading frames both in a text and in PostScript format, Fig. 3. At this stage, the user can stop the process, edit the annotation file, and restart the alignment procedure with the modified annotations. The coding regions that are used for scoring can be automatically defined, user defined, modified, or eliminated. Before restarting the alignment process, codaln again provides a text and PostScript output summarizing the modified annotation. If necessary, this process can be repeated. Multiple alignments are built from the pairwise alignments using the same progressive scheme that is used e.g. by ClustalW [26]: A guide tree is inferred from the pairwise distances and determines the order in which profiles are constructed from alignments of two sequences, a sequence and a profile, or two profiles.

Figure 3
figure 3

Reports on the annotated and inferred structure of the input sequences are automatically generated by codaln, respecting all user intervention.

The profile alignments respect the full model of both nucleic acid and amino acid (mis)match scores. In the present implementation, the sequences within a profile are unweighted; it would be straightforward, however, to include a weighting scheme that takes the relative distances of the sequences into account to reduce the weight of very similar sequences, as implemented e.g. in ClustalW.

Results

More plausible alignments

Not surprisingly, we observe that codaln multiple alignments of coding DNA sequences have a much larger fraction of gaps with a length divisible by three than ClustalW multiple alignments. This is the desired effect of including amino acid-based scoring contributions since it reduces biologically implausible frameshifts. In itself, this is of course not a direct evidence for real improvements of multiple nucleic acid sequence alignments, but it is a good indication that, in coding regions, codaln preferentially makes insertions and deletions at the protein level.

Unfortunately, good hand-curated multiple alignments of partially coding sequences do not seem to be available, so that a systematic quantitative analysis (using, e.g., the BAliBASE tools [27]) could not be performed. Pairwise alignments of coding DNA sequences are barely distinguishable from those obtained with combat [24] provided the amino acid contributions dominate codaln's scoring function. We therefore concentrate on a qualitative assessment of codaln alignments in particular application contexts.

Hox genes and their genomic neighborhood

Hox genes were first described in the fruitfly Drosophila melanogaster. They code for homeodomain containing transcription factors [28] and are characterized by a 60 amino-acid helix-turn-helix DNA binding homeodomain. This domain is highly conserved on the level of protein, but can be quite variable at the DNA level.

Vertebrates, in contrast to all invertebrates examined, have multiple Hox gene clusters that have arisen from a single ancestral cluster in the most recent common ancestor of chordates [29, 30]. This ancient cluster in turn evolved through tandem gene duplications from a more ancient hypothetical protohox cluster [31].

We applied both ClustalW and codaln to the genomic sequences at the Hox4 locus. Exon 2 of Hox4, which contains the homeobox, is highly conserved also on the level of nucleic acid, while exon 1 has a well-conserved amino acid sequence but exhibits high variability at the nucleic acid level. The non-coding sequence in the intron and the flanking sequences are highly variable. Thus, this example is a hard test case for our approach. Fig. 4 summarizes the gap lengths in the Hox4 alignments. A comparison of the number of gaps with a length divisible by 3 with the other gaps of other lengths is a useful indicator whether coding regions are reasonably aligned: Base triplets preferentially should not be disrupted as amino acids within a protein sequence cannot be disrupted. In this example, codaln produces 436 gaps with a length divisible by 3 (ClustalW: 330) and 797 others (ClustalW: 1113). While codaln produces a significantly higher fraction of gaps that are a multiple of 3 and correctly aligns the coding sequences in both exons, ClustalW only treats exon 2 correctly, which is highly conserved on the level of nucleic acids. The nucleic acid alignment for the more variable exon 1, in contrast, is much more divergent.

Figure 4
figure 4

Relative distribution of gaps in an alignment of genomic Hox4 sequences. The alignment is essentially gap-less in exon 2. ClustalW (above) returns a very poor alignment of exon 1 in which gaps occur with a broad distribution. In contrast, codaln respects the coding region so that almost all gap lengths in this area are divisible by 3.

Conserved RNA secondary structures in Levivirus genomes

Virus genomes serve as an ideal test case for a procedure that makes explicit usage of information about (overlapping) coding regions to improve the resulting alignments. Improved alignments, as we shall see, increase the sensitivity of the detection of secondary structure elements.

The members of the genus Levivirus infect eubacteria (Procarya). All members of the family Leviviridae (Levivirus and Allolevivirus) are ssRNA positive-strand viruses. The replication cycle includes no DNA stage. The virions are neither enveloped nor tailed with nucleocapsids that are isometric, 24–26 nm in diameter. The total genome length is 3466 up to 4276 nucleotides depending on type of strain. Most Levivirus species have four (partly) overlapping genes, while some exceptions exist which contain only three open reading frames [32, 33].

We have investigated 8 complete genomic sequences of the Levivirus genus: The Enterobacteria phages MS2, KU1, GA, and fr. Alignments of the genomic sequences were prepared using codaln and scanned for conserved RNA secondary structures using the alidot method [3]. The results are compared to earlier studies based on ClustalW alignments [10, 12].

The two different alignment processes produce results that seem to be similar at a first glance: The number of gaps and a visual interpretation of the quality of the alignment only does not already announce the significantly different results when further processing the alignments by alidot. Interestingly, the combination of codaln and alidot produces a weak signal at the basis of the Hogeweg mountain plot (see Fig. 5).

Figure 5
figure 5

Hogeweg mountain plots of conserved RNA structures in Levivirus genomes. Above: ClustalW, below: codaln. Colors indicate the number of consistent mutations: red 1, ochre 2, green 3, turquoise 4, blue 5; Saturated colors indicate that there are only sequences that are compatible to the structure prediction. Decreasing saturation of the colors indicates 1 or 2 non-compatible sequences. The thickness of the slabs is proportional to the average frequency of the base pair in the thermodynamic equilibrium. For further details see [3].

Long range interactions, so called panhandle structures, are known to play a role e.g. in the replication of Bunyaviridae [34] and Flaviviridae [35]. It will be interesting to see if the long-range interactions can be experimentally verified in Leviviridae as well.

At the 5'-terminal end of the Levivirus sequences we furthermore detect a short GC-rich hairpin(tetraloop) adjacent to an unpaired GGG element, see Fig. 6. This feature is probably the analogon to the recognition signal site for the RNA replicase in Alloleviviruses. This stem-loop-structure is well known and defined in Qβ (Allolevivirus).

Figure 6
figure 6

The 5'-terminal hairpin in Levivirus (left) is probably the analogon to the recognition signal site for the RNA replicase in Alloleviviruses which is well analyzed in Qβ (right). In Qβ the replicase amplifies RNA templates autocatalytically with high efficiency. This recognition element in Levivirus likely has a similar function.

The Qβ replicase amplifies RNA templates autocatalytically with high efficiency, and the recognition element, consisting of a hairpin and a short unpaired region at the 5'-terminus, is essential for recognition [36, 37].

Discussion

Algorithms for the the automatic detection of biologically functional secondary structure elements, such as the ones used here, are dependent upon accurate alignments. Clearly, the quality of alignments can be enhanced by including additional biological information. In the case of codaln, we make use of the information on the coding properties of a nucleic acid sequence into the alignment process. We demonstrate this in the case of alignments of the Hox4 genomic region which consists of non-coding regions and two coding exons, one containing the highly conserved homeodomain, while the other exon is poorly conserved on nucleic acid level. As expected, the quality of the alignment in the coding region can be increased significantly.

Virus genomes can serve as an ideal test case for a procedure that makes explicit usage of information about various (overlapping) coding regions. Above we have seen that additional conserved secondary structure elements become detectable with the improved alignment. Leviviruses are, despite their short genome, a quite complex example. The sequences are at least in part highly divergent at the nucleic acid level, so that the information on the coding sequences in codaln significantly improves the quality of the alignment. Using codaln instead of a purely nucleotide-based alignment program, we found a putative recognition signal site, analog to the one for the RNA replicase in Alloleviviruses.

Conclusion

The codaln program was specifically developed for applications to genomic sequences of RNA viruses with their partially overlapping reading frames and untranslated regions. The Hox gene example shows, however, that codaln is also applicable to other partially coding sequence data. The recent discovery of ORFs that overlap with different reading directions [38–40] suggest to extend codaln to such cases as well. Our framework makes such an extension straightforward.

Availability and requirements

C source code and documentation may be downloaded from http://www.bioinf.uni-leipzig.de/Software/ or http://www.tbi.univie.ac.at/~roman/Codaln/.

Hox4 data sources

The Hox4 sequences are taken from GenBank for Homo sapiens (HsA join(AC004080.2rc+AC010990 [201-6508]rc+AC004079 [75001-end]rc) [125253 126761], HsB NT_010783 [5306154 5309021]rc, HsC NT_009563 [586220 584941]rc, HsD NT_037537 [4224691 4225996]), Mus musculus (MmA NT_039343 [3862302 3864022]rc, MmB AC011194 [114551 116043], MmC NT_028016 [137212 139414], MmD AC015584 [164151 165456]), and Morone saxatilis (MsA AF089743 [29109 30386]). For Danio rerio the sequences are retrieved both from the web server of the Danio rerio Sequencing Project [41] and GenBank (DrAa AC107365rc [61628 62827], DrBa AL645782.2 [33537 35809], DrCa ctg23.10700001-10870000 [75679 77005]rc, DrD ctg13407.19000-191000 [61789 63580]rc).

rc = reverse complement; sequence intervals are listed in brackets.

References

  1. Rivas E, Eddy SR: Noncoding RNA gene detection using comparative sequence analysis. BMC Bioinformatics 2001, 2(8):19.

    Google Scholar 

  2. Hofacker IL, Fekete M, Flamm C, Huynen MA, Rauscher S, Stolorz PE, Stadler PF: Automatic Detection of Conserved RNA Structure Elements in Complete RNA Virus Genomes. Nucl Acids Res 1998, 26: 3825–3836. 10.1093/nar/26.16.3825

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  3. Hofacker IL, Stadler PF: Automatic Detection of Conserved Base Pairing Patterns in RNA Virus Genomes. Comp & Chem 1999, 23: 401–414. 10.1016/S0097-8485(99)00013-3

    Article  CAS  Google Scholar 

  4. Thurner C, Hofacker IL, Stadler PF: Conserved RNA Pseudoknots. In Proceedings of the GCB 2004 (Bielefeld), Volume P-53 of GI-Edition: Lecture Notes in Informatics Edited by: Giegerich R, Stoye J. 2004, 207–216.

    Google Scholar 

  5. Washietl S, Hofacker IL, Stadler PF: Fast and reliable prediction of noncoding RNAs. Proc Natl Acad Sci USA 2005, 102: 2454–2459. 10.1073/pnas.0409169102

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  6. Pedersen JS, Meyer IM, Forsberg R, Simmonds P, Hein J: A comparative method for finding and folding RNA secondary structures within protein-coding regions. Nucl Acids Res 2004, 32: 4925–4936. 10.1093/nar/gkh839

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  7. Schuster P, Fontana W, Stadler PF, Hofacker IL: From Sequences to Shapes and Back: A Case Study in RNA Secondary Structures. Proc Royal Soc London B 1994, 255: 279–284.

    Article  CAS  Google Scholar 

  8. Witwer C, Rauscher S, Hofacker IL, Stadler PF: Conserved RNA Secondary Structures in Picornaviridae Genomes. Nucl Acids Res 2001, 29: 5079–5089. 10.1093/nar/29.24.5079

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  9. Thurner C, Witwer C, Hofacker I, Stadler PF: Conserved RNA Secondary Structures in Flaviviridae Genomes. J Gen Virol 2004, 85: 1113–1124. 10.1099/vir.0.19462-0

    Article  CAS  PubMed  Google Scholar 

  10. Stocsits R, Hofacker IL, Stadler PF: Conserved Secondary Structures in Hepatitis B Virus RNA. In Computer Science in Biology. Bielefeld, D: Univ. Bielefeld; 1999:73–79. [Proceedings of the GCB'99, Hannover, D]

    Google Scholar 

  11. Kidd-Ljunggren K, Zuker M, Hofacker IL, Kidd AH: The hepatitis B virus pregenome: prediction of RNA structure and implications for the emergence of deletions. Intervirology 2000, 43: 154–64. 10.1159/000025041

    Article  CAS  PubMed  Google Scholar 

  12. Hofacker IL, Stocsits R, Stadler PF: Conserved RNA Secondary Structures in Viral Genomes: A Survey. Bioinformatics 2004, 20: 1495–1499. 10.1093/bioinformatics/bth108

    Article  CAS  PubMed  Google Scholar 

  13. Torresi J: The virological and clinical significance of mutations in the overlapping envelope and polymerase genes of hepatitis B virus. J Clin Virol 2002, 25: 97–106. 10.1016/S1386-6532(02)00049-5

    Article  CAS  PubMed  Google Scholar 

  14. Simmonds P: Reconstructing the origins of human hepatitis viruses. Philos Trans R Soc Lond B: Biol Sci 2001, 356: 1013–1026. 10.1098/rstb.2001.0890

    Article  CAS  Google Scholar 

  15. Yewdell J, Garcia-Sastre A: Influenza virus still surprises. Curr Opin Microbiol 2002, 5: 414–418. 10.1016/S1369-5274(02)00346-6

    Article  CAS  PubMed  Google Scholar 

  16. Taliansky ME, Robinson DJ: Molecular biology of umbraviruses: phantom warriors. J Gen Virol 2003, 84: 1951–1960. 10.1099/vir.0.19219-0

    Article  CAS  PubMed  Google Scholar 

  17. Rogozin IB, Spiridonov AN, Sorokin AV, Wolf YI, Jordan IK, Tatusov RL, Koonin EV: Purifying and directional selection in overlapping prokaryotic genes. Trends Genet 2002, 18: 228–232. 10.1016/S0168-9525(02)02649-5

    Article  CAS  PubMed  Google Scholar 

  18. Johnson ZI, Chisholm SW: Properties of overlapping genes are conserved across microbial genomes. Genome Res 2004, 14: 2268–2272. 10.1101/gr.2433104

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  19. Klemke M, Kehlenbach RH, Huttner WB: Two overlapping reading frames in a single exon encode interacting proteins – a novel way of gene usage. EMBO J 2001, 20: 3849–3860. 10.1093/emboj/20.14.3849

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  20. Poulin F, Brueschke A, Sonenberg N: Gene fusion and overlapping reading frames in the mammalian genes for 4E-BP3 and MASK . J Biol Chem 2003, 278: 52290–52297. 10.1074/jbc.M310761200

    Article  CAS  PubMed  Google Scholar 

  21. Gotoh O: An improved algorithm for matching biological sequences. J Mol Biol 1982, 162(3):705–708. 10.1016/0022-2836(82)90398-9

    Article  CAS  PubMed  Google Scholar 

  22. Hein J: An Algorithm Combining DNA and Protein Alignment. J Theor Biol 1994, 167: 169–174. 10.1006/jtbi.1994.1062

    Article  CAS  PubMed  Google Scholar 

  23. Hein J, Støvlbæk J: Combining DNA and Protein Alignment. Methods of Enzymology 1996, 266: 402–415.

    Article  CAS  Google Scholar 

  24. Pedersen CNS, Lyngsø RB, Hein J: Comparison of coding DNA. Proceedings of the 9th Annual Symposium of Combinatorial Pattern Matching (CPM) 1998.

    Google Scholar 

  25. Hua Y, Jiang T, Wu B: Aligning DNA Sequences to Minimize the Change in Protein. J Combinatorial Optimization 1999, 3: 227–245. 10.1023/A:1009889710983

    Article  Google Scholar 

  26. Thompson JD, Higgins DG, Gibson TJ: CLUSTAL W: improving the sensitivity of progressive multiple sequence alignment through sequence weighting, position-specific gap penalties and weight matrix choice. Nucl Acids Res 1994, 22(22):4673–4680.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  27. Thompson JD, Plewniak F, Poch O: BAliBASE: a benchmark alignment database for the evaluation of multiple alignment programs. Bioinformatics 1999, 15: 87–88. 10.1093/bioinformatics/15.1.87

    Article  CAS  PubMed  Google Scholar 

  28. McGinnis W, Krumlauf R: Homeobox genes and axial patterning. Cell 1992, 68: 283–302. 10.1016/0092-8674(92)90471-N

    Article  CAS  PubMed  Google Scholar 

  29. Garcia-Fernández J, Holland PW: Archetypal organization of the amphioxus Hox gene cluster. Nature 1994, 370: 563–566. 10.1038/370563a0

    Article  PubMed  Google Scholar 

  30. Kappen C, Schughart K, Ruddle FH: Two steps in the evolution of Antennapedia-class vertebrate homeobox genes. Proc Natl Acad Sci USA 1989, 86: 5459–5463.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  31. Ferrier DE, Holland PW: Ancient origin of the Hox gene cluster. Nat Rev Genet 2001, 2: 33–38. 10.1038/35047605

    Article  CAS  PubMed  Google Scholar 

  32. van Duin J: Single-stranded RNA bacteriophages. In The Bacteriophages. Edited by: Calendar R. New York: Plenum Press; 1988:117–167.

    Chapter  Google Scholar 

  33. van Regenmortel MHV, Fauquet CM, Bishop DHL, Carstens EB, Estes MK, Lemon SM, Maniloff MayoMAJ, McGeoch DJ, R PC, Wickner RB, (Eds): Virus Taxonomy: The Seventh Report of the International Committee on Taxonomy of Viruses. London, UK: Academic Press; 2000.

    Google Scholar 

  34. N Paradigon PV, Girard M, Bouloy M: Panhandles and Hairpin Structures at the Termini of Germiston Virus RNAs (Bunyavirus). Virology 1982, 122: 191–197. 10.1016/0042-6822(82)90388-9

    Article  Google Scholar 

  35. Hahn CS, Hahn YS, Rice CM, Lee E, Dalgarno L, Strauss EG, Strauss JH: Conserved elements in the 3'untranslated region of flavivirus RNAs and potential cyclization sequences. J Mol Biol 1987, 198: 33–41. 10.1016/0022-2836(87)90455-4

    Article  CAS  PubMed  Google Scholar 

  36. Biebricher CK, Luce R: In vitro Recombination and terminal elongation of RNA by Qbeta replicase. EMBO J 1992, 11: 5129–5135.

    PubMed Central  CAS  PubMed  Google Scholar 

  37. Biebricher CK, Luce R: Sequence analysis of RNA species synthesized by Qbeta replicase without template. Biochemistry 1993, 32: 4848–4854. 10.1021/bi00069a021

    Article  CAS  PubMed  Google Scholar 

  38. Li AW, Murphy PR: Expression of alternatively spliced FGF-2 antisense RNA transcripts in the central nervous system: regulation of FGF-2 mRNA translation. Mol Cell Endocrinol 2000, 170: 233–242. 10.1016/S0303-7207(00)00440-8

    Article  CAS  PubMed  Google Scholar 

  39. Shendure J, Church GM: Computational discovery of sense-antisense transcription in the human and mouse genomes. Genome Biol 2002, 3: 0044.1–14. 10.1186/gb-2002-3-9-research0044

    Article  Google Scholar 

  40. Yelin R, Dahary D, Sorek R, Levanon EY, Goldstein O, Shoshan A, Diber A, Biton S, Tamir Y, Khosravi R, Nemzer S, Pinner E, Walach S, Bernstein J, Savitsky K, Rotman G: Widespread occurrence of antisense transcription in the human genome. Nat Biotechnol 2003, 21: 379–386. 10.1038/nbt808

    Article  CAS  PubMed  Google Scholar 

  41. (Sanger Institute): The Danio rerio Sequencing Project.2002. [http://www.sanger.ac.uk/Projects/D_rerio/]

    Google Scholar 

Download references

Acknowledgements

This work is supported by the Austrian Fonds zur Förderung der Wissenschaftlichen Forschung, Project Nos. P-13545-MAT and P-15893, and the German DFG Bioinformatics Initiative.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Ivo L Hofacker.

Additional information

Authors' contributions

RS implemented the algorithm, RS and CF performed quantitative comparisons, ILH and PFS conceived this study. All four authors closely collaborated in writing the manuscript.

Authors’ original submitted files for images

Rights and permissions

Open Access This article is published under license to BioMed Central Ltd. This is an Open Access article is distributed under the terms of the Creative Commons Attribution License ( https://creativecommons.org/licenses/by/2.0 ), which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly cited.

Reprints and permissions

About this article

Cite this article

Stocsits, R.R., Hofacker, I.L., Fried, C. et al. Multiple sequence alignments of partially coding nucleic acid sequences. BMC Bioinformatics 6, 160 (2005). https://doi.org/10.1186/1471-2105-6-160

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-6-160

Keywords