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

Pathological rate matrices: from primates to pathogens

Abstract

Background

Continuous-time Markov models allow flexible, parametrically succinct descriptions of sequence divergence. Non-reversible forms of these models are more biologically realistic but are challenging to develop. The instantaneous rate matrices defined for these models are typically transformed into substitution probability matrices using a matrix exponentiation algorithm that employs eigendecomposition, but this algorithm has characteristic vulnerabilities that lead to significant errors when a rate matrix possesses certain 'pathological' properties. Here we tested whether pathological rate matrices exist in nature, and consider the suitability of different algorithms to their computation.

Results

We used concatenated protein coding gene alignments from microbial genomes, primate genomes and independent intron alignments from primate genomes. The Taylor series expansion and eigendecomposition matrix exponentiation algorithms were compared to the less widely employed, but more robust, Padé with scaling and squaring algorithm for nucleotide, dinucleotide, codon and trinucleotide rate matrices. Pathological dinucleotide and trinucleotide matrices were evident in the microbial data set, affecting the eigendecomposition and Taylor algorithms respectively. Even using a conservative estimate of matrix error (occurrence of an invalid probability), both Taylor and eigendecomposition algorithms exhibited substantial error rates: ~100% of all exonic trinucleotide matrices were pathological to the Taylor algorithm while ~10% of codon positions 1 and 2 dinucleotide matrices and intronic trinucleotide matrices, and ~30% of codon matrices were pathological to eigendecomposition. The majority of Taylor algorithm errors derived from occurrence of multiple unobserved states. A small number of negative probabilities were detected from the Padé algorithm on trinucleotide matrices that were attributable to machine precision. Although the Padé algorithm does not facilitate caching of intermediate results, it was up to 3× faster than eigendecomposition on the same matrices.

Conclusion

Development of robust software for computing non-reversible dinucleotide, codon and higher evolutionary models requires implementation of the Padé with scaling and squaring algorithm.

Background

The dynamics of genetic divergence are typically modelled as a Markov process where the rates of exchange between discrete sequence states are described by rate matrices. Discrete- or continuous-time Markov processes employ different, but related, rate matrices. The former involve a substitution matrix that specifies the probabilities of substitution between sequence states in a discrete period of time (P(t), [1]). The continuous-time Markov process employs an instantaneous rate matrix (Q), which defines the instantaneous relative rates of interchange between sequence states from which the substitution probabilities for a specified time period are obtained by P(t) = exp(Q t) where t represents time and exp is the matrix exponential. The most commonly employed rate matrices impose the restriction that evolutionary processes are time-reversible (e.g. [1]). The inaccuracy of this restriction is shown by the specificity of particular mutagens and repair enzymes [2], and by the apparent directionality of amelioration of horizontally transferred genes to the background genome composition [3].

Relaxing the assumption of time-reversibility requires consideration of non-reversible matrices. Assessments of time-reversibility, which have largely been restricted to nucleotide rate matrices, show that non-reversible models can provide better estimation of important evolutionary parameters including rates of evolution and, when employed with the maximum-likelihood phylogenetic inference framework, phylogenetic tree support [4]. The development of approaches to identifying both biologically accurate and parametrically succinct models is therefore of considerable interest. Non-reversible forms of codon substitution models would allow, for instance, consideration of temporal changes in mutation pressure on natural selection. However, limitations of matrix exponentiation algorithms have been cited as motivation for continued development of reversible models (for example, [5]). Exploration of statistically efficient (parametrically reduced) forms might be most readily achieved using continuous time processes, but the accuracy of these approaches hinges on the properties of exponentiation of matrices from real biological data.

The most obvious method for computing a matrix exponential is the generalisation of the Taylor series expansion of a scalar exponential [6]. Instead of a series of scalar terms, the matrix exponential is expressed as a Taylor series over terms involving matrix products. The series is truncated at a sufficiently large finite number of terms (M).

P ( t ) = exp ( Q t ) = I + Q ( t ) + Q 2 t 2 2 ! + Q 3 t 3 3 ! + i = 0 M Q i t i i ! MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xI8qiVKYPFjYdHaVhbbf9v8qqaqFr0xc9vqFj0dXdbba91qpepeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaqbaeWabmqaaaqaaiabhcfaqjabcIcaOiabdsha0jabcMcaPiabg2da9iGbcwgaLjabcIha4jabcchaWjabcIcaOiabhgfarjabdsha0jabcMcaPaqaaiabg2da9iabhMeajjabgUcaRiabhgfarjabcIcaOiabdsha0jabcMcaPiabgUcaRKqbaoaalaaabaGaeCyuae1aaWbaaeqabaGaeGOmaidaaiabdsha0naaCaaabeqaaiabikdaYaaaaeaacqaIYaGmcqGGHaqiaaGccqGHRaWkjuaGdaWcaaqaaiabhgfarnaaCaaabeqaaiabiodaZaaacqWG0baDdaahaaqabeaacqaIZaWmaaaabaGaeG4mamJaeiyiaecaaOGaey4kaSIaeSOjGSeabaGaeyisIS7aaabCaKqbagaadaWcaaqaaiabhgfarnaaCaaabeqaaiabdMgaPbaacqWG0baDdaahaaqabeaacqWGPbqAaaaabaGaemyAaKMaeiyiaecaaaWcbaGaemyAaKMaeyypa0JaeGimaadabaGaemyta0eaniabggHiLdaaaaaa@6451@

Convergence of the series expansion depends on the magnitude of the matrix norm ||Q|| (a measure of the size of the elements in Q, see Methods equation 1) [7]. An important property of the Taylor series is a reduced rate of convergence for matrices with large ||Q|| such that achieving a required accuracy involves increasingly larger M. A further problem is that the impact of roundoff error increases with term order so the method becomes impractical and inaccurate for matrices with large ||Q||. Although some efficiency improvements can be made to reduce the number of matrix products required [7], the essential defect remains. Accordingly, the Taylor series expansion performs worst on potentially the most biologically relevant matrices and thus sets a lower bound on both accuracy and computational performance. We will subsequently refer to the Taylor series matrices exponentiation algorithm as expTAYL.

