Skip to main content

CSA: An efficient algorithm to improve circular DNA multiple alignment

Abstract

Background

The comparison of homologous sequences from different species is an essential approach to reconstruct the evolutionary history of species and of the genes they harbour in their genomes. Several complete mitochondrial and nuclear genomes are now available, increasing the importance of using multiple sequence alignment algorithms in comparative genomics. MtDNA has long been used in phylogenetic analysis and errors in the alignments can lead to errors in the interpretation of evolutionary information. Although a large number of multiple sequence alignment algorithms have been proposed to date, they all deal with linear DNA and cannot handle directly circular DNA. Researchers interested in aligning circular DNA sequences must first rotate them to the "right" place using an essentially manual process, before they can use multiple sequence alignment tools.

Results

In this paper we propose an efficient algorithm that identifies the most interesting region to cut circular genomes in order to improve phylogenetic analysis when using standard multiple sequence alignment algorithms. This algorithm identifies the largest chain of non-repeated longest subsequences common to a set of circular mitochondrial DNA sequences. All the sequences are then rotated and made linear for multiple alignment purposes.

To evaluate the effectiveness of this new tool, three different sets of mitochondrial DNA sequences were considered. Other tests considering randomly rotated sequences were also performed. The software package Arlequin was used to evaluate the standard genetic measures of the alignments obtained with and without the use of the CSA algorithm with two well known multiple alignment algorithms, the CLUSTALW and the MAVID tools, and also the visualization tool SinicView.

Conclusion

The results show that a circularization and rotation pre-processing step significantly improves the efficiency of public available multiple sequence alignment algorithms when used in the alignment of circular DNA sequences. The resulting alignments lead to more realistic phylogenetic comparisons between species.

Background

Genomic sequence alignment tools have been playing an important role in comparative genomics and phylogenetic reconstruction. However, traditional sequence alignment algorithms based on dynamic programming are very inefficient when long genome sequences needed to be aligned. To tackle this problem several heuristic based methods have been proposed. The most popular progressive multiple sequence alignment (MSA) method is ClustalW [1, 2], to which access is provided by a number of web portals. Other methods like T-COFFEE [3], DIALIGN [4], MUSCLE [5], MLAGAN [6], MAVID [7], and MAUVE [8] are also widely used. Despite the fact that these tools are heuristic based and sometimes lead to poor biologically plausible alignments, they were also developed to deal only with linear genomic sequences. When applied to circular genomes, the results become extremely sensitive to the exact place where the genomic sequence begins.

This limitation is very important since circular DNA sequence alignments are central to a number of biological problems. Every cell has some kind of genome that is circular. Prokaryotic genomes are circular and many bacteria possess extra circular DNA molecules, the plasmids. Eukaryotic cells also contain organelles which possess circular DNA molecules: the mitochondrial DNA (mtDNA) inside mitochondria in all cells; and chloroplast DNA inside chloroplasts in plant cells.

MtDNA has long been used for phylogenetic analyses. In fact, the absence of recombination in this genome enables an easy and direct inference of the phylogenetic evolution and its fast mutation rate leads to a high discriminative power. Until recently, phylogenetic reconstructions were based on certain regions of the mtDNA molecule, mainly the protein-coding gene cytochrome b when comparing different species [9] and hypervariable regions on D-loop when comparing human populations (e.g. [10]). But the high recent throughput of automatic sequencing techniques is offering the possibility to study complete mtDNA genomes in humans (see revision in [11]) and in other species (ex: Mus musculus, [12]). By the end of April 2009 there were around 5,650 human mtDNA complete genomes in GenBank [13] and 1,750 complete mtDNA which should be used as reference sequence for the diverse species in RefSeq [14]. The blind application of standard phylogenetic analyses in these massive datasets without concern to the circularity of these molecules will lead to the overestimation of genetic distances between species.

