Skip to main content

Linear predictive coding representation of correlated mutation for protein sequence alignment

Abstract

Background

Although both conservation and correlated mutation (CM) are important information reflecting the different sorts of context in multiple sequence alignment, most of alignment methods use sequence profiles that only represent conservation. There is no general way to represent correlated mutation and incorporate it with sequence alignment yet.

Methods

We develop a novel method, CM profile, to represent correlated mutation as the spectral feature derived by using linear predictive coding where correlated mutations among different positions are represented by a fixed number of values. We combine CM profile with conventional sequence profile to improve alignment quality.

Results

For distantly related protein pairs, using CM profile improves the profile-profile alignment with or without predicted secondary structure. Especially, at superfamily level, combining CM profile with sequence profile improves profile-profile alignment by 9.5% while predicted secondary structure does by 6.0%. More significantly, using both of them improves profile-profile alignment by 13.9%. We also exemplify the effectiveness of CM profile by demonstrating that the resulting alignment preserves share coevolution and contacts.

Conclusions

In this work, we introduce a novel method, CM profile, which represents correlated mutation information as paralleled form, and apply it to the protein sequence alignment problem. When combined with conventional sequence profile, CM profile improves alignment quality significantly better than predicted secondary structure information, which should be beneficial for target-template alignment in protein structure prediction. Because of the generality of CM profile, it can be used for other bioinformatics applications in the same way of using sequence profile.

Background

Currently, the comparison of multiple sequence alignments (MSAs) is based on aligning the sequence profiles that represent conservation at specific positions. However, the alignment quality of profile-profile alignment becomes unreliable as the sequence identity of seed sequences becomes low [1]. Even though using predicted secondary structure as additional information slightly improves profile-profile alignment, it is still unsatisfactory since the most protein secondary structure prediction methods are based on sequence profile. In this situation, using correlated mutation information originated from coevolution of two or more residue positions would be informative.

Constructing alignments with high quality is important in comparative modeling, in which target-template alignment is a crucial step together with template selection, but the sequence alignments based solely on statistical amino acid matches become undependable at low sequence identity. Particularly, below 20% sequence identity referred to as midnight zone, using sequence alignment without structural evidence can be problematic. Practically, it is found that many proteins with similar structure have low sequence identity [2], and, in CASP7, about half of the targets have the single best templates with <20% sequence identity [3]. This means that the reliability of alignment in the midnight zone is a bottleneck for protein structure prediction, and therefore its improvement is strongly desirable.

Correlated mutation is estimated in various ways. McBASC algorithm [4] calculates the correlation of amino acid substitutions at individual positions. SCA algorithm and its variants [57] measure the relative amino acid frequencies observed after perturbing the MSA. Mutual information [8, 9] is used for estimating correlated mutation. Recently, it is also found that normalizing mutual information improves the determination of coevolving residues [10, 11]. In spite of these efforts, the application of correlated mutation is restricted mainly to inter-residue contact prediction [12, 13] and functional site prediction [5]. Moreover, it has not been utilized for the purpose of sequence alignment, the most basic procedure in sequence analysis, and there is no universal method for comparing correlated mutation patterns of different proteins.

In this article, we introduce a novel method, CM profile, which represents correlated mutation based on signal processing technique called linear predictive coding (LPC) [14], and apply it to the protein sequence alignment problem. The results show that the employment of correlated mutation improves alignment quality consistently at different SCOP levels and sequence identities. The analysis on a few examples shows that the use of CM profile makes alignments preserve correlated mutation and the residues with common contacts are aligned with high scores.

Methods

Data

We prepare protein pairs which are non-redundant and distantly related with each other. The data are derived from SCOP [15] version 1.69 with <35% sequence identity downloaded from Astral compendium [16]. 4253 domains whose MSA is composed of less than 100 sequences are omitted because correlated mutation analysis using MSA with a small number of sequences can be unreliable and include much noise, and 2501 domains remain. To make pairs of distantly related homologs, we select superfamilies with at least 10 domains, and pair the domains with each other in each superfamily. The selected domains are composed of 1105 domains of 50 folds, 60 superfamilies, and 341 families. For parameter selection we use 388 pairs consisting of 200 domains randomly chosen, and for testing use 9118 pairs consisting of the remaining 905 domains.

