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

Incorporating phylogenetic-based covarying mutations into RNAalifold for RNA consensus structure prediction

Abstract

Background

RNAalifold, a popular computational method for RNA consensus structure prediction, incorporates covarying mutations into a thermodynamic model to fold the aligned RNA sequences. When quantifying covariance, it evaluates conserved signals of two aligned columns with base-pairing rules. This scoring scheme performs better than some other approaches, such as mutual information. However it ignores the phylogenetic history of the aligned sequences, which is an important criterion to evaluate the level of sequence covariance.

Results

In this article, in order to improve the accuracy of consensus structure folding, we propose a novel approach named PhyloRNAalifold. It incorporates the number of covarying mutations on the phylogenetic tree of the aligned sequences into the covariance scoring of RNAalifold. The benchmarking results show that the new scoring scheme of PhyloRNAalifold can improve the consensus structure detection of RNAalifold.

Conclusion

Incorporating additional phylogenetic information of aligned sequences into the covariance scoring of RNAalifold can improve its performance of consensus structures folding. This improvement is correlated with alignment characteristics, such as pair-wise identity and the number of sequences in the alignment.

Background

The discovery of novel non-coding RNA (ncRNA) families expanded our understanding of RNAs, which not only carry genetic codes for protein synthesis but also participate in other functions, especially the regulatory processes, such as localization, replication, translation and degradation [1-4]. In mammals, a substantial amount of transcripts (above 90%) are non-protein-coding, and most of them are functional [5, 6]. What’s more, the non-coding regions in the human genome are crucially important. For example, microRNA (miRNA) is used as a marker to differ normal tissues from tumors [7-9]; long non-coding RNA (lncRNA) also contributes to human disease etiology [10]. These findings fuel the research of RNA and also pose new challenges.

Unlike protein-coding genes, whose primary sequences can be applied for accurate functional prediction with statistical signals, RNAs’ functions depend on their secondary structures. Many computational methods have been proposed to fold RNA structures. One type of popular algorithms adopts Minimum Free Energy (MFE) model to fold a single RNA sequence, which has been implemented in Mfold [11] and RNAfold [12]. However, the structure prediction accuracy of this approach is limited. One major reason is that the precise energy parameters are hard to obtain experimentally [13]; on the other hand, the functional RNA structure may not be the one with the minimum energy [4]. What’s more, single sequence folding may not be applied to discover new RNA families even if the predicted structures are correct, because the statistical signals in an RNA secondary structure are not strong enough to distinguish itself from the stable structures folding from random sequences [14, 15].

Comparative methods can solve these problems by folding a consensus structure from multiple sequences, which not only improve the structure prediction accuracy, but also provide additional signals to discover novel RNAs [16]. The idea of this approach is that RNA secondary structures are conserved through evolution. Therefore, a consensus structure detected by comparing related RNA sequences should be more accurate and significant than the structure folded from a single sequence. With a consistent consensus structure, the specific structure of each sequence in the alignment can be obtained by constraint folding. A classic comparative method is the Sankoff algorithm [17]. Because constructing a precise structural alignment of RNA sequences is also a challenging problem, the Sankoff algorithm computes alignment and fold structure simultaneously. Excessive computational resources (O(n6)) are required by the Sankoff algorithm for a large-scale problem. Some implementations of this approach, such as Dynalign [18], Foldalign [19], LocARNA [20] and Conan [21], attempt to restrict its solution space by limiting the number of possible sub-structures. However these methods are still computationally expensive (O(n4)).

To reduce the computation complexity, comparative methods may align related sequences first and then detect conserved signals in the alignment to infer a consensus structure. One type of these methods extends the energy-based model from single sequences to alignments. Based on the assumption that high covariance of two aligned columns implies the conservation of pairing, all potential pairing columns in an alignment can be determined. After that the optimal consensus structure with minimum average free energy can be folded just as a single sequence structure. An example of covariance scoring scheme is Mutual Information (MI), which can measure the dependence of two columns in the alignments [22-24]. RNAalifold [25] adopts the basic idea of MI scoring and imports the pairing rules of RNA into the measurement of covariance. Another type of comparative methods is evolution-based. In these methods, no thermodynamic parameters but statistical learning algorithms are used. The evolutionary history of the aligned sequences is reformed with probability theories [26, 27], and the RNA secondary structures are modeled as stochastic context-free grammar (SCFG) [28-30]. Both strategies have their own strengths and weaknesses [31]. Some methods try to integrate both approaches. For example, PETfold extends Pfold [30], an evolution-based algorithm, to consider the energetically favorable base-pairs [32]. However, PETfold utilizes a Nussinov style model [33], which does not make full use of the energy parameters. RNAalifold also tested two other covariance scoring schemes to incorporate evolutionary information [25, 34], but neither of them yielded a better result.

