Background

Generation of meaningful multiple sequence alignments (MSAs) of biological sequences is a well-studied NP-complete problem, which has significant implications for a wide spectrum of applications [1, 2]. In general, the challenge is aligning N sequences of varying lengths by inserting gaps in the sequences so that in the end all sequences have the same length. Of particular interest to computational biology are DNA/RNA sequences and amino acid sequences, which are comprised of nucleotide and amino acid residues, respectively.

MSAs are generally used in studying phylogeny of organisms, structure prediction, and identifying segments of interest among many other applications in computational biology [3].

Given a scoring scheme to evaluate the fitness of an MSA, calculating the best MSA is an NP-complete problem [1]. Variances in scoring schemes, need for expert-hand analysis in most applications, and many-to-one mapping governing elements-to-functionality (codon mapping and function) make MSA a more challenging problem when considered from a biological context as well [4].

Generally, three approaches are used to automate the generation of MSAs. The first offers a brute-force method of multidimensional dynamic programming [5], which may find a good alignment but is generally computationally expensive and, therefore, unusable beyond a small N. Another method uses a probabilistic approach where Hidden Markov Models (HMMs) are approximated from unaligned sequences. The final method, progressive alignment, is possibly the most commonly used approach when obtaining MSAs [6].

A progressive alignment algorithm begins with an optimal alignment of two of the N sequences. Then, each of the remaining N sequences are aligned to the current MSA, either via a consensus sequence or one of the sequences already in the MSA. Variations on the progressive alignment method include PRALINE [7], ProbCons [8], MAFFT [9, 10], MUSCLE [11, 12], T-Coffee [13], Kalign [14], PSalign [15], and the most commonly used CLUSTALW [16]. In most cases, the algorithms attempt to generate accurate alignments while minimizing computational time or space. Advances in DNA sequencing technology with next generation sequencers such as ABI's SOLID and Roche's GC FLX provide vast amount of data in need of multiple alignment. In case of large sequencing projects, high number of fragments that lead to longer contigs to be combined are generated with much less time and money [17]. In addition, as more organisms' genomes are sequenced, approaches that require MSA of the same gene in different organisms now find a more populated data set. In both cases computational time in MSA is becoming an important issue that needs to be addressed.

This work presents GramAlign, a progressive alignment method with improvements in computational time. In particular, the natural grammar inherent in biological sequences is estimated to determine the order in which sequences are progressively merged into the ongoing MSA. The following sections describe the algorithm and present initial results as compared with other alignment algorithms.

Methods

A general overview of the GramAlign algorithm is depicted in Figure 1. The set of sequences to be aligned, S, are regarded as input to the algorithm with S = {s1,...,s N }, where s i is the ithsequence and i ∈ {1,...,N}.

Figure 1
figure 1

Algorithm overview. The algorithm operates on a set of sequences S originally read in FASTA format. After a grammar-based distance matrix D is estimated, a minimal spanning tree T is constructed. The tree is used as a map for determining the order in which the sequence set is progressively aligned in A. Gaps in the alignment are grouped together using a sliding window resulting in A Adj . Several outputs are available, including the distance matrix and various sequence alignment formats.

Distance Estimation

The first step in the procedure involves the formation of an estimate of the distance between each sequence s m and all other sequences s n nm. The distance used in GramAlign is based on the natural grammar inherent to all information-containing sequences. Unfortunately, the complete grammar for biological sequences is unknown, and so cannot be used when comparing sequences. However, we do know that biological sequences have structures which correspond to functions. This in turn implies that biological sequences which correspond to proteins with similar functions will have similarities in their structure. Therefore, we use a grammar based on Lempel-Ziv (LZ) compression [18, 19] used in [20] for phylogeny reconstruction. This measure uses the fact that sequences with similar biological properties share commonalities in their sequence structure. It is also known that biological sequences contain repeats, especially in the regulatory regions [21]. When comparing sequences with functional similarity, non-uniform distribution of repeats among the sequences poses a problem to assess sequence similarity. As shown below, the proposed distance naturally handles such cases, which are difficult to be accounted for by alignment or sequence edit based measures.