Sequencing, the technique employed to determine bases constituting the DNA molecule is performed in fragments, generally overlapping in the ends so that an order can be inferred for constructing the map of the molecule. But the place where a circular genome begins is totally irrelevant and arbitrary. For instance, the first team sequencing the human mtDNA [15] decided to begin numbering more or less in the middle of a region designated control region or D-loop; however, the chimpanzee mtDNA sequence has position number one placed in tRNA phenylalanine, which will be position 577 in human mtDNA. Due to this arbitrarily first position definition, a false high genetic distance would be obtained from the alignment between human and its closest species, by using available sequence alignment tools. A total of 576 gaps would be added to the beginning of the chimpanzee sequence and around 563 gaps would be added to the end of the human sequence.

Algorithms for the problem of cyclic sequence alignment have already been proposed in the computer science research field. However, like optimal MSA methods, most existing optimal methods that handle this kind of sequences are very time consuming and seldom used. A simple extension of a general MSA dynamic programming algorithm can be used to compute the edit distance between two cyclic sequences, but requires a quadratic time computation complexity [16, 17]. Several other algorithms that explore suboptimal solutions have also been proposed [18, 19], reducing the practical execution time. However, these works present experiments that consider only the cyclic use of the Levenshtein metric [17].

Based on algorithms closely related to the ideas described above, two software packages have been recently proposed to align circular DNA genome sequences: the Circal package [20] and the Cyclope package [21]. The algorithm implemented in the Circal package uses a complex gap cost function and can only deal with short sequences, less than a thousand characters, due to its time complexity. The Cyclope package includes an implementation of an exact and a heuristic method with time complexities that are prohibitive if it is used to align several sequences with several thousands of base pairs. For this particular package, the authors claim that it should be used only to obtain a rough first solution of the multiple alignment and that the sequences should be realigned with a standard linear alignment package like ClustalW.

In this paper, we present the CSA tool http://kdbio.inesc-id.pt/software/csa/, a very efficient algorithm that finds the best rotation for a set of circular genome sequences that are to be aligned. Firstly, the genomic sequences are circularized. In a second stage the best rotation is calculated based on the largest chain of non-repeated blocks that belongs to all the sequences. These maximum common blocks are obtained with the help of a generalized cyclic suffix tree, which is a new concept introduced in this work. At the end of the process, the users can visualize all the identified common blocks, obtaining a precise idea on how these regions are conserved along the genomic sequences. The new rotated sequences are made available for download and can be submitted to public available MSA tools. At the developed website, several commonly used MSA and visualizations tools are proposed.

Implementation

The purpose of the proposed algorithm is to find the best rotation among all the possible rotations of each circular genome sequence, in order to improve subsequent multiple sequence genome alignment. Unlike previous algorithms that pursued the same goal, the proposed algorithm is, to the best of our knowledge, the first one that is able to do this task in linear time. This was accomplished by employing the highly efficient suffix tree data structure [22].

Suffix Trees

In general terms, a suffix tree for a given string is an advanced data structure shaped like an upside down tree that stores all the suffixes of the string and that can be used to efficiently solve many complex string problems. An in-depth explanation of this data structure is outside the scope of this article, but a detailed overview of suffix trees including construction methods and applications can be found in a number of sources (e.g. [23]). In this work we follow many of the definitions presented in that reference. In particular, strings will be denoted as sequences, which correspond to DNA sequences.

Cyclic Suffix Trees

To be able to represent all the rotations of a cyclic sequence S of length n, we introduce the concept of cyclic suffix tree. A cyclic suffix tree is a suffix-tree-like structure which represents all the rotations of the sequence (instead of all its suffixes, as is normal for suffix trees). The construction algorithm follows Ukkonen's suffix tree construction method [24] but with some subtle modifications, namely in the implementation of suffix links and open leaves (see [23] for a detailed description of these concepts). In our case, suffix links at leaves are treated as connecting successive rotations instead of successive suffixes. The role of the open leaves is also changed so that the resulting path label from the root to the end of the leaf has always the same length, n. In this way, if a new leaf for the character at position i is created at depth d, the right pointer of that leaf will be i + (n - d - 1). The result is that all the leaves are at the same depth in the tree, which corresponds to the size of the original sequence. When accessing characters from the edge labels, if a pointer indicates a position k that reaches beyond the end of the original sequence (i.e., k > n), then we must subtract from that position the size of the sequence (i.e., k = k - n).