In this article, we propose a novel method called PhyloRNAalifold. It improves RNAalifold by explicitly incorporating the phylogenetic tree of the aligned sequences into the computation of covariance scores. Like RNAalifold, PhyloRNAalifold detects pairing columns by evaluating covarying mutations and folds RNA structures through an MFE model. Unlike RNAalifold, which does not consider the relative positions of sequences in the phylogeny, PhyloRNAalifold counts the number of covarying mutations on the phylogenetic tree for each pair of columns with a parsimony approach. What’s more, comparing with PETfold, PhyloRNAalifold retains the Turner’s model [35] in RNAalifold, which describes RNA structures with many thermodynamic parameters derived from physical studies. With the supports of both energy-based model and evolution-based model, PhyloRNAalifold may detect consensus structures more precisely.

The rest of the article is organized as follows: in the methods section, we discuss the basic mechanism of RNAalifold, its shortcomings, and details of the PhyloRNAalifold algorithm. In the results section, we describe the benchmark datasets, experimental results, and the effect of parameters and alignment characteristics on our algorithm. In the discussion and conclusion section, we summarize our existing works and propose directions for future research.

Methods

Consensus folding energy and covariance score in RNAalifold

The basic approach of RNAalifold [25] is to integrate covarying mutation into the thermodynamic model to predict consensus structures. First, covariance scores are computed for all pairs of columns to determine possible pairing positions in the consensus structure. Then, based on the MFE model, the minimum average folding energy is computed with dynamic programming. Assume the given alignment is denoted by A, which contains N sequences A={ s 1 , s 2 ,, s N }. Each sequence contains L symbols, including nucleotides and gaps, and s i k represents the ith symbol (1≤iL) at the kth (1≤kN) RNA sequence. The minimization of free energy is computed by using the following recursive functions:

F i , j = min ( F i + 1 , j , min i < k j ( C i , k + F k + 1 , j ) ) C i , j = ϕ 2 γ i , j + min s k A H ( i , j , s k ) min i < p < q < j s k A I ( i , j , p , q , s k ) + C p , q min i < p < j F M i , p + FM 1 p + 1 , j + M a F M i , j = min F M i + 1 , j + M c min i < p < j C i , p + F M p + 1 , j + M b FM 1 i , j FM 1 i , j = min FM 1 i , j 1 + M c , C i , k
(1)

where Fi,j,Ci,j,F Mi,j,F M1i,j denote the minimum free energies for the region between ith column and jth column with unconstrained structure, with enclosed structure, with a multi-loop, and with a multi-loop containing a single branch, respectively. H(i,j,s) is the free energy for a hairpin loop enclosed by s i and s j , and I(i,j,p,q,s) is the free energy for an internal loop containing two base-pairs, one is between s i and s j and the other is between s p and s q . M a ,M c are penalties for closing bases and non-pairing bases in multi-loops. M b is the bonus for branch bases in multi-loops.

The recursive functions were derived from the Turner’s model [35]. One major change made by RNAalifold for consensus folding is the usage of covariance score γ. It is not only a factor in the computing of free energy, but also determines the possible pairing columns in the alignment. Two parts, one is bonus and the other is penalty, are in this score. The first part of the covariance score is called the conservation score. For ( s i k , s j k ) and ( s i l , s j l ), three levels of confidence for pairing are assessed: base-pairs without mutation, base-pairs with one mutation, and base-pairs with two mutations. In the latest version of Vienna RNA package (v2.0) [36], the recursive function for computing conservation score is:

V i , j = 1 N 1 k < l N h ( s i k , s i l ) + h ( s j k , s j l ) if ( s i k , s j k ) B and ( s i l , s j l ) B 0 otherwise
(2)

where h(x,y) is the Hamming distance between base x and base y, and B ={‘AU’, ‘UA’, ‘CG’, ‘GC’, ‘GU’, ‘UG’} is the set of all possible base-pairs. The second part is the penalty score Qi,j, which deals with a pair of symbols that cannot form a base-pair:

Q i , j = 1 k N 0 if ( s i k , s j k ) B 0 . 25 if s i k and s j k are gaps 1 otherwise
(3)

Overall, the covariance score is:

γ i , j = V i , j ϕ 1 × Q i , j
(4)

where ϕ1=ϕ2=1. A threshold value γ t =−2 is defined for γi,j. If γi,j>γ t , ith column and jth column are considered to be pairing columns. In the final output, the minimum average folding energy, including the covariance score, is normalized by dividing N.

Phylogenetic-based covarying mutation

RNAalifold incorporates covarying mutations into consensus folding to improve the detection of pairing columns. From Equation (2), it can be seen that RNAalifold counts the level of covariance by treating all sequences equally and try all possible combinations of base-pairs. In short, RNAalifold models the relationship of sequences as a complete graph. As a result, the specific evolutionary relationship among sequences in the phylogenetic history is ignored. Take the RNA structural alignment in Figure 1 as an example. The red and green columns achieve the same covariance score (2) in RNAalifold. However, as described in [37], the conservation evidence in Figure 1(c) is stronger than that in Figure 1(b) because at least two mutations occur at the green columns while only one is required to form the red ones.

