Skip to main content
  • Research article
  • Open access
  • Published:

Automatic detection of anchor points for multiple sequence alignment

Abstract

Background

Determining beforehand specific positions to align (anchor points) has proved valuable for the accuracy of automated multiple sequence alignment (MSA) software. This feature can be used manually to include biological expertise, or automatically, usually by pairwise similarity searches. Multiple local similarities are be expected to be more adequate, as more biologically relevant. However, even good multiple local similarities can prove incompatible with the ordering of an alignment.

Results

We use a recently developed algorithm to detect multiple local similarities, which returns subsets of positions in the sequences sharing similar contexts of appearence. In this paper, we describe first how to get, with the help of this method, subsets of positions that could form partial columns in an alignment. We introduce next a graph-theoretic algorithm to detect (and remove) positions in the partial columns that are inconsistent with a multiple alignment. Partial columns can be used, for the time being, as guide only by a few MSA programs: ClustalW 2.0, DIALIGN 2 and T-Coffee. We perform tests on the effect of introducing these columns on the popular benchmark BAliBASE 3.

Conclusions

We show that the inclusion of our partial alignment columns, as anchor points, improve on the whole the accuracy of the aligner ClustalW on the benchmark BAliBASE 3.

Background

Multiple sequence alignment (MSA) appears as the initial step of almost all biological sequence analyses. However, MSA is well known to be a difficult problem, both from the algorithmic point of view and with respect to the biological relevance of the output. The local alignment is a classical paradigm in sequence analysis [1, 2]. The idea of including local alignment information into global alignment tools, like in DIALIGN [3], represented an important step in alignment accuracy, and is also at work in more recent tools like T-Coffee [4], MUSCLE [5] or MAFFT [6]. A latest trend is to include homology information retrieved from existing databases, such as, e.g., in DbClustal [7]. For recent reviews on MSA programs see [810]. Another way to improve the accuracy of existing MSA is to include user-specified anchor points, which are specific positions that should turn out to be aligned in the output [11]. This information can be composed of a small number of expert-based constraints, or can be used to include additional information, such as secondary structure predictions (like in [12]) or other information derived from external resources [7].

Multiple sequence alignment, being NP-hard under any reasonable optimisation scheme, must consistently rely on heuristics. The inclusion of anchor points can result in a dramatic improvement on the relevance of the alignment, if it constrains the search of the local optimum to a region that contains the "true" alignment. The number of MSA programs that currently accept the inclusion of user-specified anchor points is unfortunately limited. To our knowledge, only DIALIGN 2 has such an explicit option [13], while it is also possible to include anchor points in ClustalW 2.0 [14], by using the format developed for the BLAST-based BALLAST [7] tool, and in T-Coffee, by including the anchor points as library files.

Anchored alignment is also widely used for whole genome alignment strategies, for which it is almost required, by the sheer size of the input, to start by detecting strong pairwise local similarities for the efficiency of the subsequent algorithm (see e.g., [15]). For instance, exact maximal repeated substrings (like multi-MUMs or MEMs [16]) can prove to be sufficiently informative, although more recent methods use spaced seeds (see [17]). In this paper, we follow likewise a combinatorial approach, but our focus concerns however not whole genomes, but sequences that are amenable to traditional multiple alignment methods, such as protein or gene-sized nucleic sequences.

We introduce a method to determine automatically a set of such "anchor points" for multiple alignment software. We base ourselves on a previously introduced algorithm, the N-local decoding, introduced by Didier [18] that clusters together positions in the sequences whose contexts of appearance of a given length N are similar but exhibit an a priori unspecified number of mismatches. More precisely, we use a method called MS4 [19], which selects multiple local similarities resulting from the N-local decoding, but for an adaptive value of N.

However, specifying contradicting anchor points can prove deleterious. Indeed, suggesting or imposing that some positions be aligned while these positions are incompatible with the ordering induced by the sequence can altogether destroy the relevance of the alignment. The simplest kind of incompatibility arises from internal repeats inside sequences. The MS4 method is here tuned to accept only similarities occurring at most once in any sequence. Usually, anchor points are specified as pairs of aligned residues, or possibly, of aligned segments. In order not to confuse the reader, we will call the output of this procedure partial columns, because they would look as such in a multiple alignment display.