The construction algorithm

Based on the previous definitions, the construction algorithm proceeds as originally proposed in [24], producing all the n rotations of the sequence in linear time with no additional effort. In some cases, as a final step, we still need to perform an additional pass through S. Take for example the sequence AAABA. The construction algorithm, as proposed in [24], would stop at the internal node with path label A, and would not report the rotation AAAAB. So, we need to match again all the characters from the beginning of the sequence until the (n-1)-th position to create the last missing rotation. This can easily be done by constructing the cyclic suffix tree of the sequence concatenated with itself (i.e., SS). Using this technique, the algorithm runs in time proportional to 2 n, and we obtain a linear time complexity.

The example presented in Figure 1 shows all the steps for the construction of the cyclic suffix tree for the sequence ACACG. The current node/position is marked in red and the newly created nodes/edges are coloured in blue. For the sake of simplicity, only the suffix links connecting leaves are shown. Figure 2 presents the same construction but gives a deeper look at the node pointers, showing some of the implementation details of the algorithm.

Figure 1
figure 1

Cyclic suffix tree step by step construction for the sequence ACACG.

Figure 2
figure 2

Cyclic suffix tree step by step construction for the sequence ACACG, showing internal node pointers instead of node labels.

Generalized Cyclic Suffix Trees

We have so far presented the algorithm to build a cyclic suffix tree for a single sequence, in linear time. However what we want is to efficiently obtain the best rotation for an entire set of cyclic sequences. For this we build a tree called a generalized cyclic suffix tree. A generalized cyclic suffix tree is a tree that stores all the rotations of a set of sequences. In this representation, a node can belong to several different sequences at the same time. Each node in the tree is marked, using a bit vector, with the identifiers of all the sequences that contain that node. A linear time algorithm for the construction of a generalized suffix tree for a set of sequences can be found in [23]. The implementation used in this work is a generalization to deal with cyclic sequences.

Figure 3 shows a simple example of a generalized cyclic suffix tree for the following set of three sequences: ACACG, CGTGA and TGAC. As one can see, every rotation of every sequence is present in the represented tree. To allow a more clear view, the nodes/edges that belong to all the sequences are marked in red, the ones that belong to only two of the sequences in purple, and the ones corresponding to a single sequence in blue.

Figure 3
figure 3

Example of a generalized cyclic suffix tree for sequences ACACG, CGTGA and TGAC.

Finding the best rotation

The general idea to obtain the best rotation for each sequence based on all the others is to find the largest chain of longest common subsequences that belongs to all the sequences and then use the position of that highly conserved block chain in each sequence to establish the cutting point. We start by retrieving all the nodes that belong simultaneously to all the sequences. The tree nodes carry a bit vector with this information, so we only need to perform a depth-first search on the tree starting at the root and count the number of sequences in each node. When the sequence count, in a node, falls bellow the total number of sequences, we don't need to search the children of that node because their count will only be lower or equal to the count of the father. Using the suffix links of those nodes, it is now possible to discard all the nodes whose path label corresponds to a suffix of the path label of another node. The result is the set of all maximal blocks common to all the sequences.

To improve the results three other steps were included. One step removes the nodes that appear more than once in at least one of the sequences. This is important because a repeated subsequence that appears in multiple positions inside a sequence could lead to wrong alignments. At this stage, we are left with all the unique maximal common blocks to all the sequences. Next, the second step groups together the blocks that appear consecutively and in the same order in all the sequences. The third and last step consists of taking the largest chain of these blocks and set its start position on each circular sequence as the start position of the new linear sequence.