The frequency matrices and the position-specific score matrices (PSSMs) representing sequence profiles are automatically generated by running PSI-BLAST [17] version 2.2.19 against NCBI nr database with “–j 3 –e 0.001 –h 0.001” options. The MSAs used for constructing CM profiles are also generated by running PSI-BLAST with the same option, and then thinned by removing the sequences covering less than 50% of the seed sequence and clustering the remaining sequences at 65% sequence identity.

Representation of correlated mutation

If we have a sequence of length n, we build, at each position, 400 correlated mutation vectors consisting of n correlated mutation scores with other positions for one of 400 possible amino acids pairs. The correlated mutation vector for amino acid pair a, b at position i, m(a i , b) = [m(a i , b1) m(a i , b2) … m(a i , b n )], consists of n log-odds scores defined as

,

where f(a i , b j ) is the joint frequency of amino acid a at position i and amino acid b at position j, f(a i ) is the marginal frequency calculated as , and f(b j ) is the marginal frequency calculated as . The correlated mutation score m(a i , b j ) of amino acid a at position i and amino acid b at position j has a positive value if they have positive correlation with each other, a negative value if they have negative correlation, or zero if they evolve independently. Because a small number of observations can make the joint frequency very noisy, we apply low number correction [10], thereby defining the joint frequency as

,

where N(a i , b j ) is the number of observations of amino acid a at position i and amino acid b at position j in the MSA, and .

Since the dimension of correlated mutation vector is variable depending on sequence length, the correlated mutation vectors of distinct sequences are not paralleled. Therefore, we extract the spectral features, known as LPC cepstral coefficients, to represent the correlated mutation vector. LPC cepstral coefficients have been used for comparing DNA and protein sequences [18].

The basic assumption of LPC model is that the present sample at time n, s(n), can be calculated as a linear combination of the past p samples. The approximation is expressed as [14]

,

where the coefficients {a k } are constants called as LPC coefficients, which are determined by minimizing the sum of squared error

.

To solve this equation for the predictor coefficients {a k }, we differentiate E with respect to each a k and set the result to zero,

The result gives a set of p linear equations

,

where r(i), known as the autocorrelation function of s(n), is defined as

,

and symmetric, i.e. r(– k) = r(k). The linear equations can be expressed in matrix form as

.

Since the p x p matrix of autocorrelation values is a Toeplitz matrix that is symmetric and all the diagonal elements are equal, the solution of the linear equations can be calculated recursively and very efficiently through Levinson-Durbin algorithm without relatively expensive computation such as matrix inversion. If the linear equation is solved, more advanced spectral feature called as LPC cepstral coefficients can be derived from the LPC coefficients by the following recursion.

.

By using the LPC analysis process described above, we transform a correlated mutation vector to the CM profile consisting of the LPC cepstral coefficients. Since the cepstral coefficients are decaying, we use only the first L coefficients excluding c0. Additionally, we normalize CM profiles of a protein by fitting the mean and variance into zero and one, respectively, to weight them equally regardless of the orders. We obtain consequently a L-dimensional CM profile, c(a i , b), that represents the correlated mutations between amino acid a at position i and amino acid b at other positions. In other word, all the correlated mutation between position i and other positions are represented as 400 x L coefficients.

Alignment

To compare sequences, we define the alignment score between the position i of a protein and the position j of another protein as follows,

,

where w mut , w cor , and w sec denote the weights, and S mut (i, j), S cor (i, j), and S sec (i, j) denote the similarity scores of sequence profiles, CM profiles, and secondary structure predictions, respectively, between the positions i and j. S mut (i, j) is the sequence profile score defined as

,

where q(a i ), q(a j ), t(a i ), and t(a j ) are the frequencies and the PSSM scores of amino acid a at position i and j respectively. S cor (i, j) is the CM profile score defined as

,

Where d(c(a i , b), c(a j , b)) is the Euclidean distance between CM profile c(a i , b) at position i and CM profile c(a j , b) at position j, d0 is the threshold, and α is the scaling factor. The S cor (i, j) gives a positive score in case that the distance between CM profiles is less than d0, and a negative score in case that the distance is more than d0. S sec (i, j) is the secondary structure prediction score given as 1 if the predicted secondary structures at position i and j are identical, and 0 otherwise. We use PSIPRED [19] to predict secondary structures. Based on the score matrix consisting of S(i, j) for all i and j, we perform the Needleman-Wunsch algorithm with affine gap costs and baseline to find the optimal alignment.