The core of the present paper consists in a graph-theoretic algorithm to tackle the global issues of consistency with a multiple alignment. To do this, we consider the order-theoretic definition of consistency (as used, e.g., in DIALIGN [20]). Each sequence is seen as an abstract ordered sequence of positions (from left to right). A collection of subsets of positions can be added to a given multiple alignment under a technical condition which ensures that the elements of different subsets never appear in contradicting orders. This condition is readily encoded in a directed graph, and the consistency problem amounts to getting a directed acyclic graph (DAG) from it. Our algorithm starts by implementing a heuristic solution to the NP-hard problem known as the minimum feedback arc-set problem. Once a DAG has been identified, positions that contradict the induced partial order are removed from the corresponding partial column. We call the output of this procedure consistent partial columns.

As a validation of the method, we introduced the partial columns, and the consistent partial columns, into the programs accepting anchoring options. We tested the effect of introducing these two types of anchor points on the performance of these MSA tools on the global benchmark BAliBASE 3 [21]. The results show that the use of either type of partial columns induce improvements of performance for ClustalW 2.0 on BAliBASE, which are better and stabler with the consistent ones. By contrast, we get a consistent degradation of performance for DIALIGN, and almost no variation for T-Coffee.

Although we used our method only with the MS4-based partial columns, this algorithm can be applied to any other set of partial columns. The MS4 approach has the advantage to detect directly multiple similarities with only linear complexity. Virtually any scheme for detecting local similarities could produce an input for our method, provided that all internal repetitions be removed. It is for example possible to use pairwise similarities, such as used by most MSA programs, and select among them those that involve more than two sequences to construct the partial columns, albeit at some computational cost. In [22], we used the pairwise optimal fragments for DIALIGN, and the consistency algorithm described in the present paper, this time with satisfactory results.

Methods

Let S be a collection of n sequences over a finite alphabet. The site space

S = { ( i , p ) | 1 i n , 1 p ( i ) } ,

where ℓ(i) is the length of the i-th sequence, is the abstract set of positions in the sequences, and is endowed with a natural partial ordering "" such that (i, p) (i', p') holds if and only if i = i' and pp'. Let S i be the set of sites of the i-th sequence, i.e. the set {(i, p)|1≤ p ≤ ℓ(i)}. In the following, we identify S i with the i-th sequence.

An alignment of S, in the sense of DIALIGN [20], is a partition A of S that satisfies a consistency condition. As usual, we attach to the partition A the natural equivalence relation ~ A defined as x ~ A y if and only if there exists a subset a A that contains both x and y. Then the consistency condition reads as follows: the preorder A= ( U ~ A ) t , where R t denotes the transitive closure of a relation R, coincides with the order when restricted to any sequence s S. The equivalence classes of the partition A correspond to parts of columns of aligned positions of S. If only a set of disjoint subsets of positions whose union does not cover the whole set S is given, we implicitly consider the partition obtained by adding the missing singletons. These notions are illustrated for concreteness' sake on the toy example presented in Figure 1.

Figure 1
figure 1

Alignments as partitions of the set of sites. (Left) - Unaligned sequences: the class in red is ambiguous. It cannot take place into any alignment of the sequences. The green and orange classes are non-ambiguous. However, they are incompatible with each other. If the green class is accepted, then the orange one must be excluded. (Right) - An alignment of the sequences containing as equivalence class the green subset of sites. Each column of the complete alignment is a subset of sites. The corresponding partition is consistent: in particular, all the elements in a given column appear in the same order with respect to another column.

We call a subset C S ambiguous if it contains a repetition, that is, there is a sequence S i such that the intersection C S i contains at least two distinct elements (i, p) and (i, p'), which are then also called ambiguous with respect to C. This definition is extended to an equivalence relation E on S by calling E itself ambiguous, if it contains an equivalence class which is an ambiguous subset.

A non-ambiguous subset C S will be called a partial alignment column. A non-ambiguous equivalence relation consists therefore only of partial alignment columns. If an equivalence relation is consistent, it is obviously non-ambiguous. The converse is however in general not true.

The MS4 method

Our partial column detection scheme is called MS4, and is described in [19]. It relies on a fast algorithm for producing partitions of sites, the N-local decoding, that we briefly recall.

A word w A N occurs at position i relatively to s = (s, p) if s[p-i, p-i+N-1]= w. Say σ N σ' whenever there is an identical length N word w at the same position relatively to both σ and σ'. A single length N word induces N instances of the relation N , one for each position in the word. The N-local decoding ofS is the partition Nof S induced by the transitive closure of N . Therefore, two sites σ and σ' are clustered together if there is a chain of occurrences of identical length N words that connects them (Figure 2).

Figure 2
figure 2

N -local decoding. Schematic explanation of the NLD procedure. Sites s and s' (resp. s' and s'') appear at the same position of two occurrences of an identical word (respectively words 1 and 2). Positions s and s'' are therefore connected by transitive closure.