An overview of the grammar-based distance calculation is shown in Figure 2 where a dictionary of grammar rules for each sequence is calculated. Initially, the dictionary G m 1 MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaGaem4raC0aa0baaSqaaiabd2gaTbqaaiabigdaXaaaaaa@2F6C@ = ∅ is empty, a fragment f1 = s m (1) is set to the first residue of the corresponding sequence, and only the first element s m (1) is visible to the algorithm. At the k th iteration of the procedure, the k th residue is appended to the k - 1 fragment and the visible sequence is checked. If fks m (1,...,k - 1) then fkis considered a new rule, and so added to the dictionary G m k = G m k 1 { f k } MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaGaem4raC0aa0baaSqaaiabd2gaTbqaaiabdUgaRbaakiabg2da9iabdEeahnaaDaaaleaacqWGTbqBaeaacqWGRbWAcqGHsislcqaIXaqmaaGccqGHQicYcqGG7bWEcqWGMbGzdaahaaWcbeqaaiabdUgaRbaakiabc2ha9baa@3E63@ , and the fragment is reset, fk= ∅. However, if fks m (1,...,k - 1), then the current dictionary contains enough rules to produce the current fragment, i.e., G m k = G m k 1 MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaGaem4raC0aa0baaSqaaiabd2gaTbqaaiabdUgaRbaakiabg2da9iabdEeahnaaDaaaleaacqWGTbqBaeaacqWGRbWAcqGHsislcqaIXaqmaaaaaa@36CE@ . In either case, the iteration completes by appending the k th residue to the visible sequence. This procedure continues until the visible sequence is equal to the entire sequence, at which time the size of the dictionary is recorded along the diagonal of the grammar elements matrix, E m, m = |G m |. As will be shown, calculating the distance between sequences requires only the number of entries in the dictionary.

Figure 2
figure 2

Distance calculation. An N × N grammar-based distance matrix D is estimated from the set of N input sequences S. The first step in generating D is to approximate the original number of elements in each sequence's dictionary based on an LZ complexity. Each dictionary is extended using all other sequences resulting in new numbers of elements. The grammar-based distance between sequences m and n is determined by considering the amount by which dictionaries change.

In the next step shown in Figure 2, each sequence is compared with all other sequences. In particular, consider the process of comparing sequences m and n. Initially, the dictionary G m , n 1 MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaGaem4raC0aa0baaSqaaiabd2gaTjabcYcaSiabd6gaUbqaaiabigdaXaaaaaa@31B1@ = G m is set to that of sequence m, a fragment f1 = s n (1) is set to the first residue of the n th sequence, and the visible sequence is all of s m . The algorithm operates as described previously, resulting in a new dictionary size E m, n = |G m,n |. When complete, more grammatically-similar sequences will have a new dictionary size with fewer entries as compared to sequences that are less grammatically-similar. Therefore, the size of the new dictionary Em,nwill be close to the size of the original dictionary E m,m .

In the final step, the distance between the sequences is estimated using the dictionary sizes. Five different distance measures were suggested in [20]. This work used the distance measure

d m , n = E m , n E m , m + E n , m E n , n E m , n + E n , m 2 , MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xI8qiVKYPFjYdHaVhbbf9v8qqaqFr0xc9vqFj0dXdbba91qpepeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaGaemizaq2aaSbaaSqaaiabd2gaTjabcYcaSiabd6gaUbqabaGccqGH9aqpjuaGdaWcaaqaaiabdweafnaaBaaabaGaemyBa0MaeiilaWIaemOBa4gabeaacqGHsislcqWGfbqrdaWgaaqaaiabd2gaTjabcYcaSiabd2gaTbqabaGaey4kaSIaemyrau0aaSbaaeaacqWGUbGBcqGGSaalcqWGTbqBaeqaaiabgkHiTiabdweafnaaBaaabaGaemOBa4MaeiilaWIaemOBa4gabeaaaeaadaWcaaqaaiabdweafnaaBaaabaGaemyBa0MaeiilaWIaemOBa4gabeaacqGHRaWkcqWGfbqrdaWgaaqaaiabd6gaUjabcYcaSiabd2gaTbqabaaabaGaeGOmaidaaaaakiabcYcaSaaa@55A8@
(1)

where m, n ∈ {1,...,N} are indices of two sequences being compared. This particular metric accounts for differences in sequence lengths, and normalizes accordingly. Thus, the final distance matrix D is composed of grammar-based distance entries given by (1). Smaller entries in D indicate a stronger similarity, at least in terms of the LZ-based grammar estimate. Intuitively, sequences with a similar grammar should be pairwise aligned with each other in order for progressive combining into an MSA.

To further improve the execution time, D is only partially calculated as follows. An initial sequence is selected and compared with all other sequences. The resulting distances are split evenly into two groups based on d, one containing the smallest distances, and the other containing the largest distances. The process is repeated recursively on each group until the number of sequences in a group is two. The benefit is that only N log(N) distances need to be calculated. The validity of only calculating these sets of distances stems from the transitivity of the LZ grammars being inferred. That is, if the grammar-based distances d i, j and d j, k are small, it is likely that d i, k is also small. By recursively dividing groups of extreme distances, only those distances which would likely be used in the spanning-tree creation process will actually be calculated.

Sequence Alphabet