Assessment and parameter selection

We assess the alignment quality by measuring the average MaxSub score [20] of models derived from sequence alignments. The model is generated by directly copying the coordinates of C-alpha atoms based on the sequence alignment, and the MaxSub score of the model is computed with default options. The MaxSub score identifies the largest subset of C-alpha atoms of a model that superimpose well over the experimental structure, and provides a single normalized score in the range of 0 to 1. The MaxSub score 0 indicates a completely wrong model, and 1 indicates a perfect model. The parameters of each method are selected by simulated annealing (SA) that uses the average MaxSub score of training set as the objective function.

Results

The selected parameters by simulated annealing are listed in Table 1. For p and L in LPC analysis, 6 and 9 are used, respectively. For α in CM profile score calculation, 0.025 is used. Combining CM profile, sequence profile, and secondary structure prediction (CMPA_PPA_SS) improves the conventional methods, the profile-profile alignment without and with secondary structure prediction (PPA and PPA_SS), by 7.6% and 4.7%, respectively. In addition, combining CM profile only with profile-profile alignment (CMPA_PPA) improves the PPA by 6.2%, which is 2.3 times more increase than PPA_SS which improves PPA by 2.7%. However, using CM profile solely performs poorly; therefore we will exclude it in the following test.

Table 1 Selected parameters for the different combination of scoring terms.

As shown in Table 2, overall, CMPA_PPA_SS and CMPA_PPA significantly outperform the original methods, PPA_SS and PPA that do not use correlated mutation information by 4.1% (p-value 2.1e-252) and 5.0% (p-value 8.2e-232), respectively. The p-values are calculated by Wilcoxon signed rank test. At family level, using CM profile shows almost the same improvement that can be achieved by using secondary structure prediction. However, it is seen that CMPA_PPA_SS shows 2.2 times more improvement than PPA_SS and CMPA_PPA. A dramatic result can be seen at superfamily level where the average sequence identity is 11.5%, less than 17.4% at family level, and 96% of the protein pairs have sequence identity less than 20%. CMPA_PPA_SS and CMPA_PPA improve PPA by 13.9% and 9.5%, respectively, while PPA_SS does by 6.0%. This indicates that the use of correlated mutation is much more effective for difficult cases, where the sequence identity is very low, and the following analysis also consistently shows more effective improvements below 20% sequence identity. Moreover, it also implies that both the information can be used complementarily and many of the current alignment methods using secondary structure prediction can be improved by incorporating correlated mutation information. According to a previous study using data set derived from SCOP with <75% sequence identity, the sophisticated methods including the structural state assignment based on self-organizing map and the scoring function based on artificial neural network, have performed best and shown the average MaxSub score 0.22 at superfamily level [21]. In their work, the other methods have shown the average MaxSub scores of 0.20-0.22. The MaxSub scores of PPA and PPA_SS of this work are also in that range. Although the results cannot be directly compared, it is reasonable to expect that CMPA_PPA_SS should outperform the previous method on their test set as well.

Table 2 Average MaxSub scores of test set by different methods

Figure 1 shows the average MaxSub scores of various methods at family level as a function of sequence identity. Below 20% sequence identity, CMPA_PPA_SS consistently outperforms the others and improves PPA by 3.2%. However, all the methods perform almost identically above 20% sequence identity. A reason for this result is that closely related proteins possibly share more common or similar sequences in their MSAs and yield similar sequence profiles. Particularly, the key residues strongly conserved are easily aligned and guide the global alignment optimally. According to a previous study [22], it has been demonstrated that the model quality generated by comparative modeling is related with the distribution of the sequence identity between the sequences comprised in the MSAs. Moreover, it is more probable that MSAs share more common or similar sequences, here, at family level where evolutionary distance is much closer than at superfamily level. Thus, in case where there is close evolutionary relationship and high sequence identity, sequence profiles seem to be sufficiently informative and combining correlated mutation or secondary structure prediction does not improve alignment quality.

Figure 1
figure 1