The MS4 method combines the different equivalence classes from various values of N by introducing a new construction, the partition tree, which encodes how the equivalence classes for successive values of N are related.

Letting 0 = { S } we can encode the set V = Ui i of equivalence classes for different values of N into the partition tree P = (V, EP), defined by

E P = { ( u , v ) N × N + 1 | v u } .

The leaves of the partition tree are the sites in the sequences. Let us say that a node is ambiguous if the leaves of the partition tree that are children of this node form an ambiguous subset of sites.

Given k , we define the set of MS4 partial columns (or shorter, partial columns) spanning at least k sequences, as the set of subsets of sites C k corresponding to the children of non-ambiguous nodes v of the partition tree such that their direct ancestor in the tree is ambiguous (see Figure 3). This condition ensures that the resulting subsets of sites are indeed partial columns, as illustrated in Figures 4 and 5.

Figure 3
figure 3

Selection of partial column subsets on a partition tree. Toy example (continued) - Selection of nodes corresponding to partial columns using the partition tree. The partition tree of the example in Figure 1 features as green nodes the "highest" non-ambiguous nodes. The leaves are the sites (i, p) in the sequences i at position p (note that numbering starts with 0). Sets of leaves sitting underneath a green node correspond to selected partial alignment columns. An inner node is denoted by a suffixed letter, e.g., A2-4 corresponds to an equivalence class for N = 4. The green nodes share the property of being non-ambiguous and having an ambiguous node as direct ancestor.

Figure 4
figure 4

Alignments as partitions of the set of sites (continued). Toy example (continued) - The example alignment of Figure 1, onto which the partial columns detected by MS4 have been "projected". Some MS4 classes, for instance T0-5, correspond exactly to some equivalence class of the original alignment, while others, like G2-5 form only a subset of an alignment column. Note that other classes, like G1-3, while being partial columns by definition, are not part of this particular alignment.

Figure 5
figure 5

Alignments as partitions of the set of sites (end). Toy example (end) - The alignment of the same sequences as produced by DIALIGN 2 with the featured partial columns included as anchor points. Almost all MS4 partial columns are now part of the alignment, except T1-3. The set of MS4 partial columns for this example is consistent, as can be seen by simply sliding the lowest occurrence of T1-3 below its corresponding fellow. The perturbation in the alignment is however sufficiently penalized by the optimisation function of DIALIGN to be rejected from the final alignment.

Consistent Partial Columns

We present now the algorithm that resolves the inconsistencies among a set of partial columns.

The succession graph of a set C of partial columns is the edge-weighted directed graph S G ( C ) = ( C , E , w ) where we have an edge e = (C, C') if and only if there exists a sequence i and sites (i, p) C and (i, p') C' that satisfy p <p'. An edge from C to C' means that there exists at least one sequence where C occurs to the left of C'. The weight ( C,C' ) of the edge (C, C') is then defined as the number of sequences i with this property. For convenience purposes, we also add an initial vertex vstart and a terminal one vend. The following result is quite easy to establish.

Lemma 1. The set C is consistent if and only if SG(C) is a directed acyclic graph (DAG).

Finding a consistent set of partial columns amounts therefore to finding a set of partial columns whose succession graph is a DAG. To turn our possibly inconsistent set of subsets of sites C = { C 1 , C 2 , ... , C p } into a consistent one, we proceed in two steps:

  1. 1.

    delete some edges of the succession graph G = SG(C) to turn it into a DAG,

  2. 2.

    transform the subsets C i themselves so that the succession graph of this new set of partial columns is itself a DAG.

For our applications, we will take C = C k described in the previous section, but the procedure we introduce here would work starting with any set of disjoint non-ambiguous subsets of S.

Getting a Directed Acyclic Graph

An optimal solution to the first problem would suppress a subset of edges of total minimal weight that yields a DAG. However, this is an NP-hard problem known as the minimal (weighted) feedback arc set problem. As a heuristic substitute, we successively remove the lowest weighted edges from the graph until all cycles have disappeared. Namely, let for k the edge subset

E k = { ( u , v ) E | w ( u , v ) > k or u = v start or v = v end } ,

and k* = min{k > 0|(V, E k ) is a DAG}.

Removing Inconsistencies