The distance between sequences m and n as determined by (1) is based on how many additional rules need to be added to each grammar in order to generate both s m and s n . Because the real grammars are unknown, G m and G n are approximated by scanning the only observations available (i.e., s m and s n ). The grammar approximation improves as the length of the observed sequences increases. And so, the distance calculations are a function of sequence lengths, becoming more accurate as the sequences increase in length. In practice, this calculation works well for DNA sequences, even of shorter lengths, because the approximated grammar of a DNA sequence can only contain rules involving words composed of combinations of elements from the alphabet {'A','C','G','T'}. This small alphabet allows for a rapid generation of a reasonable grammar since there are a relatively small number of permutations of letters. From a grammar perspective, amino acid sequences are generally much more difficult to process correctly using (1). The reason being the alphabet contains 23 letters, where each element is not equally different from all other elements. Due to the relatively large alphabet size, much longer sequences are necessary to generate a reasonable grammar approximation. Thus, the accuracy of distances calculated for sets of short amino acid sequences are diminished. Additionally, consider the substitution scores of 'L' and 'M' as taken from the GONNET250 and BLOSUM62 substitution matrices in Figure 3. Notice in (a) and (c), that 'L' receives a relatively high positive value when aligned with any of {'I','L','M','V'}. Similarly, in (b) and (d), 'M' receives a relatively high positive value when aligned with any of the same set. Additionally, both 'L' and 'M' generally receive high negative values when compared to letters other than {'I','L','M','V'}. When taking this type of scoring into account, the elements 'L' and 'M' could be considered the same letter in a grammatical sense.

Figure 3
figure 3

Substitution scores for amino acid 'L' and 'M'. Bar graphs of the substitution scores for amino acid 'L' and 'M' as taken from the Gonnet250 and BLOSUM62 substitution matrices. The scores are shown based on an alphabetical ordering of amino acid letters from the leftmost 'A' to rightmost 'Z'.

Thus, GramAlign offers the option to use a "Merged Amino Acid Alphabet" when calculating the distance matrix. The merged alphabet contains 11 elements corresponding to the 23 amino acid letters grouped into the sets {'A','S','T','X'}, {'B','D','N'}, {'C'}, {'E','K','Q','R','Z'}, {'F'}, {'G'}, {'H'}, {'I','L','M','V'}, {'P'}, {'W'}, and {'Y'}. These groupings were determined by considering all 23 rows of the BLOSUM45, BLOSUM62, BLOSUM80 and GONNET250 substitution matrices, and only grouping elements that had a strong similarity across the entire row in all four matrices. The merged alphabet has the benefit of containing fewer elements allowing for more accurate distance estimates based upon shorter observed sequences. Also, the resultant merged-alphabet substitution matrices are more consistent in that a merged-letter score is high only when compared to itself. In practice, the average alignment scores increased when aligning the same data sets using the merged alphabet within the distance calculation, as compared to using the actual alphabet (results not shown). In either case, once the distances have been calculated, a tree based on these distances is used to determine which sequences should be pairwise aligned.

Tree Construction

The next step in the algorithm consists of constructing a minimal spanning tree T based on the distance matrix D. In particular, consider a completely connected graph of N vertices and N ( N 1 ) 2 MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaqcfa4aaSaaaeaacqWGobGtcqGGOaakcqWGobGtcqGHsislcqaIXaqmcqGGPaqkaeaacqaIYaGmaaaaaa@333E@ edges, where the weight of an edge between vertices i and j is given by the (i, j)th element of the distance matrix, D i, j . This work uses Prim's Algorithm [22] to determine a minimal spanning tree T which may be used as a guide in determining the order for progressively aligning the set of sequences S.

Align Sequences

The minimal spanning tree T along with the set of sequences S, are processed by the "Align Sequences" block in Figure 1. This block is presented in more detail in Figure 4. The first two sequences from S to be aligned are given by T as the root sequence of T and the nearest sequence in terms of the LZ grammar distance. At the conclusion of the pairwise alignment process, the resulting alignment is stored in an ensemble of sequences.

Figure 4
figure 4

Align sequences. From the spanning tree T and the set of sequences S, a progressive alignment is generated and stored in an ensemble. When no more sequences remain, the final alignment A is available for post-processing gap adjustments.

In the following we describe the pairwise alignment procedure, the scoring system and the method for progressive alignment.

Dynamic Programming

At the core of most progressive MSA algorithms is some method for performing pairwise alignments between two sequences. This work uses a version of the [23] dynamic programming algorithm with affine gap scores as discussed in [2] to generate each pairwise alignment.

Scoring System

A significant ambiguity regarding the dynamic programming procedure is the scoring function used when comparing two elements, or when comparing an element with a gap.

Typically, the pairwise scoring function c() is simply a matrix of values, where each column and row represent one element in the alphabet. In this way, each cell of the matrix corresponds to some measure representing the likelihood that two sequence elements should be aligned with each other. The most well-known amino acid scoring matrices are the Percent Accepted Mutation (PAM) [24], BLOck SUbstitution Matrix (BLOSUM) [25] and GONNET [26]. GramAlign defaults to the GONNET250 substitution matrix for the scoring function c(), as other progressive alignment algorithms generally use it as the default choice (e.g., [14] and [16]).