Average MaxSub scores of various methods, measured by different sequence identities at family level Average MaxSub scores above 25% sequence idenitty are not shown.

As shown in Figure 2, CMPA_PPA_SS and CMPA_PPA outperform the conventional methods, PPA and PPA_SS, consistently, regardless of sequence identity at superfamily level. Similarly at family level, alignment quality deteriorates below 20% sequence identity, and the average MaxSub score of PPA does not exceed 0.19 below 15% sequence identity. Although CMPA_PPA_SS also shows a decline below 20% sequence identity, it significantly improves PPA and PPA_SS by 18.4% and 12.5%, respectively, in the range of 0-10% sequence identity, and by 13.0% and 8.9%, respectively, in the range of 10-20% sequence identity.

Figure 2
figure 2

Average MaxSub scores of various methods, measured by different sequence identities at superfamily level Average MaxSub scores above 25% sequence idenitty are not shown.

This result has important implications in several aspects. It is well known that profile-profile alignment is improved most by using secondary structure prediction [1, 23] and numerous state-of-the-art methods hence incorporate secondary structure prediction in their alignment scheme [21, 2426]. Also in our results, profile-profile alignment is consistently outperformed by combining secondary structure prediction. However, it is more significantly improved by combining correlated mutation (CMPA_PPA), and the best performance is achieved by combining correlated mutation and secondary structure prediction together (CMPA_PPA_SS). Taking this into account, the state-of-the-art methods can be improved significantly by incorporating correlated mutation information.

Another aspect is related with the reliability of alignment in the midnight zone. An alignment becomes less reliable when the sequence identity lies in the midnight zone [1]. Since using correlated mutation is more advantageous for the proteins pairs with low sequence identity and CM profile is easily combined with conventional methods, the coverage of current alignment methods in the midnight zone can be increased by using CM profile. The most important implication is related with the template-based protein structure prediction. From two other aspects described above, it is obvious that using correlated mutation remarkably improves current alignment methods for the sequences with less than 20% sequence identity. This is beneficial to target-template alignment because most of promising templates sharing the same structure have relatively low sequence identity [2]. Practically, according to the recent analysis for the template-based modeling targets of CASP7 [3], almost half of the targets, specifically 50 among 108 targets, have the best templates with similar structure but low sequence identity less than 20%, and a virtual predictor based on the best templates overall outperforms all other groups by far. The effectiveness of CM profile will carry out more reliable target-template alignments and subsequently provide better models for difficult target-template pairs, thereby increasing the confidence for template-based structure prediction.

To assess the performance of CM profile for domains which have less MSA sequences than 100, we build two additional test sets from the omitted domains. The first test set is built from the domains with 50-99 MSA sequences, and consists of 527 domains of 30 folds, 31 superfamilies, and 142 families, deriving 5586 pairs. The second test set is built from the domains with 1-49 MSA sequences, and consists of 752 domains of 31 folds, 37 superfamilies, and 225 families, deriving 9676 pairs.

When testing with the domains whose MSA is composed of 50-99 sequences, using CM profile improves PPA and PPA_SS by 4.3% and 3.8%, respectively, as shown in Table 3. Also, when testing with the domains whose MSA is composed of 1-49 sequences, using CM profile improves PPA and PPA_SS by 2.4% and 3.5%, respectively, as shown in Table 4. Although the improvement rate becomes small for the domains with less MSA sequences, correlated mutation is still valuable as additional information for sequence alignment. Moreover, combining profile-profile alignment with both correlated mutation and secondary structure prediction outperforms the others significantly, convincing that both the information can complement each other. However, just as the quality of profile-profile alignment decrease when the amount of sequences in MSA is not sufficient, the performance of CM profile seems to decrease likewise.

Table 3 Average MaxSub scores of test set with 50-99 MSA sequences by different methods
Table 4 Average MaxSub scores of test set with 1-49 MSA sequences by different methods

Discussion

The reason for the effectiveness of CM profile is related with the correlation between coevolution and contact. It has been shown that the residues important for protein function are not only conserved but also coevolved with other inter-related residues [12, 27]. This fact has been exploited to infer the structural factor such as inter-residue contacts [13] and to evaluate the correctness of de novo model [28]. Recently, it has been also shown that key residues can be identified by analyzing residue-residue coevolution network [29]. In the aspect of alignment, contact-mutation matrices derived from structural information have been used for improving alignment quality [30]. CM profile utilizes correlated mutation information much more globally and progressively, implying all the correlated mutation of possible residue pairs. This optimizes alignment to match multiple contacting residue pairs, while the previous studies only consider at most two residue pairs, thereby improving alignment quality noticeably.