We describe now a method that will remove sites from the subsets C i in the set Csuch that the resulting set of partial columns C' is consistent. The algorithm tries to make the partial ordering on the partial columns induced by the DAG compatible with the linear partial ordering on the sites in the sequences, by removing a minimal set of positions from the partial columns. The subtle point is that deleting the edge (u, v) cannot be always interpreted directly as the removal of some positions that belong to partial columns u or v. The procedure is illustrated in Figure 6.

Figure 6
figure 6

Toy example for the removal of inconsistencies. Removal of inconsistencies from a set of partial columns. On the left, the sites belonging to column "A" are denoted by a square box bearing that letter. On the right, the graph captures the immediate succession of the partial columns. The overall inconsistency can be detected by the cycle A→D→B→C→A. Assume that the DAG is obtained by removing the red edge C→A. The algorithm in section Getting an Acyclic Graph proceeds as indicated on the right. Namely, the longest path for each sequence is indicated with the bold black edges and the remaining edges from relation R are in grey. The result is the removal from the partial column "C" of the site indicated in red.

The acyclic graph ( V , E k * ) can turn out to be disconnected, so we reconnect it by adding all the necessary edges of the form (vstart, u) or (u, vend), and denote with G* the corresponding graph. Let ≤* be the partial order defined on C by the DAG G*. For each sequence s, let C s be the set of partial columns C of Chaving a (necessarily unique by definition) site (s, j C ) in s. There are two order relations on Vs = C s U { vstart,vend}, namely

  • the total order s induced by the natural order of S defined in section Methods,

  • the partial order s * induced by the order ≤*defined by G*

The relation R = s s * is the largest order which is a sub-relation of both s and s * The total sub-orders, or chains, of the relation R are those subsets of occurrences of partial columns that are consistent. To minimise the number of lost sites, we choose a maximal chain.

More explicitly, let G+ = (V, E+) be the transitive closure TC(G*) of G*. The graph G+ is also a DAG and defines the same partial order on the set of partial columns. The graph G s = (V s , E s ) of the relation R is defined on the vertex set V s by

( u , v ) E s u , v V s , ( u , v ) E + and u s v .

Chains of R correspond to paths in G s . Let g s = (vstart,u1,...,u n , vend) be a path from vstart to vend in G s of maximal length. For all partial columns C C s such that C g s , remove the site (s, j C ) from C. Let C be the set of partial columns obtained after applying this procedure for all sequences s S. The order in which they have been selected does not matter. If we wish to stress the difference between consistent and non-consistent partial columns, we will sometimes refer to the latter as raw partial columns.

Lemma 2. The succession graph SG( C ) of the resulting partial column set is a DAG.

Proof. Every direct transition between occurrences of partial columns in C is encoded as an edge appearing in some longest path g in some graph G s . Therefore, every edge of the succession graph G = S G ( C ) corresponds to a path in the graph G+. Since G+ is a DAG, the graph G°cannot have any cycle.

All current implementations of anchoring options take as input a list of pairs of matching positions. To obtain a set of anchor points from a set C of partial alignment columns, we consider all maximal segments of consecutive pairs of sites (i, p),...,(i, p+k) and (i', p'),..., (i', p' +k) such that every pair of sites (i, p+l) and (i', p' +l),1 ≤ lk, belongs to some partial alignment column C j C .

Results and Discussion

In order to evaluate the effect of introducing the MS4 partial columns in multiple alignments, we have used the reference protein multiple alignment benchmark database BAliBASE (release 3) [21]. As is usually done, we have only considered the core regions to assess the effect of the introduction of the partial columns in the MSA software. In order to do this, we have slightly waylaid DbClustal from its usual function, by including our MS4-based partial columns as anchors points encoded in BALLAST files, as explained in [7]. We have also used the anchoring option of DIALIGN 2 and included the partial columns as library les in T-Coffee.

For each of the reference sets in BAliBASE 3, we have examined and analyzed the performances of the aligners that accept anchors before and after the inclusion of two types of position subsets: (1) raw MS4 partial columns, computed according to section MS4 method (2) consistent MS4 partial columns, as obtained after applying the algorithm described in section Consistent Partial Columns.

The partial columns must be split into segments of pairwise matching positions, and attributed a weight. For a pair of segments of length l we set the weight to 10|l| for ClustalW and Dialign, and a uniform value of 100M for T-Coffee, where M is the number of sequences in the dataset. For each of the obtained alignments, we have computed the sum-of-pairs (SP) and total-column (TC) scores, and compared it to the scores obtained by the aligner alone. On DIALIGN, the results proved disappointing. With T-Coffee, no improvement nor degradation whatsoever was observed in the overwhelming majority of cases: there is a variation on less than 25 datasets over the whole BAliBASE3 (which consisting of 218), and a substantial one on about 5 only. These results are after all not so surprising, since both DIALIGN and T-Coffee already rely on local strategies. We will henceforth focus our discussion on the results obtained with ClustalW 2.0 alone. We omit "MS4" in what follows.