For the identification of close related regions the minimum block size is not limited. However, since all the suffixes of common subsequences are automatically excluded when the suffix tree is analysed, it is usual that the longest common subsequences have size not inferior to 5 or 6 nucleotides. The only restriction that was included limits the maximum distance between two consecutive blocks in a chain to 10 nucleotides. Since the algorithm purpose is to identify the best rotation for all the sequences based on a similar region, we tried, with this distance restriction, to avoid that other more complex biological events, like gene inversions, deletions or insertions could play a role at this stage. These events will be detected at the final multiple alignment. The length of the chain, or common region, is the sum of the lengths of each one of the intervening blocks.

Consider the example represented in Figure 3 where sequences ACACG, CGTGA and TGAC correspond to a linearization of three DNA cyclic sequences. There are three common blocks to all these sequences: GAC, AC and C. Since AC and C are both suffixes of GAC, they are removed. The remaining block does not occur more than once in the same sequence, so repetitions are not observed. At the end, the single sequence GAC is reported as the largest block chain, leading to the following rotated and linear set of sequences: GACAC, GACGT and GACT.

Figure 4 shows a more elaborated example of the block chains obtained from a set of longest common subsequences present in 3 sequences. All the blocks are shown almost aligned for a better understanding of the concept of block chains, but the sequences can have any random rotation. Block E is automatically discarded because it appears twice in the first sequence. Blocks A and B belong to the same chain since they appear in the same order in every sequence. Blocks F, G and H also form another chain. Blocks C and D are excluded from those chains because they do not have the same order in all the sequences. However, each one of these two blocks forms itself an elementary chain containing a single block. The longest chain corresponds to blocks F, G and H and therefore all the final rotated sequences will start with this chain of blocks.

Figure 4
figure 4

Example of 4 block chains (A+B, C, D and F+G+H) derived from a set of longest common subsequences, from 3 sequences.

Multiple Sequence Alignment

After finding the largest chain of unique common blocks belonging to all the sequences that were circularized, they are again made linear by cutting these sequences at the starting position of the first block from that common chain. The multiple alignment itself can then be easily performed by any linear multiple alignment algorithm. At the CSA tool web site several multiple alignment methods and visualization tools are suggested for further sequence analysis.

The CSA tool interfaces

The CSA tool is available through a friendly and easy to use web interface. Figure 5 presents the tool's main page and the output results after pre-processing a set of mtDNA Primate sequences.

Figure 5
figure 5

CSA tool, input and output interfaces.

The genomic sequences can be submitted in the Multi-FASTA format by uploading a file or by pasting the sequences in a text window. The size of the chain of blocks displayed in the output can be specified by the user. By default chains with size higher than fifteen bases are selected and displayed. The minimum size allowed for a chain with only one block is eight since finding conserved blocks of this size in genomic sequences with several thousand base pairs is still statistically significant.

The output page is divided in three main areas where data are displayed. At the beginning the user can find tool execution statistics, including the size and description of each input sequence, the algorithm running time, information about the 20 first longest blocks, and eventually any processing errors. After this general information, the alignment map of the blocks in all the sequences after their optimal rotation is presented, together with a table with all the blocks lengths and positions, following the same colour schema as the alignment map. The colour of the blocks in the results page is not related to their length. The blocks are coloured in a rainbow-like fashion by their positions relative to the first (top-most) sequence. This position-based colouring is more interesting than a length based colouring because it allows, in a much more easy way, the detection of block transpositions among sequences. Before clicking on the alignment image, the table on the right shows the blocks sorted by their length. By left-clicking over a specific section of one of the sequences in the alignment map, the positions table automatically sorts its rows to reflect the correct order of the blocks inside that sequence and it automatically scrolls itself to show the information of the blocks from the selected region/sequence. All the previous described data are available for download at the end of the page.

At the CSA tool web page the user can also find a user manual, the algorithm source code and some example sequences.