Several other algorithms compute the matrix exponential, but differ substantially in their computational behaviour, performance, and vulnerability to so called pathological matrices. For the purposes of this paper, we define a pathological matrix as one that results in a substantial discrepancy between the 'true' value of P and the value computed as exp(Q t) by a given algorithm. It is important to note that a matrix property responsible for a discrepancy affecting one particular algorithm may not necessarily affect another algorithm to the same extent.

Of the collection of algorithms, that proposed as most robust (described below) is seldom adopted in the field of molecular evolution: instead, the method of matrix exponentiation by eigendecomposition is most widely used by existing software packages but is far less robust [6]. This latter algorithm is based on a matrix decomposition approach involving similarity transformations of the form Q = SBS-1 so thatexp(Q) = S exp(B)S-1

where the aim is to find an S for which exp(B) is easy to compute. In the case of eigendecomposition, if Q = UDU-1 where U are the eigenvectors, D is a diagonal matrix containing the eigenvalues of Q and P(t) the matrix of substitution probabilities for time t, thenP(t) = U exp(D t)U-1.

The eigendecomposition approach has an important practical advantage for molecular evolutionary applications – the spectral theorem allows the calculation of arbitrary many values of exp(Q t) from a single decomposition [7]. For a phylogenetic model that assumes a single (global) Q across the entire tree, for instance, this property means the decomposition need be performed only once per model evaluation. The O(n3) complexity of the decomposition is thus outweighed by its suitability for caching intermediate results. Eigendecomposition works well for normal matrices (where a normal matrix is defined as one that commutes with its conjugate transpose [7]) but breaks down when Q does not have a complete set of linearly independent eigenvectors (an invertible U does not exist) or when U is close to singular, i.e. when the condition number of the matrix of eigenvectors cond(U) = condEV(Q) is large. (We illustrate the analytical conditions under which the eigendecomposition approach can fail with an example in Additional file 1.) We will subsequently refer to the eigendecomposition matrix exponentiation algorithm as expEIG.

The algorithm advocated by Moler and van Loan [6] computes the matrix exponential using the Padé approximation in combination with scaling and squaring [8]. Padé approximants converge if the matrix norm ||Q|| is not too large. Thus, the idea is to reduce the matrix norm by scaling the matrix and then use Padé approximation (a ratio of series) to compute the scaled matrix exponential and then the full matrix exponential by squaring operations. The scaling and squaring operation reduces the norm of the matrix ||Q|| to that of a matrix ||Q '||P(t) = [exp(Q t/m)]m= [exp(Q 't)]m

The Padé approximation is a ratio of series where, typically, the series (denoted p and q) are constrained to be equal as diagonal Padé approximants are preferred for numerical efficiency [6]. The Padé approximation with scaling and squaring is then