Tables 1 and 2 contain the scores obtained by ClustalW 2.0 with and without our anchors, as well as those obtained by more modern aligners. We have reported the scores obtained for values of smin = 2, 6 and 12, which are somehow representative of the general trend, that we sum up as graphs in Figure 7,8, 9 &10. The consistency algorithm improves in every case the performance of ClustalW, while the partial columns computed by MS4 only improve it for smin = 6 and 12. Although the score improvements of our anchors on ClustalW are substantial, they remain inferior to those obtained by modern aligners.

Table 1 Sum-of-pairs score of ClustalW with anchor points on Balibase 3, compared to other usual aligners
Table 2 Total-Column score of ClustalW with anchor points on Balibase 3, compared to other usual aligners
Figure 7
figure 7

SP Results for raw partial columns. Sum-of-Pairs (SP) score improvements for ClustalW on BAliBASE 3 with raw partial columns. The plot shows the mean score variation Score(with anchors)-Score(without anchors) over all datasets for each reference set of the BAliBASE 3 benchmark (except RV11), against the minimum number smin of sequences where a partial column must be found to be included. The level 0 corresponds to a neutral effect.

Figure 8
figure 8

SP Results for consistent partial columns. Sum-of-Pairs (SP) score improvements for ClustalW on BAliBASE 3 with consistent partial columns.

Figure 9
figure 9

TC Results for raw partial columns. Total Column (TC) score improvements for ClustalW on BAliBASE 3 with raw partial columns.

Figure 10
figure 10

TC Results for consistent partial columns. Total Column (TC) score improvements for ClustalW on BAliBASE 3 with consistent partial columns.

Detecting a larger amount of correct similarities does not necessarily mean that the obtained alignment is better. Indeed, this effect could be obtained at the cost of including also a lot of wrongly aligned positions. To study this issue, we used the multiple alignment comparison tool aln_compare[4] by swapping arguments: usually the call aln_compare ref_al test_al computes among all pairs of aligned residues of the reference alignment ref_al, the proportion of residues which are present in the tested alignment test_al. If the arguments are swapped, the result returned counts the proportion of correct pairs among the core pairs aligned in the test alignment. A similar analysis is valid for the Total-Column score. These measures can be considered as specificity scores. We have reported in Table 3 the specificity scores (for both measures of specificity-SP and TC), obtained by the ClustalW 2.0 alignments alone, and for ClustalW with our consistent partial columns for smin = 6, which appears from Tables 1 and 2 as being the best overall combination.

Table 3 Specificity scores for ClustalW with anchor points on Balibase 3

SP scores

We can observe from Figure 7 that, as a general trend, the inclusion of raw partial columns induces a general degradation of performance for smin < 5, and a global improvement above this threshold (except for RV30). The score degradation for smin < 5 shows that the raw partial columns include inconsistent similarities for these values, which are eliminated by requiring that a column span a minimum number of sequences in order to be considered.

Figure 8 illustrates the effect on the SP scores of introducing consistent partial columns. A perceptible improvement (from 0.5 to 2 points) is then observed, and no degradation of the SP scores for weak values of smin (except for RV12) is to be seen. This indicates that the consistency algorithm manages to suppress inconsistent similarities even when they only concern as few as 2 sequences. More generally, the improvement due to the inclusion of the consistent partial columns is clearer for RV40 and RV50.

This result fits with the expectations, since these two datasets contain respectively large (C- or N-) extensions and large internal deletions. It is well known that supplying local information help global aligners to deal with large indels.

TC scores

Figures 9 and 10 show the variation of TC score with respectively raw and consistent columns. The TC score is much more stringent, since a single mistake in a column as compared to the reference alignment results in a score of 0 for the considered column. As for the SP score, the degradation that can be observed for smin < 5 with raw partial columns disappears as soon as the columns have been filtered by the consistency algorithm, and gives on the contrary a perceptible improvement (with the notable exception of RV40). This means that, although the actual number of correctly aligned pairs does not greatly increase (see Figure 8), the improvement concerns essential columns of the core reference alignment. If the consistent partial columns are able to improve the TC scores, it shows that they can find previously undetected local similarities for a subset of sequences where the similarity was missed and now can be included for all sequences, because the TC score will only raise if a column is aligned correctly in all sequences. The improvement is more perceptible for RV30 and RV50. The dataset RV30 contains highly divergent sequences and RV50 large indels, as we recalled before.