Results and discussion

In order to evaluate the efficiency of the proposed tool and the adequacy to perform the circularization and rotation prior to the alignment, we conducted tests in three sets of mtDNA sequences. The first set includes sequences of 16 Primates, the second set includes sequences of 12 Mammals and the last set is a set of distantly related sequences including 19 mtDNA sequences (the 16 Primates, the Drosophila melanogaster, the Gallus gallus and the Crocodylus niloticus) (Table 1). These datasets are available, as supplementary material, at the tool's web site. Multiple sequence alignments with and without CSA pre-processing were performed using two well known MSA tools: ClustalW [1] and MAVID [7]. Alignment quality was compared in two ways: (1) by evaluating genetic standard measures in the software Arlequin [25]; (2) by using the tool SinicView [26], a visualization environment for comparison of multiple nucleotide sequence alignment tools.

Table 1 Species, GenBank accession numbers and mtDNA genome size (bp) used for the tests.

In order to get a sense of the statistical significance of the CSA improvement relative to the random situation, tests with 50 sets of control sequences with random cuts (using the third set described) were also conducted. For these sets, the alignment scores and the consensus length obtained when using the ClustalW tool with and without the CSA algorithm were compared.

We also tried to compare the results obtained with the CSA tool followed by a linear DNA multiple sequence aligner, with the results obtained by the algorithms available at the Cyclope package [21]. However, this comparison could not be performed because this software package is not able to deal with sequences with a few thousand bases pairs as the mtDNA sequences. The recommendation obtained by the tool's authors was to perform a manual rotation based on the genes positions and then use a linear DNA multiple sequence alignment algorithm.

The circularization and rotation in CSA

After pre-processing the set of Primate sequences with CSA, 58 homologous chains of blocks with size 8 or bigger were observed, with the biggest one consisting in a block of 16 bp followed by a gap of one base, a second block of 29 bp followed by a gap of 9 bp and a third block of 15 bp, which matches perfectly the tRNA-Met (Figure 6). Those homologous chains of blocks are shortened when enlarging the analysis to the Mammal set. A total of 51 homologous chains of blocks with size 8 or bigger were still observed, being the biggest one constituted by a block of 25 bp followed by a gap of one base and another block of 21 bp, located at the gene 16 s rRNA (Figure 7). The third set, including the 16 Primates and the outgroup species, reduced the homologous chains of blocks to four unique blocks with size 8 or bigger, the biggest one being a unique block of 10 bp located in the tRNA-Trp (Figure 8). As expected, the bigger homologous chains of blocks are located in regions where the secondary structure must be maintained as it is essential for functionality. Protein-coding genes do not have such high mutation-constraint as the rRNA and tRNA genes due to the property of redundancy of the genetic code: most aminoacids are coded by several codons, the third-codon position being quite irrelevant.

Figure 6
figure 6

The 17 blocks with size 15 bp or bigger in Primate mtDNA sequences, after pre-processing with CSA.

Figure 7
figure 7

The 15 blocks with size 15 bp or bigger in Mammal mtDNA sequences, after pre-processing with CSA.

Figure 8
figure 8

The 5 blocks with size 8 bp or bigger in the third set of mtDNA sequences, after pre-processing with CSA.

Note, however, that when more distantly related sequences are considered, the common blocks correspond to single blocks of small sizes (more or less 8 bp) that are still statistical significant if mitochondrial DNA is being considered but not true for DNA sequences of bacterial genomes with million base pairs. In this way, additional care must be taken in the analysis of the sizes of the identified common blocks, when using this algorithmic approach with larger circular genomes from distantly related organisms. In these cases we are dealing with the multiple sequence alignment problem of distantly related genomes that is still an open problem.

Comparing alignment results between alignment tools and with or without CSA