Figure 1
figure 1

Covarying mutations in an RNA alignment. (a) A multiple RNA alignment and its phylogenetic tree. Three pairs of columns, which are marked with different colors, are analyzed in the following three sub-figures. (b) Possible covarying mutations in the red columns. In this case, only one pair-wise mutation is required at the root node. (c) Possible covarying mutations in the green columns. At least two pair-wise mutations occur at the internal nodes in this case; (d) Possible covarying mutations in the blue columns. There are non-pairing bases, ‘AG’ and ‘A-’. The label inference of the internal nodes does not depend on them. So in this case, the number of mutations is one.

PhyloRNAalifold models the relationship of aligned sequences as a tree by introducing the phylogenetic history of the alignment into the computation of covariance scores. The level of structural conservation is measured by the number of covarying mutations on the tree. Our assumption is that more covarying mutations on the tree mean stronger evidence of conservation. In addition, PhyloRNAalifold does not discard the original scoring scheme of RNAalifold, because experimental results showed this scheme can infer significant RNA structural aspects with high sensitivity and selectivity [38]. Assume mi,j covarying mutations occur between ith and jth columns on the alignment A’s phylogenetic tree and the number of base-pairs on those columns is bi,j. The value of mi,j depends on the size of the alignment. Since our approach focuses on improving the bonus part of the covariance scores, the number of covarying mutations is normalized with its upper bound: m i , j b i , j 1 . A new factor for the conservation score is proposed:

i , j =1+β× m i , j b i , j 1
(5)

where β is the scale parameter for the normalized covarying mutation numbers. PhyloRNAalifold computes covariance scores with the following formula:

γ i , j p = i , j × V i , j ϕ 1 × Q i , j
(6)

All the other parameters and their default values in RNAalifold are retained. Due to the fact that γ i , j p γ i , j (i,j≥1), two columns would be marked as pairing in PhyloRNAalifold if their covariance score in RNAalifold is greater than the threshold γ t (the default value of γ t is -2). Thus the advantage of PhyloRNAalifold is to import more potentially pairing positions with high mutation numbers.

Computing the number of covarying mutations

Given a phylogenetic tree and labels at its leaves, the Fitch algorithm can optimize nucleotide assignment of the internal nodes to minimize the number of mutations [39]. If we model solving phylogeny as a maximum parsimony problem, this number can be taken as the actual number of mutations. The Fitch algorithm consists of a forward phase and a backward phase. In the forward phase, all possible labels at each internal node are inferred. In addition, the number of mutations is estimated during a bottom-up traversal. In the backward phase, a top-down pass is performed to find the optimal label at each internal node. Only the forward algorithm is applied to PhyloRNAalifold, since we do not need the exact labels at the internal nodes, but only the number of mutations on the tree. Without loss of generality, we require T to be a rooted binary tree. r denotes the root of T and v, v l , v r denote a node, left child of v, and right child of v respectively. F(v) is the set of possible labels at node v, and c o s t(v) is the number of mutations on the sub-tree which is rooted at v. Then the forward phase can be described with the following recursive functions:

F ( v ) = F ( v l ) F ( v r ) if F ( v l ) F ( v r ) F ( v l ) F ( v r ) otherwise cost ( v ) = cost ( v l ) + cost ( v r ) if F ( v l ) F ( v r ) cost ( v l ) + cost ( v r ) + 1 otherwise
(7)

For each leaf, F(v) is a base at the corresponding sequence. After the computation is finished, c o s t(r) shows the minimum number of mutations on the phylogenetic tree. The optimization of this algorithm was proved in [40].

In Equation 5, the computation of i,j does not depend on non-pairing bases. Therefore, in the revised Fitch algorithm non-pairing bases need not to be considered when the number of covarying mutations is computed. We changed the original Fitch algorithm in two ways: (1) at any leaf node, if ( s i k , s j k )B, set ( s i k , s j k )= (‘-’, ‘-’); (2) for one internal node v, if the bases at v l (v r ) is (‘-’, ‘-’), v will obtain F(v r )(F(v l )) as its label. One example of this algorithm is shown in Figure 1(d). The revised Fitch algorithm can be described by using the following functions:

F ( v ) = F ( v l ) F ( v r ) if F ( v l ) F ( v r ) and F ( v l ) (‘-’, ‘-’) and F ( v r ) (‘-’, ‘-’) F ( v l ) if F ( v r ) = (‘-’, ‘-’) F ( v r ) if F ( v l ) = (‘-’, ‘-’) F ( v l ) F ( v r ) otherwise cost ( v ) = cost ( v l ) + cost ( v r ) if F ( v l ) F ( v r ) and F ( v l ) (‘-’, ‘-’) and F ( v r ) (‘-’, ‘-’) cost ( v l ) if F ( v r ) = (‘-’, ‘-’) cost ( v r ) if F ( v l ) = (‘-’, ‘-’) cost ( v l ) + cost ( v r ) + 1 otherwise
(8)