Discussion

It is somehow surprising that we do not get an improvement on the TC score for RV40, since this is the dataset that is used to test large C- and N-terminal insertions. For this set, it often happens that ClustalW does not align correctly any single core column, whereas supplied with our consistent partial columns, it will manage to correct this behaviour, resulting in a great improvement in score. However, the weak mean performance of the partial column anchoring on the TC score for RV40 is essentially due to 2 alignments out of the 49 composing the dataset. For BB40044, ClustalW aligns correctly 84% of the columns, whereas for smin ≤ 13 our anchors introduce mistakes, resulting in a TC 0 score. The same happens with BB40040 for which ClustalW finds 70% of correct columns, and none with our consistent partial columns (except for smin ≥ 19). A closer examination of the alignments shows that, for BB40040, MS4 detects (rightly) a similar region that extends over 18 sequences, but it turns out that for 1 sequence it should not be aligned with the 17 others. The resulting offset of the positions in this last sequence runs whole columns along the core region (see Figure 11). This unexpected phenomenon however only slightly affects the number of aligned pairs, which is consistent with the fact that otherwise the SP score is in the average of the improvements observed on the other reference sets.

Figure 11
figure 11

Screenshot of Jalview visualization of alignment on dataset BB40040. Jalview screenshots of two different regions of the reference multiple alignment of dataset BB40040, featuring our consistent partial columns for smin = 2 shown in colour. The local similarities detected by NLD that are responsible for the 0 TC score are shown as the yellow-green coloured sites enclosed in the red dotted region. This is a (rare) example where a local similarity involving up to 18 sequences turns out to be biologically wrong. The offset on the columns resulting from the wrong alignment of the last sequence is sufficient to induce at least one mistake per column along a large part of the core region.

It is to be noted that on RV50, on the contrary, the inclusion of consistent partial columns always result in an improvement of the TC score, whatever the considered dataset. Here in Figure 12, we show the consistent partial columns on the reference set BB50012, where the TC score jumps from 0 to 44. Notice that the columns appear to be split in two groups, which turn out to correspond to the separation between eukaryotes and prokaryotes. This feature illustrates why the MS4 can be used as an efficient alignment-free classification tool [19].

Figure 12
figure 12

Screenshot of Jalview visualization of reference alignment for dataset BB50012. Jalview screenshot of the consistent partial columns for smin = 3 among one of the core regions of the BAliBASE reference alignment for dataset BB50012. The partial columns (shown in colour) correspond to parts of correct columns in a sufficient amount to correct the overall behaviour of ClustalW, resulting in a TC score of 44 (instead of 0). Notice the clear separation of the partial columns between eukaryotes and prokaryotes.

Finally, the specificity scores reported in Table 3 seem to indicate that the sensitivity score improvements are indeed a result of a larger number of detected similarities that are relevant. Note that the unsatisfactory behaviour of TC on RV40 reflects also on the specificity score. In Table 4, we have reported the times taken on average by the two steps of our anchor selection algorithm. The consistency step has to be repeated for each sequence: this accounts for the higher figures for RV20 and RV30, which consist of more sequences on average than the other datasets. The program used is still a prototype, and has not been optimised for performance; nevertheless, the time required remain reasonable and does not seem to be an obstacle to using this feature on datasets of gene-sized alignable sequences.

Table 4 Time performances for the steps of the consistency algorithm

We have also used both types of partial columns with DIALIGN. However, as mentioned, probably since this aligner is already based on local similarities, we didn't observe any improvements on BAliBASE 3. Further investigations seem to show that MS4 is here to blame. When partial alignment columns are constructed from the pairwise similarities computed by DIALIGN, we have shown in [22] that the consistency algorithm successfully removes inconsistencies, resulting this time in an improvement of performance with DIALIGN 2. This supports the idea that a more refined criterion for selecting the nodes in the partition tree than the one currently implemented in the MS4 method is required to be successfully applied as a local similarity detector that performs well on more modern aligners. At any rate, MS4 seems more adapted to alignment-free classification. According to our experience, the partial columns obtained by MS4 are nevertheless useful for the visual expertise of alignments, for they highlight local homologies (for instance when used with a multiple alignment editor like Jalview), which are easier to visualise than the usual simple substitutions schemes used by these editors.