Some biological properties can help in the evaluation of the alignment results: (1) unique deletion of multiple bases instead of multiple deletions interspersing individual nucleotides; (2) higher ratio transition/transversion, as substitutions between the same type of bases are commonest than between different types; (2) the triplet-constraint in protein-coding genes making it more probable to have deletion in multiples of three than other.

As can be observed in Table 2, the genetic diversity standard measures showed lower levels of diversity (mainly the mean number of pairwise differences between sequences) when circularizing and rotating the mtDNA molecules in CSA prior to the alignment, in both alignment tools tested. This fact is stronger in the set of Primates with outgroups than in Mammals and still than in Primates, as phylogenetic distance between compared species decreases. The main difference between circularization and rotation or not of the mtDNA molecules with CSA is in the number of insertion/deletions (indels), which reduces about 1,000 events when applying this pre-processing step.

Table 2 Genetic diversity standard measures for Primates, Mammals and Primates with more distantly related sequences, aligned with several alignment tools without and after circularization an rotation in CSA.

When comparing different alignment tools, ClustalW adds considerable lower amounts of indels than MAVID. A probable cause for this is that MAVID was especially designed for the alignment of large genomes, while ClustalW is much more conservative and takes longer to achieve results.

We tried to investigate where indels were being introduced. This can be visually checked in the tool SinicView, as displayed in Figures 9 and 10. Prior to the CSA application (Figure 9), huge gaps are included in the original tips, which coincide with the most heterogeneous mtDNA region, the control region. After the circularization and rotation (Figure 10), gaps are mainly included in the control region, and a big difference can be found between the alignment tools. Outside the control region, the biggest gap is inserted in a small fragment which is non-coding, being placed between gene COX2 and tRNA-Lys. All the alignment tools allow for non-multiples of three in protein-coding genes to be included, and, for instance, when counting deletions inserted in human protein-coding genes for the Primate set, the ratio of multiple/non-multiple of three deletions is higher in ClustalW than in MAVID (1.2 and 0.5 respectively). MAVID is the less restrictive in having multiple deletions interspersing individual nucleotides.

Figure 9
figure 9

SinicView comparison between ClustalW and MAVID alignments prior to CSA pre-processing, in four Primates (NC_001643, NC_001644, NC_011120and NC_001807).

Figure 10
figure 10

SinicView comparison between ClustalW and MAVID alignments after circularization and rotation in CSA.

Comparing alignment results in the 50 sets of control sequences with random cuts

When the third set was used so that each sequence was cut each time in different random positions, resulting in 50 test sets of 19 sequences each, the efficiency improvement of CSA was also evident. It was shown that when using the CSA tool on these sets, they all resulted in the same alignment and its score greatly outperformed the scores of each not CSA-processed test set. Figure 11 presents in blue the consensus length, in bp, versus the alignment score for the 50 test sets when using the ClustalW tool for the multiple sequence alignment. When using the CSA tool as a pre-processing step the alignment score is always the same and the length of the consensus sequence is much smaller (for more details see the supplementary material in the webpage).

Figure 11
figure 11

Plotted results of the 50 test sets of randomly rotated mtDNA sequences (ClustalW in blue and CSA+ClustalW in red).

Conclusion

We have demonstrated that the essential step of circularizing and rotating the mtDNA molecules prior to its alignment can significantly improve the efficiency of current multiple sequence alignment tools, developed for the alignment of linear DNA molecules. This pre-processing step leads to more accurate phylogenetic comparisons between species.

To the best of our knowledge the CSA tool is the only web based tool that obtains the best rotation of a set of circular DNA sequences in a very efficient way. The new rotated sequences are made available for further processing and a picture of all conserved block for all the sequences can be found at the result page and can be viewed as a first draft of a future multiple sequence alignment.

Future developments of alignment tools should include more real biological mutation constraints, enabling the use of different assumptions in the different parts of the molecules. It is clear that as sequencing strategies advance further, more information will be obtained for complete genomes, which have necessarily a diverse composition. This is clearly the case of the circular molecules of mtDNA and bacterial genomes being rapidly characterized. For instance, non-coding regions could have a less restrictive rate of gap opening; protein-coding genes should incorporate the rule of multiple of three gaps and be less restrictive for substitution at the third-codon position; third-dimension structure can give additional information for the rRNA and tRNA genes alignment.