It is easy to see that our algorithm is optimal, because it only excludes non-pairing bases from the computation of the original Fitch algorithm.

In PhyloRNAalifold, the tree structure is an input variable and the clients can use any phylogenetic tree construction algorithm to build it. The time complexity of the original RNAalifold algorithm is O(m×n2+n3) [41], where n is the length of the alignment and m is the number of sequences in the alignment. The extra computation in PhyloRNAalifold is caused by the revised Fitch algorithm, whose time complexity ranges from O(logm) to O(m). In addition, PhyloRNAalifold needs to compute i,j for each pair of columns in the alignment. Thus the overall time consumption of the revised Fitch algorithm is O(logm×n2) or O(m×n2). Neither of them increases the time complexity of RNAalifold.

Results

Benchmarking datasets

The 19 Rfam [42] families used in the CMfinder paper [43] were selected as our first benchmarking dataset. It captures the diversity of known families by excluding highly conserved ones. Other programs, such as PETfold [32] and RNAalifold [34], also adopted it in their experiments. All the testing families came from Rfam version 11.0 and their seed alignments were used. In order to evaluate the dependence of our folding algorithm on the alignment quality, we also realigned the seeds with ClustalW [44] to generate the second benchmarking dataset. For this dataset, the predicted structure of the first sequence in each alignment was compared with its real consensus structure to measure the accuracy. Pair-wise identity and the number of sequences in an alignment are two important alignment characteristics. Pair-wise identity is related to the performance of consensus structure folding, while the number of members is important for inferring an accurate evolutionary history. To analyze these two factors, we generated the third benchmarking dataset which consisted of alignments with different number of sequences and identities. Member sequences were randomly picked from each seed alignment. For each family, we generated three sets. Each set included 50 alignments, and the alignments contained 5 sequences, 10 sequences and 20 sequences respectively. 7 families (ctRNA_pGA1, glmS, lin-4, Lysine, mir-10, s2m, Tymo_tRNA-like), whose sequences are less than 50, were excluded from this dataset because the diversity of generated alignments was too small.

PhyloRNAalifold requires a phylogenetic tree of the alignment to infer the consensus structural aspects. In our experiments, DNADIST and KITSCH in the PHYLIP package [45] were used to generate phylogenies. First DNADIST computed a distance matrix of the sequences. After that, KITSCH estimated a phylogenetic tree from the output matrix of DNADIST. The reason of using KITSCH was that it can generate rooted binary trees, which were required by PhyloRNAalifold. Another notable issue in this process is that if two sequences differ in more than 75% of their positions, DNADIST would set the distance between them to -1, which represents infinity. KITSCH rejects negative distances. Thus -1 was replaced with 1000 in distance matrices. We have checked all the positive sequence distances in our experiments. None of them exceeded 10, so 1000 is large enough to represent infinity.

The implementation of PhyloRNAalifold was on the top of program RNAalifold in the Vienna RNA package 2.0.7 [36]. The major change made by PhyloRNAalifold is to incorporate our Fitch module into the scoring scheme of RNAalifold. To test our idea, Matthews correlation coefficient (MCC) [46] was used to measure the accuracy of consensus structure prediction. Its definition is:

MCC= TP × TN FP × FN ( TP + FP ) ( TP + FN ) ( TN + FP ) ( TN + FN )
(9)

where T P,T N,F P,F N represent the number of true positives, true negatives, false positives, and false negatives, respectively. Additional predicted base-pairs that are not in the reference structure fall into two categories. Some base-pairs contradict reference, the others are compatible with it. Compatible base-pairs can be inserted into the known consensus structure, while adding contradictory base-pairs breaks the pairing rules. Only contradictory base-pairs were counted as false positive predictions.

Five algorithms, RNAalifold, RIBOSUM-based RNAalifold, PhyloRNAalifold, RIBOSUM-based PhyloRNAalifold, and PETfold, have been tested on the first two datasets. The first four have also been benchmarked on the third dataset. The RIBOSUM scoring scheme [47] is used in the latest version of Vienna RNA package. In this scheme, the sum of Hamming distance h( s i k , s i l )+h( s j k , s j l ) in conservation score was replaced by an entry in the RIBOSUM matrix R: R( s i k s j k , s i l s j l ). The experiment results in [34] showed that RIBOSUM-based RNAalifold outperformed the orignal RNAalifold in most of cases. In addition, the authors of [34] used ϕ1=0.6 and ϕ2=0.5 as the default parameters in their experiments. We applied their settings to make the comparison fair. The performance of PETfold was tested in our experiments too. We used the web-server of PETfold [48] and its default parameters.

Effect of parameter β