Conclusions

The introduction of our MS4-based partial columns give therefore encouraging results. The overall influence of their inclusion can be summed up in two principal observations. The introduction of local information results in an improvement of the correctness of ClustalW, as already observed by the authors themselves, who developed DbClustal for this goal. Initially, DbClustal uses local fragments based on BLAST searches (local similarities with sequences stored in generalist protein databanks). The inclusion of user-defined anchor points being also possible, we have in this way been able to assess the improvement of performance that results from the inclusion of these local primary sequence-based similarities, constructed without score matrices or sliding window of predefined length. With the local aligners for which the inclusion of anchor points is possible, the results are not conclusive, especially with DIALIGN, although they happen to have quite a neutral effect on T-Coffee. It is unfortunate that the anchoring option is not featured in any other aligner, especially any other global aligner, to be able to give more insight on the usefulness of the construction presented here.

The improvement obtained for ClustalW is most perceptible for datasets containing sequences of unequal lengths, and the computation of MS4 partial columns seems then justified in view of the gain in accuracy they provide. In other respects, the computation of consistent partial columns can help the eye-expertise of multiple alignments, for the number of obtained position subsets is quite reasonable, and, as the TC score performance seems to indicate, their visualization allows to correct whole columns in the alignment, since they appear to correspond to conserved zones in the considered sequences (like in Figure 12 for instance). We have moreover introduced an algorithmic approach that can be further explored. The consistency algorithm can be used with other local similarities as input, as already tested with success on DIALIGN [22]. These results encourage us to improve our approach on several points. In particular, the mere filtering of edges of the succession graph by their weight to get a DAG in section Getting a Directed Acyclic Graph is overly simplistic (although effective). We are currently exploring more refined ways of getting a DAG, in order to reduce the number of erased edges. Another interesting feature would consist in splitting the contradicting partial columns into subsets of similarly behaved sites. These algorithmic improvements could then fit in a general tool for making local similarities consistent.