In the following, we exemplify that combining CM profile generates the alignment reflecting correlation mutation, and the aligned residues with high CM profile score are related with common contacts. As listed in Table 5, the proteins pairs are chosen from SCOP class a, b, c, and d, and share the same superfamily but different family.

Table 5 Protein pairs with the MaxSub scores of various methods

If the inter-related residues of a protein are aligned with the comparable residues of other protein, the correlated mutation information should be kept mutually in the resulted alignment. To demonstrate this, we investigate the correlation coefficient between correlated mutations of proteins. As correlated mutation measure, we calculate mutual information with low number correction [10], and the residues not aligned are excluded. The resulting correlated mutation scores for aligned residues are shown as matrix form in Figure 3. Although the matrices do not look completely symmetric, they have positive correlation coefficients, (a) 0.1208, (b) 0.1952, (c) 0.1131, and (d) 0.2118, respectively. These values are small, but all the correlations are statistically significant (p-value < 2.2e-308). In other words, the present method constructs an alignment that preserves coevolution.

Figure 3
figure 3

Correlated mutation matrices of the proteins listed in Table 5 The upper-lower triangular matrix represents mutual information between the residues of the respective protein, (a) d1xd7a_-d1ldja1, (b) d1mvea_-d1u1ea_, (c) d1uwva2-d1p1ca_, and (d) d1lrza3-d1tiqa_, respectively. Note that the intensity and the size of image are scaled differently, regarding to the distribution of mutual information and the alignment length.

As shown in Figure 4, the residues with high CM profile scores are located spatially close with each other even though they are distant on sequence. On the other hand, the residues with high sequence profile scores are dispersed or not superimposed. This shows that CM profile reflects the structural aspect with regard to residue-residue contact in alignment and the common contacts of aligned proteins are ranked highly by CM profile score. This will be very useful in template-based protein structure prediction.

Figure 4
figure 4

High scoring residue pairs of the examples listed in Table 5 Each pair of proteins, (a) d1xd7a_-d1ldja1, (b) d1mvea_-d1u1ea_, (c) d1uwva2-d1p1ca_, and (d) d1lrza3-d1tiqa_ is superimposed based on the CMPA_PPA alignment, and coded as cyan-yellow, respectively. Top-10 residue pairs ranked by sequence profile score and CM profile score are shown as spheres coded as red and blue, respectively, but the residue pairs ranked by both are coded as green.

Due to the generality of CM profile, it can be successfully exploited for various bioinformatics applications, particularly with machine learning approaches. Our approach is position-specific and consists of a fixed number of values, which allows CM profile to be manipulated in the same way that we use sequence profile. Thus, CM profile can be easily adopted into the current methodology without serious modification to complement them. Moreover, it should be noted that our CM profile is not optimally generated because sequence profiles are automatically generated by PSI-BLAST [17]. The present method can be improved significantly, as the accuracy of correlated mutation is increased through various corrections and noise reductions [10, 11].

Conclusions

We develop a novel method to represent correlated mutation as the spectral features derived from LPC analysis, and we also apply it to sequence alignment of distantly related proteins. When combined with conventional sequence profile, CM profile improves alignment quality significantly better than predicted secondary structure information. Especially, the dramatic improvement in the midnight zone is observed, which should be beneficial for target-template alignment in protein structure prediction. Finally, because the methodology that we have developed in this work can be generalized to many interesting areas of bioinformatics, we expect that CM profile can be applicable to other bioinformatics applications equally well.