Availability and requirements

Project name: CSA: Cyclic DNA Sequence Aligner

Project home page: http://kdbio.inesc-id.pt/software/csa/

Operating system(s): Platform independent

Programming language: C

Other requirements: none

License: None

Any restrictions to use by non-academics: Free downloads and usage for academics only

References

  1. Chenna R, Sugawara H, Koike T, Lopez R, Gibson TJ, Higgins DG, Thompson JD: Multiple sequence alignment with the Clustal series of programs. Nucleic Acids Res 2003, 31: 3497–3500.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

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

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  3. Notredame C, Higgins DG, Heringa J: T-Coffee: A novel method for fast and accurate multiple sequence alignment. J Mol Biol 2000, 302(1):205–17.

    Article  CAS  PubMed  Google Scholar 

  4. Brudno M, Chapman M, Göttgens B, Batzoglou S, Morgenstern B: Fast and sensitive multiple alignment of large genomic sequences. BMC Bioinformatics 2003, 4: 66.

    Article  PubMed Central  PubMed  Google Scholar 

  5. Edgar RC: MUSCLE: multiple sequence alignment with high accuracy and high throughput. Nucleic Acids Res 2004, 32(5):1792–1797.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  6. Brudno M, Do CB, Cooper GM, Kim MF, Davydov E, Green ED, Sidow A, Batzoglou S: LAGAN and Multi-LAGAN: efficient tools for large-scale multiple alignment of genomic DNA. Genome Res 2003, 13(4):721–731.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  7. Bray N, Pachter L: MAVID: constrained ancestral alignment of multiple sequences. Genome Res 2004, 14: 693–699.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  8. Darling AC, Mau B, Blattner FR, Perna NT: Mauve: multiple alignment of conserved genomic sequence with rearrangements. Genome Res 2004, 14: 1394–1403.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  9. Castresana J: Cytochrome b phylogeny and the taxonomy of great apes and mammals. Mol Biol Evol 2001, 18: 465–471.

    Article  CAS  PubMed  Google Scholar 

  10. Richards M, Macaulay V, Hickey E, Vega E, Sykes B, Guida V, Rengo C, Sellitto D, Cruciani F, Kivisild T, Villems R, Thomas M, Rychkov S, Rychkov O, Rychkov Y, Gölge M, Dimitrov D, Hill E, Bradley D, Romano V, Calì F, Vona G, Demaine A, Papiha S, Triantaphyllidis C, Stefanescu G, Hatina J, Belledi M, Di Rienzo A, Novelletto A, Oppenheim A, Nørby S, Al-Zaheri N, Santachiara-Benerecetti S, Scozari R, Torroni A, Bandelt HJ: Tracing European founder lineages in the Near Eastern mtDNA pool. Am J Hum Genet 2000, 67: 1251–1276.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  11. Pereira L, Freitas F, Fernandes V, Pereira JB, Costa MD, Costa S, Máximo V, Macaulay V, Rocha R, Samuels DC: The diversity present in 5,140 human mitochondrial genomes. Am J Hum Genet 2009, 84: 628–640.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  12. Goios A, Pereira L, Bogue M, Macaulay V, Amorim A: mtDNA phylogeny and evolution of laboratory mouse strains. Genome Res 2007, 17: 293–298.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  13. Benson DA, Karsch-Mizrachi I, Lipman DJ, Ostell J, Wheeler DL: GenBank. Nucleic Acids Res 2008, (36 Database):D25–30.

    Google Scholar 

  14. Pruitt KD, Tatusova T, Maglott DR: NCBI reference sequences (RefSeq): a curated non-redundant sequence database of genomes, transcripts and proteins. Nucleic Acids Res 2007, (35 Database):D61–65.

    Google Scholar 

  15. Anderson S, Bankier AT, Barrell BG, de Bruijn MH, Coulson AR, Drouin J, Eperon IC, Nierlich DP, Roe BA, Sanger F, Schreier PH, Smith AJ, Staden R, Young IG: Sequence and organization of the human mitochondrial genome. Nature 1981, 290: 457–465.

    Article  CAS  PubMed  Google Scholar 

  16. Maes M: On a cyclic string-to-string correction problem. Inform Process Lett 1990, 35(2):73–78.

    Article  Google Scholar 

  17. Mollineda RA, Vidal E, Casacuberta F: Cyclic sequence alignments: approximate versus optimal techniques. Int J Patt Recogn and Artificial Intelligence 2002, 16(3):291–299.

    Article  Google Scholar 

  18. Bunke H, Bühler U: Applications of approximate string matching to 2D shape recognition. Patt Recogn 1993, 26(12):1797–1812.

    Article  Google Scholar 

  19. Mollineda RA, Vidal E, Casacuberta F: Efficient techniques for a very accurate measurement of dissimilarities between cyclic patterns. In Advances in Pattern Recognition. Volume 1876. Lecture Notes in Computer Science. Springer; 2000:337–346.

    Chapter  Google Scholar 

  20. Fritzsch G, Schlegel M, Stadler PF: Alignments of Mitochondrial Genome Arrangements: Applications to Metazoan Phylogeny. J Theor Biol 2006, 240: 511–520.

    Article  CAS  PubMed  Google Scholar 

  21. Mosig A, Hofacker IL, Stadler PF: Comparative Analysis of Cyclic Sequences: Viroids and other Small Circular RNAs. Proceedings of the German Conference on Bioinformatics: 20–22 September 2006; Tübingen P-83: 93–102.

  22. Weiner P: Linear Pattern Matching Algorithm. Proceedings of the 14th Annual IEEE Symposium on Switching and Automata Theor: 15–17 October 1973; Iowa 1973, 1–11.

    Chapter  Google Scholar 

  23. Gusfield D: Algorithms on Strings, Trees, and Sequences: Computer Science and Computational Biology. New York: Cambridge University Press; 1997.

    Chapter  Google Scholar 

  24. Ukkonen E: On-line Construction of Suffix Trees. Algorithmica 1995, 14(3):249–260.

    Article  Google Scholar 

  25. Excoffier L, Laval G, Schneider S: Arlequin ver. 3.0: An integrated software package for population genetics data analysis. Evolutionary Bioinformatics Online 2005, 1: 47–50.

    PubMed Central  CAS  Google Scholar 

  26. Shih AC, Lee DT, Lin L, Peng CL, Chen SH, Wu YW, Wong CY, Chou MY, Shiao TC, Hsieh MF: SinicView: a visualization environment for comparisons of multiple nucleotide sequence alignment tools. BMC Bioinformatics 2006, 7: 103.

    Article  PubMed Central  PubMed  Google Scholar 

Download references

Acknowledgements

We thank INESC-ID for providing computing resources. This project was supported by the ARN project – Algorithms for the identification of genetic Regulatory Networks (PTDC/EIA/67722/2006) from the Portuguese Science Foundation (FCT). FCT partially supports IPATIMUP through Programa Operacional Ciência, Tecnologia e Inovação (POCTI), Quadro Comunitário de Apoio III.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Ana T Freitas.

Additional information

Authors' contributions

LP and ATF specified the problem and supervised the system implementation. FF implemented the algorithm and coded the application and the web interface. All authors contributed for the writing, read and approved the final 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

Fernandes, F., Pereira, L. & Freitas, A.T. CSA: An efficient algorithm to improve circular DNA multiple alignment. BMC Bioinformatics 10, 230 (2009). https://doi.org/10.1186/1471-2105-10-230

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-10-230

Keywords