References

  1. Bailey TL, Elkan C: Fitting a mixture model by expectation maximization to discover motifs in biopolymers. Proceedings of the Second International Conference on Intelligent Systems for Molecular Biology 1994, 28–36.

    Google Scholar 

  2. Smith RF, Smith TF: Pattern-Induced Multi-sequence Alignment (PIMA) algorithm employing secondary structure-dependent gap penalties for comparitive protein modelling. Protein Engineering 1992, 5: 35–41. 10.1093/protein/5.1.35

    Article  CAS  PubMed  Google Scholar 

  3. Subramanian AR, Kaufmann M, Morgenstern B: DIALIGN-TX: greedy and progressive approaches for the segment-based multiple sequence alignment. Algorithms for Molecular Biology 2008, 3: 6. 10.1186/1748-7188-3-6

    Article  PubMed  PubMed Central  Google Scholar 

  4. Notredame C, Higgins D, Heringa J: T-Coffee: a novel algorithm for multiple sequence alignment. J Mol Biol 2000, 302: 205–217. 10.1006/jmbi.2000.4042

    Article  CAS  PubMed  Google Scholar 

  5. Edgar R: MUSCLE: Multiple sequence alignment with high score accuracy and high throughput. Nuc Acids Res 2004, 32: 1792–1797. 10.1093/nar/gkh340

    Article  CAS  Google Scholar 

  6. Katoh K, Misawa K, Kuma K, Miyata T: MAFFT: a novel method for rapid multiple sequence alignment based on fast Fourier transform. Nuc Acids Research 2002, 30: 3059–3066. 10.1093/nar/gkf436

    Article  CAS  Google Scholar 

  7. Thompson JD, Plewniak F, Thierry JC, Poch O: DbClustal: rapid and reliable global multiple alignments of protein sequences detected by database searches. Nucleic Acids Research 2000, 28: 2919–2926. 10.1093/nar/28.15.2919

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  8. Kemena K, Notredame C: Upcoming challenges for multiple sequence alignment methods in the high-throughput era. Bioinformatics 2009, 25(19):2455–2465. 10.1093/bioinformatics/btp452

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  9. Notredame C: Recent evolutions of multiple sequence alignment algorithms. PLoS Comput Biol 2007., 3(8): 10.1371/journal.pcbi.0030123

  10. Edgar RC, Batzoglou S: Multiple Sequence Alignment. Current Opinion in Structural Biology 2006, 16: 368–373. 10.1016/j.sbi.2006.04.004

    Article  CAS  PubMed  Google Scholar 

  11. Morgenstern B, Prohaska SJ, Pöhler D, Stadler PF: Multiple sequence alignment with user-defined anchor points. Algorithms for Molecular Biology 2006, 1: 6. 10.1186/1748-7188-1-6

    Article  PubMed  PubMed Central  Google Scholar 

  12. Morgenstern B, Subramanian A, Hiran S, Steinkamp R, Meinicke P, Corel E: DIALIGN-TX and multiple protein alignment using secondary structure information at GOBICS. Nucl Acids Res 2010, 38: W19-W22. 10.1093/nar/gkq442

    Article  PubMed  PubMed Central  Google Scholar 

  13. Morgenstern B, Werner N, Prohaska SJ, Schneider RSI, Subramanian AR, Stadler PF, Weyer-Menkhoff J: Multiple sequence alignment with user-defined constraints at GOBICS. Bioinformatics 2005, 21: 1271–1273. 10.1093/bioinformatics/bti142

    Article  CAS  PubMed  Google Scholar 

  14. Larkin MA, Blackshields G, P BN, Chenna R, McGettigan PA, McWilliam H, Valentin F, Wallace IM, Wilm A, Lopez R, Thompson JD, Gibson TJ, Higgins DG: ClustalW and ClustalX version 2.0. Bioinformatics 2007, 23(21):2947–48. 10.1093/bioinformatics/btm404

    Article  CAS  PubMed  Google Scholar 

  15. Aaron CE Darling FRB Bob Mau, Perna NT: Mauve: multiple alignment of conserved genomic sequence with rearrangements. Genome Research 2004, 14(7):1394–1403. 10.1101/gr.2289704

    Article  Google Scholar 

  16. Höhl M, Kurtz S, Ohlebusch E: Efficient multiple genome alignment. Bioinformatics 2002, 18: 312S-320S.

    Article  Google Scholar 

  17. Kucherov G, Noé L, Roytberg M: A unifying framework for seed sensitivity and its application to subset seeds. J Bioinform Comput Biol 2006, 4(2):553–569. 10.1142/S0219720006001977

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  18. Didier G, Laprevotte I, Pupin M, Hénaut A: Local Decoding of sequences and alignment-free comparison. J Computational Biology 2006, 13: 1465–1476. 10.1089/cmb.2006.13.1465

    Article  CAS  Google Scholar 

  19. Corel E, Pitschi F, Laprevotte I, Grasseau G, Didier G, Devauchelle C: MS4 - Multi-Scale Selector of Sequence Signatures: An alignment-free method for the classification of biological sequences. BMC Bioinformatics 2010, 11: 406. 10.1186/1471-2105-11-406

    Article  PubMed  PubMed Central  Google Scholar 

  20. Morgenstern B, Dress A, Werner T: Multiple DNA and protein sequence alignment based on segment-to-segment comparison. Proc Natl Acad Sci USA 1996, 93: 12098–12103. 10.1073/pnas.93.22.12098

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  21. Thompson JD, Koehl P, Ripp R, Poch O: BAliBASE 3.0: latest developments of the multiple sequence alignment benchmark. Proteins: Structure, Function, and Bioinformatics 2005, 61: 127–136. 10.1002/prot.20527

    Article  CAS  Google Scholar 

  22. Corel E, Pitschi F, Morgenstern B: A min-cut algorithm for the consistency problem in multiple sequence alignment. Bioinformatics 2010, 26(8):1015–1021. 10.1093/bioinformatics/btq082

    Article  CAS  PubMed  Google Scholar 

Download references

Acknowledgements

We wish to thank M. Hoebeke, M. Baudry and G. Grasseau for assistance with the code, B. Morgenstern for guidance on the assessment of the anchor performance, R. Steinkamp for assistance in producing the results, and K. Hoff for some valuable help with the R package. EC acknowledges partial financial support from C.N.R.S., University of Evry-Val-d'Essonne (France), and DFG Project MO 1048/6-1. FP acknowledges support from PICB (Max-Planck-Gesellschaft and the Chinese Academy of Sciences).

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Eduardo Corel.

Additional information

Authors' contributions

EC and FP have developed the methods and conducted the tests, FP and CD have performed the expertise, and all three authors have drafted, read and approved 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

Pitschi, F., Devauchelle, C. & Corel, E. Automatic detection of anchor points for multiple sequence alignment. BMC Bioinformatics 11, 445 (2010). https://doi.org/10.1186/1471-2105-11-445

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-11-445

Keywords