References

  1. Elofsson A: A study on protein sequence alignment quality. Proteins 2002, 46(3):330–339. 10.1002/prot.10043

    Article  CAS  PubMed  Google Scholar 

  2. Yang AS, Honig B: An integrated approach to the analysis and modeling of protein sequences and structures. II. On the relationship between sequence and structural similarity for proteins that are not obviously related in sequence. J Mol Biol 2000, 301(3):679–689. 10.1006/jmbi.2000.3974

    Article  CAS  PubMed  Google Scholar 

  3. Kopp J, Bordoli L, Battey JN, Kiefer F, Schwede T: Assessment of CASP7 predictions for template-based modeling targets. Proteins 2007, 69(Suppl 8):38–56. 10.1002/prot.21753

    Article  CAS  PubMed  Google Scholar 

  4. Olmea O, Rost B, Valencia A: Effective use of sequence correlation and conservation in fold recognition. J Mol Biol 1999, 293(5):1221–1239. 10.1006/jmbi.1999.3208

    Article  CAS  PubMed  Google Scholar 

  5. Lockless SW, Ranganathan R: Evolutionarily conserved pathways of energetic connectivity in protein families. Science 1999, 286(5438):295–299. 10.1126/science.286.5438.295

    Article  CAS  PubMed  Google Scholar 

  6. Süel GM, Lockless SW, Wall MA, Ranganathan R: Evolutionarily conserved networks of residues mediate allosteric communication in proteins. Nat Struct Biol 2003, 10(1):59–69. 10.1038/nsb881

    Article  PubMed  Google Scholar 

  7. Dekker JP, Fodor A, Aldrich RW, Yellen G: A perturbation-based method for calculating explicit likelihood of evolutionary co-variance in multiple sequence alignments. Bioinformatics 2004, 20(10):1565–1572. 10.1093/bioinformatics/bth128

    Article  CAS  PubMed  Google Scholar 

  8. Atchley WR, Wollenberg KR, Fitch WM, Terhalle W, Dress AW: Correlations among amino acid sites in bHLH protein domains: an information theoretic analysis. Mol Biol Evol 2000, 17(1):164–178.

    Article  CAS  PubMed  Google Scholar 

  9. Tillier ER, Lui TW: Using multiple interdependency to separate functional from phylogenetic correlations in protein alignments. Bioinformatics 2003, 19(6):750–755. 10.1093/bioinformatics/btg072

    Article  CAS  PubMed  Google Scholar 

  10. Buslje CM, Santos J, Delfino JM, Nielsen M: Correction for phylogeny, small number of observations and data redundancy improves the identification of coevolving amino acid pairs using mutual information. Bioinformatics 2009, 25(9):1125–1131. 10.1093/bioinformatics/btp135

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  11. Dunn SD, Wahl LM, Gloor GB: Mutual information without the influence of phylogeny or entropy dramatically improves residue contact prediction. Bioinformatics 2008, 24(3):333–340. 10.1093/bioinformatics/btm604

    Article  CAS  PubMed  Google Scholar 

  12. Göbel U, Sander C, Schneider R, Valencia A: Correlated mutations and residue contacts in proteins. Proteins 1994, 18(4):309–317. 10.1002/prot.340180402

    Article  PubMed  Google Scholar 

  13. Shackelford G, Karplus K: Contact prediction using mutual information and neural nets. Proteins 2007, 69(Suppl 8):159–164. 10.1002/prot.21791

    Article  CAS  PubMed  Google Scholar 

  14. Rabiner LR, Juang BH: Fundamentals of speech recognition. Englewood Cliffs, N.J.: PTR Prentice Hall; 1993.

    Google Scholar 

  15. Murzin AG, Brenner SE, Hubbard T, Chothia C: SCOP: a structural classification of proteins database for the investigation of sequences and structures. J Mol Biol 1995, 247(4):536–540.

    CAS  PubMed  Google Scholar 

  16. Chandonia JM, Hon G, Walker NS, Lo Conte L, Koehl P, Levitt M, Brenner SE: The ASTRAL Compendium in 2004. Nucleic Acids Res 2004, 32(Database issue):D189–192. 10.1093/nar/gkh034

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  17. Altschul SF, Madden TL, Schäffer AA, Zhang J, Zhang Z, Miller W, Lipman DJ: Gapped BLAST and PSI-BLAST: a new generation of protein database search programs. Nucleic Acids Res 1997, 25(17):3389–3402. 10.1093/nar/25.17.3389

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  18. Pham T: Spectral distortion measures for biological sequence comparisons and database searching. Pattern Recognition 2007, 40(2):516–529. 10.1016/j.patcog.2006.02.026

    Article  Google Scholar 

  19. Jones DT: Protein secondary structure prediction based on position-specific scoring matrices. J Mol Biol 1999, 292(2):195–202. 10.1006/jmbi.1999.3091

    Article  CAS  PubMed  Google Scholar 

  20. Siew N, Elofsson A, Rychlewski L, Fischer D: MaxSub: an automated measure for the assessment of protein structure prediction quality. Bioinformatics 2000, 16(9):776–785. 10.1093/bioinformatics/16.9.776

    Article  CAS  PubMed  Google Scholar 

  21. Ohlson T, Aggarwal V, Elofsson A, MacCallum RM: Improved alignment quality by combining evolutionary information, predicted secondary structure and self-organizing maps. BMC bioinformatics 2006, 7: 357. 10.1186/1471-2105-7-357

    Article  PubMed Central  PubMed  Google Scholar 

  22. Cozzetto D, Tramontano A: Relationship between multiple sequence alignments and quality of protein comparative models. Proteins 2005, 58(1):151–157. 10.1002/prot.20284

    Article  CAS  PubMed  Google Scholar 

  23. Qi Y, Sadreyev RI, Wang Y, Kim BH, Grishin NV: A comprehensive system for evaluation of remote sequence similarity detection. BMC bioinformatics 2007, 8: 314. 10.1186/1471-2105-8-314

    Article  PubMed Central  PubMed  Google Scholar 

  24. Söding J: Protein homology detection by HMM-HMM comparison. Bioinformatics 2005, 21(7):951–960. 10.1093/bioinformatics/bti125

    Article  PubMed  Google Scholar 

  25. Lee M, Jeong C, Kim D: Predicting and improving the protein sequence alignment quality by support vector regression. BMC bioinformatics 2007, 8: 471. 10.1186/1471-2105-8-471

    Article  PubMed Central  PubMed  Google Scholar 

  26. Wu S, Zhang Y: MUSTER: Improving protein sequence profile-profile alignments by using multiple sources of structure information. Proteins 2008, 72(2):547–556. 10.1002/prot.21945

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  27. Neher E: How frequent are correlated changes in families of protein sequences? Proc Natl Acad Sci USA 1994, 91(1):98–102. 10.1073/pnas.91.1.98

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  28. Bartlett GJ, Taylor WR: Using scores derived from statistical coupling analysis to distinguish correct and incorrect folds in de-novo protein structure prediction. Proteins 2008, 71(2):950–959. 10.1002/prot.21779

    Article  CAS  PubMed  Google Scholar 

  29. Lee BC, Park K, Kim D: Analysis of the residue-residue coevolution network and the functionally important residues in proteins. Proteins 2008, 72(3):863–872. 10.1002/prot.21972

    Article  CAS  PubMed  Google Scholar 

  30. Kleinjung J, Romein J, Lin K, Heringa J: Contact-based sequence alignment. Nucleic Acids Res 2004, 32(8):2464–2473. 10.1093/nar/gkh566

    Article  PubMed Central  CAS  PubMed  Google Scholar 

Download references

Acknowledgements

This work was supported by the Korea Institute of Science and Technology Information Supercomputing Center.

This article has been published as part of BMC Bioinformatics Volume 11 Supplement 2, 2010: Third International Workshop on Data and Text Mining in Bioinformatics (DTMBio) 2009. The full contents of the supplement are available online at http://0-www-biomedcentral-com.brum.beds.ac.uk/1471-2105/11?issue=S2.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Dongsup Kim.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors' contributions

CSJ designed the study, implemented the methods, performed the experiments and the result analysis, and drafted the manuscript. DK conceived of the study, participated in its design and coordination, and helped to draft the manuscript. All authors read and approved the final manuscript.

Rights and permissions

This article is published under license to BioMed Central Ltd. This is an open access article distributed under the terms of the Creative Commons Attribution License (http://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

Jeong, Cs., Kim, D. Linear predictive coding representation of correlated mutation for protein sequence alignment. BMC Bioinformatics 11 (Suppl 2), S2 (2010). https://0-doi-org.brum.beds.ac.uk/10.1186/1471-2105-11-S2-S2

Download citation

  • Published:

  • DOI: https://0-doi-org.brum.beds.ac.uk/10.1186/1471-2105-11-S2-S2

Keywords