Determining the best gap-open and gap-extension penalties is a challenging problem, made more difficult by introducing two different penalties to account for the beginning and ending tail gaps of alignments. The default gap penalties used by GramAlign have been adjusted to perform well based on the alignment sets presented in the results section.

Progressive Alignment

The ensemble is implemented as a doubly-linked list, where each node of the list represents a single column of the alignment. Each node of the ensemble contains an array of letters corresponding to the respective column alignment, a tally of gaps in the column, a weighted combination of substitution scores, and two gap penalties. Once the initial ensemble A(0,1) is constructed between the first two entries in T, the remaining sequences need to be added to the ensemble in the order defined by T. This is accomplished by checking T for the next sequence not already in the ensemble, call it sequence s j where j corresponds to the order in which the sequence was added to T; that is, j is the priority of the sequence. To progressively add s j to the alignment, a pairwise alignment between the ensemble A(0,...,j-1)and s j is created via the afore mentioned dynamic programming algorithm. While the algorithm used is a pairwise alignment algorithm the distance calculated at each step of the pairwise alignment is an average of the distances between the particular position being aligned in the new sequence and the corresponding amino acides or bases in the ensemble at that node. The new pairwise alignment is merged into the ongoing ensemble based on the trace-back. The process continues until all sequences have been added to the ensemble of sequences. When sequence s j is added to the current ensemble A(0,...,j-1), each node is updated to reflect the new column element.

Gap Adjustment

Once all N sequences have been progressively aligned, the final post-processing block in Figure 1, "Adjust MSA Gaps", is used to cluster gaps together. The adjustment is further detailed in Figure 5, where the ensemble A is scanned so a histogram H of gaps-per-column is generated.

Figure 5
figure 5

Adjust gaps. Gaps in the complete MSA ensemble A are grouped together via a sliding window. After the histogram H of gaps-per-column is generated, an equidistant column-window is shifted across the alignment, moving one column per interval. If the center column contains more gaps than some parameter threshold, the columns within the window are scanned for possible gaps that may be shifted into the center column. The resulting adjusted ensemble A Adj is presented as the final alignment.

The histogram H is scanned using an equidistant, user-adjustable sliding window about each column. For each column, when the number of gaps is greater than a user-adjustable threshold percentage of gaps-per-column, the following steps are taken. For each row in the column under consideration:

  1. 1.

    If the current row has a gap, move to the next row;

  2. 2.

    Otherwise, scan the current row of the neighboring columns within the window, beginning with the nearest columns and work outward;

  3. 3.

    If a neighboring column has a gap in the current row and the neighboring column has fewer total gaps than the center column, shift the gap from the neighboring column into the column under consideration.

As an illustration, consider a portion of the ensemble