In the first experiment, we compared the structure prediction results of PhyloRNAalifold with RNAalifold on the original CMfinder dataset. Default values for ϕ1, ϕ2 and γ t were used, and β was a variable ranging from 1 to 15. Figure 2 shows that the novel scoring scheme of PhyloRNAalifold improves the performance of RNAalifold in nearly all cases, except β=1. The differences of average MCC in both cases, with or without using RIBOSUM matrix, become larger when β is increased, and they are maximized at β=10. The largest differences are 0.079 and 0.033 for RIBOSUM supported and non-RIBOSUM supported algorithms. After that, the performance of PhyloRNAalifold is not boosted with the increasing of β. In the following experiments, we select 10 as a default value for β.

Figure 2
figure 2

MCC on the CMfinder dataset as a function of the β parameter. The MCC results of PhyloRNAalifold, with and without RIBOSUM matrix support, are shown in this figure. The dash lines are references for the curves, which show the performance of RNAalifold on the same dataset. It can be seen that except for β=1, the new phylogenetic-based covariance scoring scheme improves the performance of RNAalifold.

Benchmarking with other methods

Table 1 summarizes all results of the consensus structure predictions on the structural alignments. PhyloRNAalifold with RIBOSUM support achieves the best average MCC score. When RIBOSUM matrix is incorporated, the score difference between PhyloRNAalifold and RNAalifold becomes smaller. This may suggest that by using RIBOSUM matrix, RNAalifold quantifies the conservation among base-pairs more precisely than its original solution. The advantage of using phylogenetic history is swamped by this strategy to some extent. The average specificity scores of five algorithms are the same, while PhyloRNAalifold and PETfold have two largest average sensitivity scores. It is evidence of evolutionary information helping the energy-based folding algorithms to detect more base-pairs with introducing very few errors. An interesting observation is that Cobalamin has relative low MCC scores for RNAalifold. PhyloRNAalifold improves the accuracy of the consensus structure prediction of Cobalamin greatly. In addition, PETfold has the best performance on this family among all five algorithms. We checked the consensus structure of Cobalamin and the predicted results of RNAalifold. One possible reason is that there are too many gaps and non-pairing bases at its pairing columns, which decrease the covariance scores of those columns in RNAalifold greatly. Without the bonus from evolutionary information, those columns cannot be detected by RNAalifold at all.

Table 1 The benchmarking results on the structural alignments of the CMfinder dataset ( β=10)

Table 2 shows the results on the non-structural alignments of the CMfinder dataset. In this case, RIBOSUM-based PhyloRNAalifold still achieves the highest average MCC score. The performance of RNAalifold with RIBOSUM support is almost the same as that of the top one algorithm. What’s more, PETfold, which has a larger average MCC score in the previous experiment than RIBOSUM-based RNAalifold, falls to third place. This suggests that the evolutionary information at the pairing columns may be disrupted by ClustalW, whose alignment function does not consider secondary structures.

Table 2 The benchmarking results on the non-structural alignments of the CMfinder dataset ( β=10)

Effects of identity and the number of sequences

In this experiment, we try to analyze the correlation of two alignment characteristics, pair-wise identity and the number of sequences, with the performance of PhyloRNAalifold. Figure 3 shows the experiment results. It can be seen that all four algorithms have similar performance when the number of sequences in the alignments is 5. With the increasing of the members in the alignments, the average MCC difference between PhyloRNAalifold and RNAalifold becomes larger. Using more sequences provides a more precise phylogenetic history, so it is reasonable that PhyloRNAalifold achieves its best performance on alignments with 20 sequences. In addition, for experiments on the alignments of 10 sequences and 20 sequences, the maximum performance difference exists between the pair-wise identities 65 and 80. If the pair-wise identity of an alignment is small, the original covariance scoring scheme of RNAalifold works well enough because a large number of different base-pairs at the pairing columns provide substantial conservational signals. On the other hand, when the alignment’s pair-wise identity is too large, all the symbols at the pairing columns are almost the same. The effect of our new covariance scoring scheme is reduced due to the lack of evolutionary information.

Figure 3
figure 3

The effect of alignment pair-wise identity and sequence number on the structural prediction of PhyloRNAalifold ( β=10 ). The MCC results of PhyloRNAalifold and RNAalifold on the third benchmarking dataset are shown in this figure. It can be seen that the performance difference between PhyloRNAalifold and RNAalifold increases with the increasing of the sequence number in the alignments. In addition, the maximum MCC difference is achieved in the range of 6575 identities.

Discussion and conclusion

We have proposed a novel approach, PhyloRNAalifold, to fold RNA consensus structures by evaluating the level of conservation in aligned RNA sequences. With an evolution-based covariance scoring scheme, PhyloRNAalifold can detect more potential pairing columns than RNAalifold. The benchmark testing shows that PhyloRNAalifold can improve the performance of RNAalifold, as well as PETfold.