P ( t ) = [ exp ( Q ( t ) ] m = ( j = 0 p ( p + q j ) ! p ! ( p + q ) ! j ! ( p j ) ! ( Q t ) j j = 0 q ( p + q j ) ! q ! ( p + q ) ! j ! ( q j ) ! ( Q t ) j ) m MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xI8qiVKYPFjYdHaVhbbf9v8qqaqFr0xc9vqFj0dXdbba91qpepeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaqbaeWabiqaaaqaaiabhcfaqjabcIcaOiabdsha0jabcMcaPiabg2da9iabcUfaBjGbcwgaLjabcIha4jabcchaWjabcIcaOiqbhgfarzaafaGaeiikaGIaemiDaqNaeiykaKIaeiyxa01aaWbaaSqabeaacqWGTbqBaaaakeaacqGH9aqpdaqadaqcfayaamaalaaabaWaaabmaeaadaWcaaqaaiabcIcaOiabdchaWjabgUcaRiabdghaXjabgkHiTiabdQgaQjabcMcaPiabcgcaHiabdchaWjabcgcaHaqaaiabcIcaOiabdchaWjabgUcaRiabdghaXjabcMcaPiabcgcaHiabdQgaQjabcgcaHiabcIcaOiabdchaWjabgkHiTiabdQgaQjabcMcaPiabcgcaHaaacqGGOaakcuWHrbqugaqbaiabdsha0jabcMcaPmaaCaaabeqaaiabdQgaQbaaaeaacqWGQbGAcqGH9aqpcqaIWaamaeaacqWGWbaCaiabggHiLdaabaWaaabmaeaadaWcaaqaaiabcIcaOiabdchaWjabgUcaRiabdghaXjabgkHiTiabdQgaQjabcMcaPiabcgcaHiabdghaXjabcgcaHaqaaiabcIcaOiabdchaWjabgUcaRiabdghaXjabcMcaPiabcgcaHiabdQgaQjabcgcaHiabcIcaOiabdghaXjabgkHiTiabdQgaQjabcMcaPiabcgcaHaaacqGGOaakcqGHsislcuWHrbqugaqbaiabdsha0jabcMcaPmaaCaaabeqaaiabdQgaQbaaaeaacqWGQbGAcqGH9aqpcqaIWaamaeaacqWGXbqCaiabggHiLdaaaaGccaGLOaGaayzkaaWaaWbaaSqabeaacqWGTbqBaaaaaaaa@9056@

The diagonal Padé method with scaling and squaring requires of the order of O((q + m + 1/3)n3) operations but is, in general, more efficient than the Taylor series. To compute single values of exp(Q t) therefore also takes of the order of O(n3) operations, but does not have intermediate results that can be cached. Thus, each tree branch (and unique value of t) requires an independent exp(Q t). The robust computational performance of Padé therefore comes at the cost of requiring an independent exp(Q t) computation for each value of t. We will subsequently refer to the diagonal Padé with scaling and squaring matrix exponentiation algorithm as expPADÉ .

Given the evidence that the algorithms commonly employed by molecular evolutionary software can significantly err in their computation of the exponential [6], a survey of whether matrices pathological to these algorithms exist in nature is essential for the development of biologically realistic models of sequence evolution that are computationally robust. Here we report the results of a survey for matrices pathological to the exp algorithms in both protein coding and non-protein coding sequences from lineages as diverse as microbes and primates.

Results

P matrices were derived from species triads composed of two ingroups and an outgroup. Knowledge of the outgroup allows determination of the sequence states ancestral to the ingroup lineages, thereby enabling a simple counting procedure for generating the P matrices (described in the Methods). The outgroup further allows the resulting matrices to be non-reversible. For the current comparisons we arbitrarily set the time t to 1.

For each P, the corresponding Q was estimated using a constrained optimisation procedure. While the relationship between P and Q suggested using the matrix logarithm to estimate Q, doing so resulted in nearly all dinucleotide and higher matrices having negative off-diagonal elements. In preliminary analyses, we determined that this property arose from sampling error (results not shown). Importantly, because matrices with negative off-diagonals cannot be readily interpreted we developed a constrained optimisation procedure for estimation of Q from P ^ MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaGafCiuaaLbaKaaaaa@2D12@ . This procedure, which we describe in more detail in the Methods, used a numerical optimisation algorithm to minimise the value of || P ^ MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaGafCiuaaLbaKaaaaa@2D12@ - exp( Q ^ MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaGafCyuaeLbaKaaaaa@2D14@ )|| subject to the constraint qij, ij≥ 0. By default, this procedure employed the expPADÉ algorithm, resulting in a bias towards this algorithm which we address in detail later. We note here that as the results were not substantively different when we used the matrix logarithm for estimating Q and the constrained optimisation approach produces matrices more likely to be representative of naturally occurring rate matrices, we only report results from the latter procedure.

To measure the magnitude of a matrix we employ the Frobenius norm [6], the square root of the sum of the absolute squared elements of a matrix (see Methods equation 1). The matrix norm is also used as a measurement of the error, or discrepancy, between P ^ MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaGafCiuaaLbaKaaaaa@2D12@ and the results of expTAYL, expEIG and expPADÉ algorithms and we denote these error statistics as ϵ TAYL , ϵ EIG and ϵ PADÉ (see Methods equations 2–4). The additional matrix property of eigenvector matrix condition number, the product of the spectral matrix norms of the eigenvector matrix and inverted eigenvector matrix of Q (Methods equation 5), is also used as it indicates the suitability for digital computation of a matrix for eigendecomposition [911]. Finally, because the elements of P are probabilities, we also defined a matrix as pathological to an algorithm if it contained an invalid probability value (< 0, > 1).

Pathological matrices in microbes

Orthologous protein coding gene sequences were sampled from all species triples in KEGG where neighbours were 0–2% distant by 16 S rRNA and outgroups were 2–10% divergent. This procedure resulted in 136 valid species triples. Given the large number of genes, and that preliminary work indicated estimating a single trinucleotide Q required nearly 1 day, we concatenated all alignments from a triad and estimated separate Q matrices for each ingroup lineage from these concatenated alignments. As described in the Methods, aligned codon columns with non-nucleotide characters (such as indels or ambiguous bases) were deleted. Nucleotide and trinucleotide samples were obtained from the unmodified resulting alignments. Two distinct dinucleotide samples were considered. The patterns of mutation are typically distinct between the three different codon positions due to their differing influence of variation in the encoded amino acid sequence. We therefore consider dinucleotides sampled from both the first and second or second and third codon positions. We refer to these as the dinucleotide 1+2 or 2+3 matrices respectively. The minimum, median and maximum filtered, concatenated alignment lengths were ~31 Kbp, ~1.5 Mbp and ~3.7 Mbp respectively.

Measures of exponentiation error for nucleotide matrices were low across all algorithms (Table 1). There were no exponentiation failures by any algorithm for the nucleotide matrices. A small fraction (< 1%) of expEIG failed, however, for the dinucleotide matrices derived from codon positions 1+2 or 2+3, with one significant failure resulting from a large number of zero elements that lead to a singular eigenvector matrix, and four failures where the maximum element size resulted in an invalid probability. Almost all ( 255 257 ) MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaqcfa4aaeWaaeaadaWcaaqaaiabikdaYiabiwda1iabiwda1aqaaiabikdaYiabiwda1iabiEda3aaaaiaawIcacaGLPaaaaaa@33C4@ the trinucleotide matrices were pathological to expTAYL, but none of these matrices were pathological to either the expEIG or expPADÉ algorithms. The other descriptive statistics increased with the dimension of the matrices: matrix norm and eigenvector matrix condition numbers systematically increased from the nucleotide to trinucleotide matrices. The distinct dinucleotide positions were predominantly consistent with each other, with median matrix statistics and error values of similar order.

Table 1 Exponentiation of matrices from microbes.

Pathological matrices in primates

Intronic alignments were sampled from Ensembl release 46 for 3 primate lineages – human, chimpanzee and macaque – where the outgroup status of macaque relative to the great apes is well established [12]. Intronic sequences were sampled due to increased confidence in their orthology arising from the relationships between exonic sequences. Sequences unlikely to evolve by a point mutation process (such as simple repeat sequence) were masked and all alignment columns containing non-nucleotide characters were removed (see Methods). There were a total of 1079 alignments with minimum, median and maximum filtered alignment lengths of ~30 Kbp, ~59 Kbp and ~438 Kbp respectively.

As for the microbial exonic sequences, no nucleotide matrices pathological to any of the algorithms were evident (Table 2). The results from dinucleotide matrices 1+2 and 2+3 were similar – low errors across all algorithms and no matrices pathological to any algorithm. This result is distinct from that evident from the microbial exonic data. Also different to the microbial data were an appreciable frequency (~10%) of trinucleotide matrices pathological to expEIG while no matrices were pathological to expTAYL. A moderate number of matrices were also pathological to expPADÉ, but inspection of these revealed a maximum negative element size of -1.2e-33, indicating these as likely deriving from rounding errors. Also consistent with the results from the microbial analyses, the eigenvector matrix condition numbers increased from the nucleotide to trinucleotide matrices (see Figure 1).

Table 2 Exponentiation of matrices from primate intron sequences.
Figure 1
figure 1

Eigenvector matrix condition number increases with the dimension of the substitution model. Data are from primate introns.

Motivated by the differing frequency of pathological matrices between microbial exonic and primate intronic data, we sampled a collection of primate protein coding gene exons. Specifically, we used exonic sequence from a subset of the genes from which the introns were obtained. Given the restriction of pathological matrices to dinucleotide or higher alphabets, and high computational demands of fitting trinucleotide models, we sampled 1028 CDS alignments and combined these into 103 concatenated (10 loci each) alignments (see Methods). The minimum, median and maximum filtered, concatenated alignment lengths were ~12 Kbp, ~24 Kbp and ~40 Kbp respectively.

The matrix properties for these data, shown in Table 3, showed more consistency with those of the microbial exonic data than primate intronic data. As observed in the microbial analyses, an appreciable frequency (~8%) of dinucleotide matrices from codon positions 1+2 were pathological to expEIG but not to expTAYL. A smaller proportion (~1%) of matrices from codon positions 2+3 were pathological to expEIG. Also consistent with the microbial exon analysis results, all trinucleotide matrices were pathological to expTAYL. These results establish that the frequency of matrices pathological to expTAYL and expEIG depends on the class of sequence being sampled.

Table 3 Exponentiation of matrices from primate protein coding exons.

An important difference between the trinucleotide matrices from the intronic and exonic sequences is the presence of the trinucleotides encoding stop codons. We assessed whether inclusion of these states, which are absent from the in frame exons, contributed to the exponentiation errors by excluding unobserved states from the trinucleotide count matrices. This therefore generates 61 × 61 matrices, as employed by codon substitution models. As shown in the last row of Table 3, with the removal of unobserved states the errors from expTAYL were completely eliminated. We further confirmed that the presence of unobserved states was responsible for the expTAYL failures by taking a dinucleotide counts matrix and selecting two states to be missing (setting the corresponding row/column counts to all zeros). Exponentiation of this constructed matrix also proved pathological to expTAYL. Interestingly, the frequency of errors from expEIG was significantly increased with ~30% of codon matrices proving pathological (Table 3).

Discussion

Our analyses confirm the numerical qualities of the three matrix exponentiation algorithms are distinct and that matrices pathological to both expEIG and expTAYL exist in nature. The magnitude of errors ranged from the subtle, P had probabilities close to but outside the interval 0–1, to extreme cases of algorithmic failure or extremely large elements. The range of these errors, and the data-type dependent frequency of matrices pathological to an algorithm indicate that expTAYL and expEIG are ill-suited to evaluation of non-reversible evolutionary models or to data where more than one sequence state is not observed.

An important impact of our study design is a bias towards expPADÉ which we now partly redress. This bias was inevitable because estimates of Q had to be obtained from estimates of P and the prohibitive computational time required for estimation of trinucleotide Q necessitated a choice of a single exp algorithm. For the microbial lineages in particular, fitting a single trinucleotide Q frequently took ~1 day. We therefore elected to fit the trinucleotide matrices using the expPADÉ since it was supported as most robust [6]. Nonetheless, we considered the bias introduced by estimating Q using one algorithm and computing exp(Q) with another. The dinucleotide model failures of expEIG provided an opportunity to efficiently (with regards to compute time) assess whether constrained optimisation of Q using expEIG, instead of expPADÉ, might eliminate the matrices pathological to expEIG. We therefore modified the constrained fitting of Q to use expEIG instead of expPADÉ, and applied the algorithm to the primate dinucleotide matrices derived from codon positions 1+2 of the concatenated protein coding sequences and exponentiated the resulting Q ^ MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaGafCyuaeLbaKaaaaa@2D14@ also using expEIG. From the resulting matrices there was 1 failure during optimisation and 6 matrices remained pathological to expEIG after this procedure. This number is smaller than the 17 failures (Table 3) for expEIG when applied to Q estimated using expPADÉ . These results indicate that although using a different algorithm for estimating Q introduces some bias, expEIG still fails at an appreciable frequency. We note that for the Q matrices estimated using expEIG, neither expPADÉ nor expTAYL exhibited high ϵ. However, the expPADÉ of Q estimated by expEIG returned invalid probabilities from 21 4701 MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaqcfa4aaSaaaeaacqaIYaGmcqaIXaqmaeaacqaI0aancqaI3aWncqaIWaamcqaIXaqmaaaaaa@3225@ of the matrices examined in this study (all matrices considered in Tables 1, 2, 3 and those estimated using expEIG). These failures were all extremely small negative values, the largest absolute value being ~10-34, likely reflecting rounding errors and thus their infrequent occurrence and extremely small size support the robustness of expPADÉ .

The failure on both sequence classes of the eigendecomposition algorithm can originate from properties of the eigenvectors and/or eigenvalues. If the eigenvector matrix of a given Q is near-singular, then spectral expansion of the matrix exponential expEIG(Q) is ill-defined. The eigenvalues influence on the computations occurs when a Q has very many almost degenerate (in the examples in the present study, near zero) elements. In these cases, though the numerically determined eigenvector matrix has an inverse, the set of numerically determined eigenvalues and eigenvectors do not accurately satisfy the eigenvalue equation [13] that can lead to failure of the spectral representation of the matrix exponential expEIG of Q.

There appears to be a connection between these two types of failures: matrices with ill-conditioned eigenvector matrices lie close to ones with multiple eigenvalues [14]. Thus, the eigendecomposition can fail (or become inaccurate) due to ill-conditioning of the eigenvectors (becoming parallel) or of the eigenvalues (many degenerate near zero values) or both [13, 15].

The influence of sequence type on the frequency of pathological matrices originated in part from absence of some sequence states and potentially also from the reduced divergence of protein-coding DNA sequences. The expTAYL algorithm exhibited the most striking difference between exonic and intronic sequences. As demonstrated by our artificial dinucleotide example, where we set multiple states to being unobserved, these failures arose from multiple unobserved sequence exchanges. The expTAYL algorithm should therefore not be used on data sets where this may arise. The expEIG algorithm also exhibited a difference in failure rates between the two sequence classes – ~10% trinucleotide matrices on intronic data, ~5% dinucleotide matrices and ~30% codon matrices on primate exonic data. Combined with the difference in error rates of dinucleotide matrices for positions 1+2 and 2+3 on exonic data, these results suggest that the ultimate biological cause of these failures is the suppressing influence of natural selection on substitution rates. Of the three codon positions, positions 1+2 are subjected to greater scrutiny by natural selection than positions 2+3. The result is that many of the dinucleotides exhibit similarly reduced substitutions in a matrix such that some of the eigenvectors may be almost parallel, resulting in a near-singular matrix. The fact that there is little difference in the matrix norm statistics between dinucleotide 1+2 and 2+3, yet the maximum eigenvector matrix condition numbers exhibit a similar order of magnitude to that observed for the trinucleotide cases (Tables 1 and 3), is consistent with this hypothesis [16]. The absence of such errors from the primate intron dinucleotide matrices (Table 2) follows, because the putative absence of selective constraint on intronic sequence would allow greater differentiation between the dinucleotide substitutions and thus result in matrices that were not close to singular. This argument also applies to the increased frequency of errors affecting codon matrices compared with the trinucleotide counterparts (Table 3). These results indicate that combinations of divergence and natural selection, such as those considered here, exist to which the expEIG algorithm is not well suited.

We considered an alternate, but less likely, explanation for the distinct frequency of pathological matrices between the protein coding and intronic sequence classes – that they represent an artefact of the concatenation of protein coding sequences. Concatenation of sequences from protein coding genes subjected to distinct evolutionary and mutagenic processes could generate (or obscure) pathological matrices. We evaluated this possibility for dinucleotide matrices on individual protein coding sequence alignments for just one of the species triples (Anabaena variabilis, Anabaena sp. PCC 7120 and Thermosynechococcus elongatus). The results were consistent with those reported above regarding the occurrence of errors for expEIG (Table 4). In contrast to the results from the concatenated alignments, there was a substantial error rate from expTAYL. Consistent with our assessment from trinucleotide matrices from protein coding sequences, the failures were predominantly caused by the absence of some states, a case that was increased due to the much shorter length of the individual alignments. These properties were robust to whether expPADÉ or expEIG were used in the constrained optimisation step (Table 4). That all algorithms exhibited a consistently lower median error rate on the Q ^ MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaGafCyuaeLbaKaaaaa@2D14@ estimated using expPADÉ (~0.0017) compared with those estimated using expEIG (~0.0026) further supports the robustness of expPADÉ .

Table 4 Exponentiation of individual matrices from protein coding exons from a triad of microbial species.

Matrices pathological to an algorithm can also occur during numerical optimisation. What defines the frequency of such matrices is unclear but they do arise during optimisation. For ~1% of the primate intron trinucleotide P matrices, the Taylor series to the second element (which we used as the initial estimate for optimisation) were pathological to expEIG. Whether occurrence of such matrices during an optimisation would affect the resulting solution is unclear.

Although expEIG lends itself to caching, the utility of a global Q, and thus the importance of caching, diminishes when considering non-reversible models. Non-stationarity is implicitly a part of non-reversible phylogenetic models; this, by definition necessitates non-global Q. As evidenced by the computational speed summaries in Table 5, if numerous exponentiations are required then expPADÉ has a clear performance advantage in addition to its numerical robustness.

Table 5 Exponentiation algorithm compute times.

Conclusion

We have determined that matrices pathological to the most commonly applied matrix exponentiation algorithms exist in nature. The robust behaviour of the Padé with scaling and squaring algorithm, combined with its performance advantage for larger sequence alphabets, establishes this as the algorithm most suited to non-reversible models.

Methods

Sampling Sequences from Microbes

Most methods for inferring rate matrices perform best when the diagonal of the probability matrix is strongly dominant, i.e. when there are relatively few changes. Incorrect choices of the outgroup are also problematic, because such choices reverse the directionality of the evolutionary process. We therefore chose species triples where the sister taxa are substantially more related to one another than they are to the outgroup. Specifically, we required sister taxa to be at least 98% identical in their 16 S rRNA genes, and required the outgroup to be 90–98% identical, thus ensuring that all but the fastest-evolving proteins would have dominant diagonals in their P matrices and that the outgroup would be more different than the remainder. For each of these species triples, for each protein in one of the two sister taxa, its best BLAST hit in each of the other two taxa was recovered (blastp e-value 10-10). The best hits were then aligned using MUSCLE with default parameters and the nucleotide sequences from KEGG threaded back through the protein alignment to generate a nucleotide alignment.

Sampling Sequences from Primates

We sampled primate sequence alignments from the Ensembl release 46 multiple-sequence alignments of Homo sapiens (human), Pan troglodytes (chimpanzee) and Macacca mulatta ( macaque) genomes. Genomic coordinates for human protein coding genes were determined and Ensembl's PECAN genomic multiple alignments corresponding to the human coordinates selected for the species-set. Only genes for which sequence alignments were available for all three lineages were retained. Exonic sequence, indels and the simple repeat sequences were masked. Alignments were split into trinucleotide columns and any column containing characters other than ACGT were excluded and of the resulting filtered alignments those ≥ 50000 base pairs long were kept. This procedure resulted in ~1100 alignments of primate intron sequences.

Orthologous protein coding sequence (CDS) for the sampled human genes was extracted and aligned using the PyCogent progressive HMM alignment algorithm, with a codon substitution model [17]. All aligned codon columns containing non-nucleotide characters were removed. Due to the computational demands of fitting trinucleotide models, we concatenated 10 aligned genes in an arbitrary order (determined by the sort order of the Ensembl identifier of the human gene) resulting in ~100 alignments of concatenated primate protein coding genes.

All alignments were in trinucleotide frame, meaning that (starting from the first nucleotide) each triplet of nucleotide columns contained only 'real' trinucleotides. Due to the elimination of masked sequences, spanning between trinucleotides could create sequence elements not present in the original genome sequence. To avoid sampling artificial dinucleotides, alignments were split into trinucleotide columns first and either all first and second, or second and third positions were selected and concatenated to construct dinucleotide alignments. Nucleotide and trinucleotide alignments were derived without any modification.

Estimating Q

For each alignment for a species triad, we used the known outgroup lineage to determine the direction of substitutions between sequence states for each ingroup lineage. Alignments were split into columns of non-overlapping motifs of either nucleotide, dinucleotide or trinucleotides with the trinucleotide based sampling of sequences taken into account for the dinucleotide sampling (see above). Columns in which all three sequences were different were excluded since the ancestral state of the ingroups cannot be determined. If the ingroups were identical to each other, but different from the outgroup, the ancestral state is taken as the ingroup state. If one of the ingroup lineages was identical to the outgroup, their state was taken as the ancestral state. These assignments of ancestral state were used to count the number of times motif i changed to motif j for each ingroup lineage separately. This procedure generated a 'counts' matrix for each lineage, for each alignment which can be converted into a P matrix by dividing the elements of each row by the row sum. The resulting P matrices can be non-reversible.

Estimation of Q from P matrices was done using a constrained optimisation procedure. All off-diagonal elements of Q (qij, ij) are free parameters while the diagonal elements are constrained to be q ii = -∑j, jiq ij to ensure the row sums of the instantaneous rate matrix are 0. Constraining the qij, ij≥ 0, we minimised || P ^ MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaGafCiuaaLbaKaaaaa@2D12@ - exp(Q)|| where the matrix exponential was computed by Padé (unless stated otherwise). This function was minimised using the PyCogent [18] Powell optimiser with tolerance of 10-6 and a maximum of 5 restarts. We used the Taylor series to the second element, computed as P minus the identity matrix, as the starting values for the numerical optimisation. The number of free parameters for Q were N × (N - 1) (N is the number of motifs in the alphabet): 12 for nucleotides; 240 for dinucleotides; and 4032 for trinucleotide matrices. Due to the very large number of free parameters in the trinucleotide models, and computational times required to estimate some Q of ~24 hours (for the microbial samples), not all alignments were used. Codon matrices were derived for the protein coding sequences by removing the unobserved states which corresponded to the trinucleotides encoding stop codons.

Measuring matrix exponentiation error

In order to quantify the accuracy of the matrix exponentiation methods a number of measures are introduced. Firstly, there is the concept of a matrix norm. The matrix norm ||Q|| is a generalisation of the vector norm (length of a vector) and yields a measure of the effective size of a matrix Q in terms of the size of its elements [7]. We employed the Frobenius norm (often easier to compute than the induced norms) [7], which for the matrix Q is

| | Q | | = i = 1 n j = 1 n | q i j 2 | MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xI8qiVKYPFjYdHaVhbbf9v8qqaqFr0xc9vqFj0dXdbba91qpepeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaGaeiiFaWNaeiiFaWNaeCyuaeLaeiiFaWNaeiiFaWNaeyypa0ZaaOaaaeaadaaeWbqaamaaqahabaGaeiiFaWNaemyCae3aa0baaSqaaiabdMgaPjabdQgaQbqaaiabikdaYaaakiabcYha8bWcbaGaemOAaOMaeyypa0JaeGymaedabaGaemOBa4ganiabggHiLdaaleaacqWGPbqAcqGH9aqpcqaIXaqmaeaacqWGUbGBa0GaeyyeIuoaaSqabaaaaa@4AB1@
(1)

where the q ij are the elements of Q. The distance between two matrices can therefore be computed as the norm of the difference between the matrices and equates to the square root of the sum of absolute squared differences. We define relative measures of exponentiation error as

ϵ T A Y L = | | P ^ exp TAYL ( Q ^ ) | | MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xI8qiVKYPFjYdHaVhbbf9v8qqaqFr0xc9vqFj0dXdbba91qpepeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaqbaeaabeqaaaqaambvLH1qn1uy0Hws0fgBPngaryWyT1wAXadaiqGacqWF1pGSdaWgaaWcbaGaemivaqLaemyqaeKaemywaKLaemitaWeabeaakiabg2da9iabcYha8jabcYha8jqbhcfaqzaajaGaeyOeI0IagiyzauMaeiiEaGNaeiiCaa3aaSbaaSqaaiabbsfaujabbgeabjabbMfazjabbYeambqabaGccqGGOaakcuWHrbqugaqcaiabcMcaPiabcYha8jabcYha8baaaaa@5005@
(2)
ϵ E I G = | | P ^ exp EIG ( Q ^ ) | | MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xI8qiVKYPFjYdHaVhbbf9v8qqaqFr0xc9vqFj0dXdbba91qpepeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaWeuvgwd1utHrhAjrxySL2yaeHbJ1wBPfdmaGabciab=v=aYoaaBaaaleaacqWGfbqrcqWGjbqscqWGhbWraeqaaOGaeyypa0JaeiiFaWNaeiiFaWNafCiuaaLbaKaacqGHsislcyGGLbqzcqGG4baEcqGGWbaCdaWgaaWcbaGaeeyrauKaeeysaKKaee4raCeabeaakiabcIcaOiqbhgfarzaajaGaeiykaKIaeiiFaWNaeiiFaWhaaa@4D57@
(3)
ϵ P A D É = | | P ^ exp PADÉ ( Q ^ ) | | MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xI8qiVKYPFjYdHaVhbbf9v8qqaqFr0xc9vqFj0dXdbba91qpepeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaWeuvgwd1utHrhAjrxySL2yaeHbJ1wBPfdmaGabciab=v=aYoaaBaaaleaacqWGqbaucqWGbbqqcqWGebarcqWGjdqYaeqaaOGaeyypa0JaeiiFaWNaeiiFaWNafCiuaaLbaKaacqGHsislcyGGLbqzcqGG4baEcqGGWbaCdaWgaaWcbaGaeeiuaaLaeeyqaeKaeeiraqKaeeyYaKmabeaakiabcIcaOiqbhgfarzaajaGaeiykaKIaeiiFaWNaeiiFaWhaaa@518B@
(4)

where P ^ MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaGafCiuaaLbaKaaaaa@2D12@ is the probability matrix estimated from the counts matrix and Q ^ MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaGafCyuaeLbaKaaaaa@2D14@ is the instantaneous rate matrix estimated from this P ^ MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xH8viVGI8Gi=hEeeu0xXdbba9frFj0xb9qqpG0dXdb9aspeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaGafCiuaaLbaKaaaaa@2D12@ as described above.

In addition to the norm of the rate matrix, the performance of some of the matrix exponentiation methods may depend on the condition number condEV(Q) of the eigenvector matrix of Q [6, 7]. The eigenvector matrix condition number condEV(Q) can be defined within the spectral matrix norm (2-norm) [19] as [7]

cond EV ( Q ) = | | U | | 2 | | U | | 2 1 = σ max ( Q ) / σ min ( Q ) MathType@MTEF@5@5@+=feaagaart1ev2aaatCvAUfKttLearuWrP9MDH5MBPbIqV92AaeXatLxBI9gBaebbnrfifHhDYfgasaacPC6xNi=xI8qiVKYPFjYdHaVhbbf9v8qqaqFr0xc9vqFj0dXdbba91qpepeI8k8fiI+fsY=rqGqVepae9pg0db9vqaiVgFr0xfr=xfr=xc9adbaqaaeGaciGaaiaabeqaaeqabiWaaaGcbaGaee4yamMaee4Ba8MaeeOBa4Maeeizaq2aaSbaaSqaaiabbweafjabbAfawbqabaGccqGGOaakcqWHrbqucqGGPaqkcqGH9aqpcqGG8baFcqGG8baFcqWHvbqvcqGG8baFcqGG8baFdaWgaaWcbaGaeGOmaidabeaakiabcYha8jabcYha8jabhwfavjabcYha8jabcYha8naaDaaaleaacqaIYaGmaeaacqGHsislcqaIXaqmaaGccqGH9aqpcqaHdpWCdaWgaaWcbaGagiyBa0MaeiyyaeMaeiiEaGhabeaakiabcIcaOiabhgfarjabcMcaPiabc+caViabeo8aZnaaBaaaleaacyGGTbqBcqGGPbqAcqGGUbGBaeqaaOGaeiikaGIaeCyuaeLaeiykaKcaaa@5E6C@
(5)

where U is the matrix of eigenvectors and σmax(Q) and σmin(Q) are the maximal and minimal singular values [7] of Q respectively.

Software implementation

The PyCogent [18, 20] built-in routines for determining counts matrices and matrix exponentiation routines were used, while the matrix statistics were computed using the python numerical library, Numpy version 1.0.4 [21]. All scripts used to undertake this study are available on request.

References

  1. Lio P, Goldman N: Models of molecular evolution and phylogeny. Genome Res 1998, 8(12):1233–44.

    CAS  PubMed  Google Scholar 

  2. Ames B: The detection of environmental mutagens and potential carcinogens. Cancer 1984, 53(10):2034–40. Publisher Full Text 10.1002/1097-0142(19840515)53:10<2034::AID-CNCR2820531005>3.0.CO;2-S

    Article  CAS  PubMed  Google Scholar 

  3. Lawrence JG, Ochman H: Amelioration of Bacterial Genomes: Rates of Change and Exchange. Journal of Molecular Evolution 1997, 44(4):383–397. 10.1007/PL00006158

    Article  CAS  PubMed  Google Scholar 

  4. Foster PG: Modeling compositional heterogeneity. Syst Biol 2004, 53(3):485–95. 10.1080/10635150490445779

    Article  PubMed  Google Scholar 

  5. Schadt E, Lange K: Codon and rate variation models in molecular phylogeny. Mol Biol Evol 2002, 19(9):1534–1549.

    Article  CAS  PubMed  Google Scholar 

  6. Moler CB, Van Loan CF: Nineteen dubious ways to compute the exponential of a matrix, twenty-five years later. SIAM Review 2003, 45: 3–49. 10.1137/S00361445024180

    Article  Google Scholar 

  7. Golub GH, Loan CFV: Matrix computations. 3rd edition. Baltimore, MD, USA: Johns Hopkins University Press; 1996.

    Google Scholar 

  8. Ward RC: Numerical Computation of the Matrix Exponential with Accuracy Estimate. SIAM Journal on Numerical Analysis 1977, 14(4):600–610. 10.1137/0714039

    Article  Google Scholar 

  9. Smith R: The condition numbers of the matrix eigenvalue problem. Numerische Mathematik 1967, 10(3):232–240. 10.1007/BF02162166

    Article  Google Scholar 

  10. Demmel J: On condition numbers and the distance to the nearest ill-posed problem. Numerische Mathematik 1987, 51(3):251–289. 10.1007/BF01400115

    Article  Google Scholar 

  11. Bai Z, Demmel J, McKenney A: On computing condition numbers for the nonsymmetric eigenproblem. ACM Trans Math Softw 1993, 19(2):202–223. 10.1145/152613.152617

    Article  Google Scholar 

  12. Gibbs RA, Rogers J, Katze MG, Bumgarner R, Weinstock GM, Mardis ER, Remington KA, Strausberg RL, Venter JC, Wilson RK, Batzer MA, Bustamante CD, Eichler EE, Hahn MW, Hardison RC, Makova KD, Miller W, Milosavljevic A, Palermo RE, Siepel A, Sikela JM, Attaway T, Bell S, Bernard KE, Buhay CJ, Chandrabose MN, Dao M, Davis C, Delehaunty KD, Ding Y, Dinh HH, Dugan-Rocha S, Fulton LA, Gabisi RA, Garner TT, Godfrey J, Hawes AC, Hernandez J, Hines S, Holder M, Hume J, Jhangiani SN, Joshi V, Khan ZM, Kirkness EF, Cree A, Fowler RG, Lee S, Lewis LR, Li Z, Liu YS, Moore SM, Muzny D, Nazareth LV, Ngo DN, Okwuonu GO, Pai G, Parker D, Paul HA, Pfannkoch C, Pohl CS, Rogers YH, Ruiz SJ, Sabo A, Santibanez J, Schneider BW, Smith SM, Sodergren E, Svatek AF, Utterback TR, Vattathil S, Warren W, White CS, Chinwalla AT, Feng Y, Halpern AL, Hillier LW, Huang X, Minx P, Nelson JO, Pepin KH, Qin X, Sutton GG, Venter E, Walenz BP, Wallis JW, Worley KC, Yang SP, Jones SM, Marra MA, Rocchi M, Schein JE, Baertsch R, Clarke L, Csuros M, Glasscock J, Harris RA, Havlak P, Jackson AR, Jiang H, Liu Y, Messina DN, Shen Y, Song HXZ, Wylie T, Zhang L, Birney E, Han K, Konkel MK, Lee J, Smit AFA, Ullmer B, Wang H, Xing J, Burhans R, Cheng Z, Karro JE, Ma J, Raney B, She X, Cox MJ, Demuth JP, Dumas LJ, Han SG, Hopkins J, Karimpour-Fard A, Kim YH, Pollack JR, Vinar T, Addo-Quaye C, Degenhardt J, Denby A, Hubisz MJ, Indap A, Kosiol C, Lahn BT, Lawson HA, Marklein A, Nielsen R, Vallender EJ, Clark AG, Ferguson B, Hernandez RD, Hirani K, Kehrer-Sawatzki H, Kolb J, Patil S, Pu LL, Ren Y, Smith DG, Wheeler DA, Schenck I, Ball EV, Chen R, Cooper DN, Giardine B, Hsu F, Kent WJ, Lesk A, Nelson DL, O'brien WE, Prufer K, Stenson PD, Wallace JC, Ke H, Liu XM, Wang P, Xiang AP, Yang F, Barber GP, Haussler D, Karolchik D, Kern AD, Kuhn RM, Smith KE, Zwieg AS: Evolutionary and biomedical insights from the rhesus macaque genome. Science 2007, 316(5822):222–234. 10.1126/science.1139247

    Article  CAS  PubMed  Google Scholar 

  13. Golub GH, Wilkinson JH: Ill-Conditioned Eigensystems and the Computation of the Jordan Canonical Form. SIAM Review 1976, 18(4):578–619. 10.1137/1018113

    Article  Google Scholar 

  14. Ruhe A: Properties of a matrix with a very ill-conditioned eigenproblem. Numerische Mathematik 1970, 15: 57–60. 10.1007/BF02165660

    Article  Google Scholar 

  15. Alam R: On the construction of nearest defective matrices to a normal matrix. Linear Algebra and Its Applications 2005, 395: 367–370. 10.1016/j.laa.2004.09.008

    Article  Google Scholar 

  16. Chaitin-Chatelin F, Frayssé V: Lectures on Finite Precision Computations. Philadelphia: SIAM; 1996.

    Book  Google Scholar 

  17. Yang Z: Likelihood ratio tests for detecting positive selection and application to primate lysozyme evolution. Mol Biol Evol 1998, 15(5):568–73.

    Article  CAS  PubMed  Google Scholar 

  18. Knight R, Maxwell P, Birmingham A, Carnes J, Caporaso J, Easton B, Eaton M, Hamady M, Lindsay H, Liu Z, Lozupone C, McDonald D, Robeson M, Sammut R, Smit S, Wakefield M, Widmann J, Wikman S, Wilson S, Ying H, Huttley G: PyCogent: a toolkit for making sense from sequence. Genome Biol 2007, 8(8):R171. 10.1186/gb-2007-8-8-r171

    Article  PubMed Central  PubMed  Google Scholar 

  19. Meyer C: Matrix Analysis and Applied Linear Algebra. Society for Industrial Mathematics; 2000.

    Book  Google Scholar 

  20. Butterfield A, Vedagiri V, Lang E, Lawrence C, Wakefield MJ, Isaev A, Huttley GA: PyEvolve: a toolkit for statistical modelling of molecular evolution. BMC Bioinformatics 2004, 5: 1. 10.1186/1471-2105-5-1

    Article  PubMed Central  PubMed  Google Scholar 

  21. Numeric python[http://numpy.scipy.org]

Download references

Acknowledgements

This study was supported by funding from the ARC and NHMRC awarded to GAH and SE; from NIH (P01DK078669), and a time allocation on the Keck RNA Bioinformatics Facility at UC Boulder, awarded to RK; and, from the Singapore Ministry of Education AcRF R-155-050-054-133/R-155-050-054-101, awarded to VB Yap. We thank Micah Hamady for maintaining mirrors of the genome databases on the Keck RNA Bioinformatics Facility.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Gavin A Huttley.

Additional information

Authors' contributions

HS contributed to implementation of the matrix error measurements and interpretation; VBY contributed to implementation of constrained optimisation method, study design and interpretation; SE contributed to study design; RDK contributed to study design, microbial genome data sampling and interpretation; GAH contributed to study design, implementation of constrained optimisation, data sampling and interpretation.

Electronic supplementary material

12859_2008_2535_MOESM1_ESM.pdf

Additional File 1: A pathological rate matrix example. An analytical example of a matrix pathological to eigendecomposition. (PDF 28 KB)

Authors’ original submitted files for images

Below are the links to the authors’ original submitted files for images.

Authors’ original file for figure 1

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

Schranz, H.W., Yap, V.B., Easteal, S. et al. Pathological rate matrices: from primates to pathogens. BMC Bioinformatics 9, 550 (2008). https://doi.org/10.1186/1471-2105-9-550

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-9-550

Keywords