A : { x 1 , i 2 x 1 , i 1 1 , i x 1 , i + 1 x 1 , i + 2 x 2 , i 2 2 , i 1 2 , i 2 , i + 1 x 2 , i + 2 x 3 , i 2 3 , i 1 3 , i 3 , i + 1 x 3 , i + 2 4 , i 2 x 4 , i 1 x 4 , i 4 , i + 1 x 4 , i + 2 x 5 , i 2 x 5 , i 1 x 5 , i 5 , i + 1 x 5 , i + 2 MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xI8qiVKYPFjYdHaVhbbf9v8qqaqFr0xc9vqFj0dXdbba91qpepeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaGaemyqaeKaeiOoaOZaaiqaaeaafaqaaeqbfaaaaaqaaiablAciljabdIha4naaBaaaleaacqaIXaqmcqGGSaalcqWGPbqAcqGHsislcqaIYaGmaeqaaaGcbaGaemiEaG3aaSbaaSqaaiabigdaXiabcYcaSiabdMgaPjabgkHiTiabigdaXaqabaaakeaacqGHsisldaWgaaWcbaGaeGymaeJaeiilaWIaemyAaKgabeaaaOqaaiabdIha4naaBaaaleaacqaIXaqmcqGGSaalcqWGPbqAcqGHRaWkcqaIXaqmaeqaaaGcbaGaemiEaG3aaSbaaSqaaiabigdaXiabcYcaSiabdMgaPjabgUcaRiabikdaYaqabaGccqWIMaYsaeaacqWIMaYscqWG4baEdaWgaaWcbaGaeGOmaiJaeiilaWIaemyAaKMaeyOeI0IaeGOmaidabeaaaOqaaiabgkHiTmaaBaaaleaacqaIYaGmcqGGSaalcqWGPbqAcqGHsislcqaIXaqmaeqaaaGcbaGaeyOeI0YaaSbaaSqaaiabikdaYiabcYcaSiabdMgaPbqabaaakeaacqGHsisldaWgaaWcbaGaeGOmaiJaeiilaWIaemyAaKMaey4kaSIaeGymaedabeaaaOqaaiabdIha4naaBaaaleaacqaIYaGmcqGGSaalcqWGPbqAcqGHRaWkcqaIYaGmaeqaaOGaeSOjGSeabaGaeSOjGSKaemiEaG3aaSbaaSqaaiabiodaZiabcYcaSiabdMgaPjabgkHiTiabikdaYaqabaaakeaacqGHsisldaWgaaWcbaGaeG4mamJaeiilaWIaemyAaKMaeyOeI0IaeGymaedabeaaaOqaaiabgkHiTmaaBaaaleaacqaIZaWmcqGGSaalcqWGPbqAaeqaaaGcbaGaeyOeI0YaaSbaaSqaaiabiodaZiabcYcaSiabdMgaPjabgUcaRiabigdaXaqabaaakeaacqWG4baEdaWgaaWcbaGaeG4mamJaeiilaWIaemyAaKMaey4kaSIaeGOmaidabeaakiablAcilbqaaiablAciljabgkHiTmaaBaaaleaacqaI0aancqGGSaalcqWGPbqAcqGHsislcqaIYaGmaeqaaaGcbaGaemiEaG3aaSbaaSqaaiabisda0iabcYcaSiabdMgaPjabgkHiTiabigdaXaqabaaakeaacqWG4baEdaWgaaWcbaGaeGinaqJaeiilaWIaemyAaKgabeaaaOqaaiabgkHiTmaaBaaaleaacqaI0aancqGGSaalcqWGPbqAcqGHRaWkcqaIXaqmaeqaaaGcbaGaemiEaG3aaSbaaSqaaiabisda0iabcYcaSiabdMgaPjabgUcaRiabikdaYaqabaGccqWIMaYsaeaacqWIMaYscqWG4baEdaWgaaWcbaGaeGynauJaeiilaWIaemyAaKMaeyOeI0IaeGOmaidabeaaaOqaaiabdIha4naaBaaaleaacqaI1aqncqGGSaalcqWGPbqAcqGHsislcqaIXaqmaeqaaaGcbaGaemiEaG3aaSbaaSqaaiabiwda1iabcYcaSiabdMgaPbqabaaakeaacqGHsisldaWgaaWcbaGaeGynauJaeiilaWIaemyAaKMaey4kaSIaeGymaedabeaaaOqaaiabdIha4naaBaaaleaacqaI1aqncqGGSaalcqWGPbqAcqGHRaWkcqaIYaGmaeqaaOGaeSOjGSeaaaGaay5Eaaaaaa@D3E2@

where x m, n represents any element other than a gap in column n of sequence m, and - m, n represents a gap in column n of sequence m. And so, the gap histogram for this section of ensemble is H = {...,1, 2, 3, 4, 0,...}. Assuming the gap threshold is 0.4, then only columns with more than two gaps will be considered for adjustment. In the example, H is scanned until column i is identified as having three gaps. Following the procedure, each row in column i is checked until a non-gap entry is found. In the example, the first non-gap entry x4, iis in row four. Assuming the gap window is 2, elements in the fourth row of the neighboring columns are checked for gap entries. In particular, column (i + 1) is checked first, with a gap entry -4, i+1. However, no shift occurs because a quick check of H shows that column (i + 1) has more gaps than column i. Continuing the scan, columns (i - 1) and (i + 2) are checked before another gap is found in column (i - 2). In this case, H indicates column (i - 2) has fewer gaps compared to column i, and so a blind shift of entries between (i - 2) and i occurs, resulting in the ensemble

A : { x 1 , i 2 x 1 , i 1 1 , i x 1 , i + 1 x 1 , i + 2 x 2 , i 2 2 , i 1 2 , i 2 , i + 1 x 2 , i + 2 x 3 , i 2 3 , i 1 3 , i 3 , i + 1 x 3 , i + 2 x 4 , i 2 x 4 , i 4 , i 2 4 , i + 1 x 4 , i + 2 x 5 , i 2 x 5 , i 1 x 5 , i 5 , i + 1 x 5 , i + 2 MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xI8qiVKYPFjYdHaVhbbf9v8qqaqFr0xc9vqFj0dXdbba91qpepeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaGaemyqaeKaeiOoaOZaaiqaaeaafaqaaeqbfaaaaaqaaiablAciljabdIha4naaBaaaleaacqaIXaqmcqGGSaalcqWGPbqAcqGHsislcqaIYaGmaeqaaaGcbaGaemiEaG3aaSbaaSqaaiabigdaXiabcYcaSiabdMgaPjabgkHiTiabigdaXaqabaaakeaacqGHsisldaWgaaWcbaGaeGymaeJaeiilaWIaemyAaKgabeaaaOqaaiabdIha4naaBaaaleaacqaIXaqmcqGGSaalcqWGPbqAcqGHRaWkcqaIXaqmaeqaaaGcbaGaemiEaG3aaSbaaSqaaiabigdaXiabcYcaSiabdMgaPjabgUcaRiabikdaYaqabaGccqWIMaYsaeaacqWIMaYscqWG4baEdaWgaaWcbaGaeGOmaiJaeiilaWIaemyAaKMaeyOeI0IaeGOmaidabeaaaOqaaiabgkHiTmaaBaaaleaacqaIYaGmcqGGSaalcqWGPbqAcqGHsislcqaIXaqmaeqaaaGcbaGaeyOeI0YaaSbaaSqaaiabikdaYiabcYcaSiabdMgaPbqabaaakeaacqGHsisldaWgaaWcbaGaeGOmaiJaeiilaWIaemyAaKMaey4kaSIaeGymaedabeaaaOqaaiabdIha4naaBaaaleaacqaIYaGmcqGGSaalcqWGPbqAcqGHRaWkcqaIYaGmaeqaaOGaeSOjGSeabaGaeSOjGSKaemiEaG3aaSbaaSqaaiabiodaZiabcYcaSiabdMgaPjabgkHiTiabikdaYaqabaaakeaacqGHsisldaWgaaWcbaGaeG4mamJaeiilaWIaemyAaKMaeyOeI0IaeGymaedabeaaaOqaaiabgkHiTmaaBaaaleaacqaIZaWmcqGGSaalcqWGPbqAaeqaaaGcbaGaeyOeI0YaaSbaaSqaaiabiodaZiabcYcaSiabdMgaPjabgUcaRiabigdaXaqabaaakeaacqWG4baEdaWgaaWcbaGaeG4mamJaeiilaWIaemyAaKMaey4kaSIaeGOmaidabeaakiablAcilbqaaiablAciljabdIha4naaBaaaleaacqaI0aancqGGSaalcqWGPbqAcqGHsislcqaIYaGmaeqaaaGcbaGaemiEaG3aaSbaaSqaaiabisda0iabcYcaSiabdMgaPbqabaaakeaacqGHsisldaWgaaWcbaGaeGinaqJaeiilaWIaemyAaKMaeyOeI0IaeGOmaidabeaaaOqaaiabgkHiTmaaBaaaleaacqaI0aancqGGSaalcqWGPbqAcqGHRaWkcqaIXaqmaeqaaaGcbaGaemiEaG3aaSbaaSqaaiabisda0iabcYcaSiabdMgaPjabgUcaRiabikdaYaqabaGccqWIMaYsaeaacqWIMaYscqWG4baEdaWgaaWcbaGaeGynauJaeiilaWIaemyAaKMaeyOeI0IaeGOmaidabeaaaOqaaiabdIha4naaBaaaleaacqaI1aqncqGGSaalcqWGPbqAcqGHsislcqaIXaqmaeqaaaGcbaGaemiEaG3aaSbaaSqaaiabiwda1iabcYcaSiabdMgaPbqabaaakeaacqGHsisldaWgaaWcbaGaeGynauJaeiilaWIaemyAaKMaey4kaSIaeGymaedabeaaaOqaaiabdIha4naaBaaaleaacqaI1aqncqGGSaalcqWGPbqAcqGHRaWkcqaIYaGmaeqaaOGaeSOjGSeaaaGaay5Eaaaaaa@D3E4@

where original indices are kept to depict which entries are shifted into which locations.

The result is a blind movement of sparse gaps into dense regions of gaps. Numeric simulations have shown this post-processing stage does not affect alignment scoring based upon the method used in the Results and Discussion section (results not shown). And so, the user-defined parameters are set to a threshold of 1.0 and a window of 0 columns by default thereby disabling the gap adjustment block. Should it be known there are conserved regions of gaps, the user may decide to enable this process to encourage gap grouping.

Algorithm Complexity

The algorithm complexity of GramAlign may be broken into five pieces, beginning with the generation of each sequence grammar dictionary, G i for i ∈ {1,...,N}, where N is the number of sequences. Suppose the average sequence length is L, then each G i results in complexity O MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaWenfgDOvwBHrxAJfwnHbqeg0uy0HwzTfgDPnwy1aaceaGae8NdX=eaaa@3765@ (L), so all dictionaries are generated with complexity O MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaWenfgDOvwBHrxAJfwnHbqeg0uy0HwzTfgDPnwy1aaceaGae8NdX=eaaa@3765@ (LN). Next, the distance matrix D is formed by recursively extending a grammar by all other sequences within it's neighborhood, each of which results in complexity O MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaWenfgDOvwBHrxAJfwnHbqeg0uy0HwzTfgDPnwy1aaceaGae8NdX=eaaa@3765@ (L), then splitting the neighborhood into two halves, resulting in a complexity O MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaWenfgDOvwBHrxAJfwnHbqeg0uy0HwzTfgDPnwy1aaceaGae8NdX=eaaa@3765@ (LN log(N)). The spanning tree T is constructed by searching over D with a complexity of O MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaWenfgDOvwBHrxAJfwnHbqeg0uy0HwzTfgDPnwy1aaceaGae8NdX=eaaa@3765@ (N2). The tree is used as a map in determining the order in which to perform N - 1 pairwise alignments, each requiring a complexity of O MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaWenfgDOvwBHrxAJfwnHbqeg0uy0HwzTfgDPnwy1aaceaGae8NdX=eaaa@3765@ (L2 + L). Thus, the progressive alignment process takes O MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaWenfgDOvwBHrxAJfwnHbqeg0uy0HwzTfgDPnwy1aaceaGae8NdX=eaaa@3765@ (L2N). The alignment ensemble is scanned and has gaps shifted in O MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaWenfgDOvwBHrxAJfwnHbqeg0uy0HwzTfgDPnwy1aaceaGae8NdX=eaaa@3765@ (LN) time. Thus, the entire time complexity for GramAlign is O MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaWenfgDOvwBHrxAJfwnHbqeg0uy0HwzTfgDPnwy1aaceaGae8NdX=eaaa@3765@ (LN + LN log(N) + N2 + L2N + LN), which simplifies to O MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaWenfgDOvwBHrxAJfwnHbqeg0uy0HwzTfgDPnwy1aaceaGae8NdX=eaaa@3765@ (N2 + L2N).

Results and Discussion

In this section, example alignments are used to study the possible advantages of GramAlign. All results were generated by compiling and executing the respective MSA programs on the same computer; specifically, an Apple iBook with a PowerPC G4 operating at 1.2 GHz with 1.25 Gb system memory and 512 Kb L2 cache. Two sets of experiments were conducted. The first set of experiments were conducted using the unaligned FASTA files from the BAliBASE 3.0 [27] data-set, a well-accepted benchmark database containing example amino acid sequences. The resulting aligned FASTA files from each algorithm were scored using bali score, a program provided with the BAliBASE distribution that generates a Sum-of-Pairs (SP) score and a Total-Column (TC) score based on predetermined reference alignments. The size of the sequences in the BAliBASE distribution are relatively small and, therefore, not very useful in demonstrating the advantages to be obtained using a fast algorithm. The second set of experiments were conducted using sequences generated by Rose version 1.3 to demonstrate algorithms' capabilities on large data sets containing either long or numerous sequences. Rose is a software tool that implements a probabilistic model of sequence evolution, so that a user is able to generate families of related sequences from a common ancestor sequence via insertion, deletion and substitution [28]. Rose allows for many parameter adjustments including rate of mutation, desired average final sequence length and number of desired sequences. The tool outputs the unaligned sequences, as well as the real alignment based on how mutations occur, and an evolutionary tree. The set of sequences generated by Rose were based on the default seed file provided with the Rose software distribution, where the seed file is the method used to input parameters to Rose.

Note the use of simulated data here is to demonstrate the speed advantage of GramAlign, while maintaining a similar qualitative score. The default values were used to generate the data and the algorithms were not tuned to the data. The use of simulated data may actually provide a biased advantage in quality score to any given alignment program, depending on how the simulated data is generated. A wider breadth of simulated data, such as was done in [29], would provide a better assessment of overall alignment quality.

BAliBASE Experiments

Alignment files in the BAliBASE database are separated into five categories (RV1x through RV50), each exhibiting different classes of alignment issues (e.g., one sequence might be significantly longer than the other sequences in a file). The first class is further divided into two subcategories labeled RV11 and RV12. The results presented in Table 1 and Table 2 respectively detail the average SP and TC scores over each category as aligned by GramAlign version 1.14 (see Additional file 1), ClustalW version 1.83, T-Coffee version 4.45, PSAlign using ProbCons as the tree generation (no version given, archive created on 3/2/2006), Kalign version 1.04, MAFFT version 5.861, and MUSCLE version 3.6. Additionally, a fast version was tested for ClustalW, MAFFT, MUSCLE and MAFFT version 6.240. In particular, the command line options used were clustalw -quicktree, mafft --retree 1, muscle -maxiters 1 -diags -sv -distance1 kbit20_3 and mafft --retree 1 --parttree --partsize 50 to incorporate high-speed progressive options. In all cases the default parameters were used for each program. In general, there are no significant differences in the performance of GramAlign and other algorithms as far as the SP and TC scores are concerned. As may be seen, GramAlign provides similar alignments in terms of the quality determined via the scoring method used.

Table 1 Average SP scores on BAliBASE.
Table 2 Average TC scores on BAliBASE.

Presented in Table 3 are the execution times necessary to generate the entire data presented in Table 1 and Table 2. GramAlign finishes in approximately 0.4% of the time needed by PSAlign, which generated the highest scoring alignments in five out of the six BAliBASE categories as far as SP scores are concerned. PSAlign's average SP and TC score on the other hand were 9.4 and 17.5% better than GramAlign's scores, which was approximately 223 times faster. Out of the four approaches MAFFT, MAFFT v6, MAFFT (fast), MUSCLE (fast), which were 17.1, 49.9, 54.0, and 55.7% faster than GramAlign, respectively, only MAFFT had a 2% better average SP score than GramAlign. All other average SP and TC scores were equivalent or worse than that of GramAlign. Further, the GramAlign alignments scored equal-to or greater-than 56.9, 59.6, 60.8, and 71.1% of the trials based on TC score, compared to MAFFT, MAFFT v6, MAFFT (fast), and MUSCLE (fast) (results not shown). GramAlign finishes in 33% of the time required by ClustalW using -quicktree, and only 8% needed by ClustalW, possibly the most widely used MSA program.

Table 3 Execution time.

Experiments with Large Data Sets

Long Sequence Experiments

In order to compare the performance of MSA algorithms on long data sets, two sets of seven FASTA files each containing ten sequences were generated using Rose version 1.3. The first set of seven FASTA files contains protein sequences and the second set contains DNA sequences. In both sets, the first file contains sequences with an average length of 5,000 residues, with each file increasing the average sequence length by 5,000 residues. Thus, the seventh file contains ten sequences with an average sequence length of 35,000 residues.

Figures 6 and 7 depict the execution time required for the fastest algorithms to align the seven large protein and DNA sequence sets, respectively. As the average length of sequences increases, the difference in time required by GramAlign compared to the other algorithms also increases. In particular, at an average sequence length of 35,000 residues GramAlign completes the alignments in 3,363 and 3,092 seconds, while the nearest algorithm (MAFFT in fast-mode) requires 10,362 and 6,981 seconds. That is, GramAlign finishes in 32% and 44% of the time required by the next fastest algorithm.

Figure 6
figure 6

Rose protein long. Result of executing the fastest algorithms on the Rose-generated long protein sequence sets.

Figure 7
figure 7

Rose DNA long. Result of executing the fastest algorithms on the Rose-generated long DNA sequence sets.

MUSCLE in fast mode encountered a segmentation fault during the Root Alignment step while running on the longest test sequences, and so the execution time is not included in Figures 6 and 7.

Numerous Sequence Experiments

In order to compare the performance of MSA algorithms on data sets with many sequences, two sets of seven FASTA files each containing sequences with an average length of 100 residues were generated using Rose version 1.3. The first set of seven FASTA files contains protein sequences and the second set contains DNA sequences. In both sets, the first file contains 100 sequences, with each file increasing the number of sequences up to the seventh file, which contains 10,000 sequences.

As shown in [30], the authors of MAFFT added a new heuristic method for generating a spanning tree referred to as "PartTree". The increase in performance is dramatic and intended for data sets involving many sequences. Thus, for this set of experiments, MAFFT version 6.240 was added with the command line mafft --retree 1 --parttree --partsize 50, which matches the fastest algorithm presented in [30]. Figures 8 and 9 depict the execution time required for the fastest algorithms to align the seven large protein and DNA sequence sets, respectively. As the number of sequences increases, the difference in time required by GramAlign and MAFFT v6 compared to the other algorithms also increases. In particular, on the sets containing 10,000 protein and DNA sequences GramAlign completes the alignments in 162 and 68 seconds and MAFFT v6 completes the alignments in 119 and 71 seconds, while the next closest algorithm, MUSCLE in fast-mode, requires 621 and 456 seconds. That is, GramAlign finishes in 26% and 15% of the time required by the next fastest algorithm other than MAFFT v6.

Figure 8
figure 8

Rose protein many. Result of executing the fastest algorithms on the Rose-generated numerous protein sequence sets.

Figure 9
figure 9

Rose DNA many. Result of executing the fastest algorithms on the Rose-generated numerous DNA sequence sets.

The results imply the promising viability of the proposed algorithm, especially when aligning either long or numerous sequences such as in whole-genome applications. Further, better alignment scores may be achieved with little change in execution time via the user-alterable parameters.

Conclusion

The primary goal of this work was to introduce a computationally-efficient progressive alignment algorithm which can be used for aligning large data sets. The grammar-based distance work presented in [20] was adapted to generate an estimation of the proper order in which sequences are to be aligned. Additionally, a merged amino acid alphabet was determined to allow an improved grammar-based distance when operating on protein sequences. Results from extensive alignments were presented in an attempt to study the overall quality of the resultant alignments as well as the computation time necessary to achieve the alignments. Correctly aligning multiple biological sequences in an efficient amount of time is an important and challenging problem with a wide spectrum of applications. In this work, we adapt existing ideas in a novel way introducing innovative improvements. The proposed algorithm achieves reasonable alignments compared to existing methods while significantly reducing execution time. Future work will focus on determining the best set of user-defined parameters for generating the highest overall SP and TC scores.

Availability

The current version of GramAlign may be run on-line, or the source code may be downloaded from the web server http://bioinfo.unl.edu/GramAlign.html.