There are two possible directions for further research. The first direction is to analyze the dependence of PhyloRNAalifold on the phylogenetic tree construction algorithms. Tree structures have great effect on the RNA structure prediction of PhyloRNAalifold. Besides DNADIST and KITSCH, there are other algorithms, such as UPGMA [49], PAUP [50] and MrBayes [51], which can construct alternative trees. Finding or design an optimal algorithm for detecting the phylogenetic information in the pairing columns is an open question. Ideally, structure conservation should be considered because it is crucial for evaluating the similarity between two RNA sequences. The second direction deals with incorporating the phylogenetic information of non-pairing bases into the folding algorithm. Only covarying mutations among base-pairs are considered in PhyloRNAalifold. In probabilistic methods, all the possible mutations, including mutations in loop regions and stack regions, are modeled with HMM. Our goal is to incorporate both types of mutations into PhyloRNAalifold, while still keep the simplicity of the scoring scheme.

Availability

The latest version of PhyloRNAalifold can be downloaded at: http://genome.ucf.edu/PhyloRNAalifold.

References

  1. Eddy SR: Non-coding RNA genes and the modern RNA world. Nat Rev Genet. 2001, 2 (12): 919-929. 10.1038/35103511.

    Article  CAS  PubMed  Google Scholar 

  2. Mattick JS: Challenging the dogma: the hidden layer of non-protein-coding RNAs in complex organisms. Bioessays. 2003, 25 (10): 930-939. 10.1002/bies.10332.

    Article  CAS  PubMed  Google Scholar 

  3. He L, Hannon GJ: MicroRNAs: small RNAs with a big role in gene regulation. Nat Rev Genet. 2004, 5 (7): 522-531. 10.1038/nrg1379.

    Article  CAS  PubMed  Google Scholar 

  4. Mandal M, Breaker RR: Gene regulation by riboswitches. Nat Rev Mol Cell Biol. 2004, 5 (6): 451-463. 10.1038/nrm1403.

    Article  CAS  PubMed  Google Scholar 

  5. The ENCODE Project Consortium: An integrated encyclopedia of DNA elements in the human genome. Nature. 2012, 489 (7414): 57-74. 10.1038/nature11247.

    Article  Google Scholar 

  6. The FANTOM Consortium: The transcriptional landscape of the mammalian genome. Science. 2005, 309 (5740): 1559-1563.

    Article  Google Scholar 

  7. Esquela-Kerscher A, Slack FJ: Oncomirs - microRNAs with a role in cancer. Nat Rev Cancer. 2006, 6 (4): 259-269.

    Article  CAS  PubMed  Google Scholar 

  8. Croce CM: Causes and consequences of microRNA dysregulation in cancer. Nat Rev Genet. 2009, 10 (10): 704-714. 10.1038/nrg2634.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  9. Nicoloso MS, Spizzo R, Shimizu M, Rossi S, Calin GA: MicroRNAs-the micro steering wheel of tumour metastases. Nat Rev Cancer. 2009, 9 (4): 293-302.

    Article  CAS  PubMed  Google Scholar 

  10. Mercer TR, Dinger ME, Mattick JS: Long non-coding RNAs insights into functions. Nat Rev Genet. 2009, 10 (3): 155-159. 10.1038/nrg2521.

    Article  CAS  PubMed  Google Scholar 

  11. Zuker M, Stiegler P: Optimal computer folding of large RNA sequences using thermodynamics and auxiliary information. Nucleic Acids Res. 1981, 9: 133-148. 10.1093/nar/9.1.133.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  12. Hofacker IL, Fontana W, Stadler PF, Bonhoeffer SL, Tacker M, Schuster P: Fast folding and comparison of RNA secondary structures. Monatsh Chem. 1994, 125: 167-188. 10.1007/BF00818163.

    Article  CAS  Google Scholar 

  13. Jaeger JA, Turner DH, Zuker M: Improved predictions of secondary structures for RNA. Proc Natl Acad Sci USA. 1989, 86 (20): 7706-7710. 10.1073/pnas.86.20.7706.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  14. Workman C, Krogh A: No evidence that mRNAs have lower folding free energies than random sequences with the same dinucleotide distribution. Nucleic Acids Res. 1999, 27 (24): 4816-4822. 10.1093/nar/27.24.4816.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  15. Rivas E, Eddy SR: Secondary structure alone is generally not statistically significant for the detection of noncoding RNAs. Bioinformatics. 2000, 16 (7): 583-605. 10.1093/bioinformatics/16.7.583.

    Article  CAS  PubMed  Google Scholar 

  16. Woese CR, Pace NR: 4 Probing RNA structure, function, and history by comparative analysis. Cold Spring Harbor Monograph Archive. 1993, 24: 91-117.

    Google Scholar 

  17. Sankoff D: Simultaneous solution of the RNA folding, alignment and protosequence problems. SIAM J Appl Math. 1985, 45 (5): 810-825. 10.1137/0145048.

    Article  Google Scholar 

  18. Harmanci AO, Sharma G, Mathews DH: Efficient pairwise RNA structure prediction using probabilistic alignment constraints in Dynalign. BMC Bioinformatics. 2007, 8: 130-10.1186/1471-2105-8-130.

    Article  PubMed Central  PubMed  Google Scholar 

  19. Havgaard JH, Torarinsson E, Gorodkin J: Fast pairwise structural RNA alignments by pruning of the dynamical programming matrix. PLoS Comput Biol. 2007, 3 (10): 1896-1908.

    Article  CAS  PubMed  Google Scholar 

  20. Will S, Reiche K, Hofacker IL, Stadler PF, Backofen R: Inferring noncoding RNA families and classes by means of genome-scale structure-based clustering. PLoS Comput Biol. 2007, 3 (4): e65-10.1371/journal.pcbi.0030065.

    Article  PubMed Central  PubMed  Google Scholar 

  21. Dowell RD, Eddy SR: Efficient pairwise RNA structure prediction and alignment using sequence alignment constraints. BMC Bioinformatics. 2006, 7: 400-10.1186/1471-2105-7-400.

    Article  PubMed Central  PubMed  Google Scholar 

  22. Chiu DKY, Kolodziejczak T: Inferring consensus structure from nucleic acid sequences. Comput Appl Biosci : CABIOS. 1991, 7 (3): 347-352.

    CAS  PubMed  Google Scholar 

  23. Gutell RR, Woese CR: Higher order structural elements in ribosomal RNAs: pseudo-knots and the use of noncanonical pairs. Proc Natl Acad Sci USA. 1990, 87 (2): 663-667. 10.1073/pnas.87.2.663.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  24. Gutell RR, Power A, Hertz GZ, Putz EJ, Stormo GD: Identifying constraints on the higher-order structure of RNA: continued development and application of comparative sequence analysis methods. Nucleic Acids Res. 1992, 20 (21): 5785-5795. 10.1093/nar/20.21.5785.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  25. Hofacker IL, Fekete M, Stadler PF: Secondary structure prediction for aligned RNA sequences. J Mol Biol. 2002, 319 (5): 1059-1066. 10.1016/S0022-2836(02)00308-X.

    Article  CAS  PubMed  Google Scholar 

  26. Eddy SR, Durbin R: RNA sequence analysis using covariance models. Nucleic Acids Res. 1994, 22 (11): 2079-2088. 10.1093/nar/22.11.2079.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  27. Pedersen JS, Bejerano G, Siepel A, Rosenbloom K, Lindblad-Toh K, Lander ES, Kent J, Miller W, Haussler D: Identification and classification of conserved RNA secondary structures in the human genome. PLoS Comput Biol. 2006, 2 (4): e33-10.1371/journal.pcbi.0020033.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  28. Sakakibara Y, Brown M, Hughey R, Mian IS, Sjolander K, Underwood RC, Haussler D: Stochastic context-free grammars for tRNA modeling. Nucleic Acids Res. 1994, 22 (23): 5112-5120. 10.1093/nar/22.23.5112.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  29. Knudsen B, Hein J: RNA secondary structure prediction using stochastic context-free grammars and evolutionary history. Bioinformatics. 1999, 15 (6): 446-454. 10.1093/bioinformatics/15.6.446.

    Article  CAS  PubMed  Google Scholar 

  30. Knudsen B, Hein J: Pfold: RNA secondary structure prediction using stochastic context-free grammars. Nucleic Acids Res. 2003, 31 (13): 3423-3428. 10.1093/nar/gkg614.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  31. Do CB, Woods DA, Batzoglou S: CONTRAfold: RNA secondary structure prediction without physics-based models. Bioinformatics. 2006, 22 (14): e90-e98. 10.1093/bioinformatics/btl246.

    Article  CAS  PubMed  Google Scholar 

  32. Seemann SE, Gorodkin J, Backofen R: Unifying evolutionary and thermodynamic information for RNA folding of multiple alignments. Nucleic Acids Res. 2008, 36 (20): 6355-6362. 10.1093/nar/gkn544.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  33. Nussinov R, Pieczenik G, Griggs J, Kleitman D: Algorithms for Loop matchings. SIAM J Appl Math. 1978, 35: 68-82. 10.1137/0135006.

    Article  Google Scholar 

  34. Bernhart SH, Hofacker IL, Will S, Gruber AR, Stadler PF: RNAalifold: improved consensus structure prediction for RNA alignments. BMC Bioinformatics. 2008, 9: 474-10.1186/1471-2105-9-474.

    Article  PubMed Central  PubMed  Google Scholar 

  35. Zuker M: On finding all suboptimal foldings of an RNA molecule. Science. 1989, 244 (4900): 48-52. 10.1126/science.2468181.

    Article  CAS  PubMed  Google Scholar 

  36. Lorenz R, Bernhart SH, Honer Zu Siederdissen C, Tafer H, Flamm C, Stadler PF, Hofacker IL: ViennaRNA Package 2.0. Algorithms Mol Biol. 2011, 6: 26-10.1186/1748-7188-6-26.

    Article  PubMed Central  PubMed  Google Scholar 

  37. Gulko B, Haussler D: Using multiple alignments and phylogenetic trees to detect RNA secondary structure. Biocomputing: Proceedings of the 1996 Pacific Symposium. 1996, 350-367.

    Google Scholar 

  38. Washietl S, Hofacker IL: Consensus folding of aligned sequences as a new measure for the detection of functional RNAs by comparative genomics. J Mol Biol. 2004, 342: 19-30. 10.1016/j.jmb.2004.07.018.

    Article  CAS  PubMed  Google Scholar 

  39. Fitch WM, Margoliash E: Construction of phylogenetic trees. Science. 1967, 155 (3760): 279-284. 10.1126/science.155.3760.279.

    Article  CAS  PubMed  Google Scholar 

  40. Waterman MS: Introduction to Computational Biology: Maps, Sequences and Genomes. 1995, London: Chapman and Hall

    Book  Google Scholar 

  41. Xia F, Dou Y, Zhou X, Yang X, Xu J, Zhang Y: Fine-grained parallel RNAalifold algorithm for RNA secondary structure prediction on FPGA. BMC Bioinformatics. 2009, 10 (Suppl 1): S37-10.1186/1471-2105-10-S1-S37.

    Article  PubMed Central  PubMed  Google Scholar 

  42. Gardner PP, Daub J, Tate J, Moore BL, Osuch IH, Griffiths-Jones S, Finn RD, Nawrocki EP, Kolbe DL, Eddy SR, Bateman A: Rfam: Wikipedia, clans and the “decimal” release. Nucleic Acids Res. 2011, 39 (Database issue): D141-D145.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  43. Yao Z, Weinberg Z, Ruzzo WL: CMfinder-a covariance model based RNA motif finding algorithm. Bioinformatics. 2006, 22 (4): 445-452. 10.1093/bioinformatics/btk008.

    Article  CAS  PubMed  Google Scholar 

  44. Larkin MA, Blackshields G, Brown NP, Chenna R, McGettigan PA, McWilliam H, Valentin F, Wallace IM, Wilm A, Lopez R, Thompson JD, Gibson TJ, Higgins DG: Clustal W and Clustal X version 2.0. Bioinformatics. 2007, 23 (21): 2947-2948. 10.1093/bioinformatics/btm404.

    Article  CAS  PubMed  Google Scholar 

  45. Felsenstein J: PHYLIP - Phylogeny Inference Package (Version 3.2). Cladistics. 1989, 5: 164-166.

    Google Scholar 

  46. Gardner PP, Giegerich R: A comprehensive comparison of comparative RNA structure prediction approaches. BMC Bioinformatics. 2004, 5: 140-10.1186/1471-2105-5-140.

    Article  PubMed Central  PubMed  Google Scholar 

  47. Klein RJ, Eddy SR: RSEARCH: finding homologs of single structured RNA sequences. BMC Bioinformatics. 2003, 4: 44-10.1186/1471-2105-4-44.

    Article  PubMed Central  PubMed  Google Scholar 

  48. Seemann SE, Menzel P, Backofen R, Gorodkin J: The PETfold and PETcofold web servers for intra- and intermolecular structures of multiple RNA sequences. Nucleic Acids Res. 2011, 39 (Web Server issue): W107-W111.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  49. Sokal RR, Michener CD: A statistical method for evaluating systematic relationships. University Kansas Scienti Bull. 1958, 28: 1409-1438.

    Google Scholar 

  50. Swofford DL: PAUP: Phylogenetic Analysis Using Parsimony (and other Methods). 2002, Sunderland Massachusettss: Sinauer Associates

    Google Scholar 

  51. Huelsenbeck JP, Ronquist F: MRBAYES: Bayesian inference of phylogenetic trees. Bioinformatics. 2001, 17 (8): 754-755. 10.1093/bioinformatics/17.8.754.

    Article  CAS  PubMed  Google Scholar 

Download references

Acknowledgements

This work is supported in part by a University of Central Florida In-House Award and the National Institute of General Medical Sciences of the National Institutes of Health (R01GM102515).

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Shaojie Zhang.

Additional information

Competing interests

Both authors declare that they have no competing interests.

Authors’ contributions

SZ conceived of the study and designed the algorithm. PG implemented the algorithm and carried out the benchmarking tests. Both authors wrote and approved the manuscript.

Authors’ original submitted files for images

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

Authors’ original file for figure 1

Authors’ original file for figure 2

Authors’ original file for figure 3

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

Ge, P., Zhang, S. Incorporating phylogenetic-based covarying mutations into RNAalifold for RNA consensus structure prediction. BMC Bioinformatics 14, 142 (2013). https://doi.org/10.1186/1471-2105-14-142

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-14-142

Keywords