Next Article in Journal
Non-Invasive Prenatal Testing: Current Perspectives and Future Challenges
Next Article in Special Issue
DIANA-mAP: Analyzing miRNA from Raw NGS Data to Quantification
Previous Article in Journal
MYC DNA Methylation in Prostate Tumor Tissue is Associated with Gleason Score
Previous Article in Special Issue
RNAflow: An Effective and Simple RNA-Seq Differential Gene Expression Pipeline Using Nextflow
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

RNA Secondary Structures with Limited Base Pair Span: Exact Backtracking and an Application

by
Ronny Lorenz
1,* and
Peter F. Stadler
1,2,3,4,5,*
1
Institute for Theoretical Chemistry, University of Vienna, Währingerstraße 17, A-1090 Vienna, Austria
2
Bioinformatics Group, Department of Computer Science, and Interdisciplinary Center for Bioinformatics, German Centre for Integrative Biodiversity Research (iDiv) Halle-Jena-Leipzig, Competence Center for Scalable Data Services and Solutions, and Leipzig Research Center for Civilization Diseases, University of Leipzig, Härtelstraße 16-18, D-04107 Leipzig, Germany
3
Max Planck Institute for Mathematics in the Sciences, Inselstraße 22, D-04103 Leipzig, Germany
4
Facultad de Ciencias, Universidad National de Colombia, Sede Bogotá 111321, Colombia
5
Santa Fe Institute, 1399 Hyde Park Rd., Santa Fe, NM 87501, USA
*
Authors to whom correspondence should be addressed.
Genes 2021, 12(1), 14; https://doi.org/10.3390/genes12010014
Submission received: 24 November 2020 / Revised: 18 December 2020 / Accepted: 21 December 2020 / Published: 24 December 2020
(This article belongs to the Special Issue Algorithms and Workflows in RNA Bioinformatics)

Abstract

:
The accuracy of RNA secondary structure prediction decreases with the span of a base pair, i.e., the number of nucleotides that it encloses. The dynamic programming algorithms for RNA folding can be easily specialized in order to consider only base pairs with a limited span L, reducing the memory requirements to O ( n L ) , and further to O ( n ) by interleaving backtracking. However, the latter is an approximation that precludes the retrieval of the globally optimal structure. So far, the ViennaRNA package therefore does not provide a tool for computing optimal, span-restricted minimum energy structure. Here, we report on an efficient backtracking algorithm that reconstructs the globally optimal structure from the locally optimal fragments that are produced by the interleaved backtracking implemented in RNALfold. An implementation is integrated into the ViennaRNA package. The forward and the backtracking recursions of RNALfold are both easily constrained to structural components with a sufficiently negative z-scores. This provides a convenient method in order to identify hyper-stable structural elements. A screen of the C. elegans genome shows that such features are more abundant in real genomic sequences when compared to a di-nucleotide shuffled background model.

1. Introduction

Long-range base pairs are notoriously difficult to predict in RNA structures. The main reasons are that parts of the folding process in very long RNAs, say beyond a few hundred nucleotides, are likely to be influenced by co-transcriptional folding, and that RNAs are rarely, if ever, isolated in the cell. Consequently, long-range base pairs often do not fold as predicted by thermodynamic folding rules alone [1,2,3]. Performance limitations are also a consideration for very long sequences, since the effort grows cubicly with the sequence length n. Several tools have become available, which restrict the span of base pairs ( k , l ) to l k + 1 L , including RNALfold [4], Rfold [5], and LocalFold [6]. An alternative approach penalizes long-range base pairs by reducing their energy contribution [2]. The two ideas were combined in [3]. Here, a sigmoidal function is used in order to interpolate between the full energy parameters and an upper bound on the base pair span. Restrictions on the base pair span are easily incorporated into the dynamic programming recursions [4,5,6]. This has the added benefit of resulting in an asymptotically linear resource consumption, namely O ( L 2 n ) time and O ( L n ) memory in terms of the sequence length n and the maximum base pair span L. The main memory requirement can be reduced to O ( n + L 2 ) by writing intermediate results to the disk. This makes it possible to scan an entire genome for local secondary structure elements.
In this contributionm we first close a gap in the implementation of the ViennaRNA package [7,8]. The RNALfold program provides a tool for computing minimum free energy structure with limited span in O ( n + L 2 ) memory, but it only produces local candidate structures. Here, we show that these local structures can be assembled efficiently, in O ( n L ) time, in order to yield the global minimum energy structure. We then discuss an additional restriction to unexpectedly stable local secondary structures, and, finally, sketch some application scenarios.

2. Theory

2.1. Backtracking from External Memory

Consider the problem of folding RNA structure with a maximal base pair span L, i.e., for every base pair ( i , j ) holds j i + 1 L . In the following, we write D k l for the optimal sub-structure on the sequence interval [ k , l ] subject to the additional condition that the interval contains a single component, i.e., a substructure that is enclosed by base pair that itself is not contained inside any other base pair. Furthermore, we write C k l for the minimal free energy of a structure that is enclosed by the base pair ( k , l ) . In order to accomodate the so-called dangling ends appearing in the standard (Turner) energy model [9], we set
D k l = min { C k l , C k + 1 , l + d 5 ( k ) , C k , l 1 + d 3 ( l ) , C k + 1 , l 1 + d ( k , l ) }
Here, d 5 ( . ) , d 3 ( . ) , and d ( . ) denote the 5’- and 3’- dangle parameters, and the dangling mismatch energy contributions, resp. The recursions that involve D k l correspond to an ambiguous decomposition of the secondary structure. Thus they can be used for energy minimization, but they cannot be translated directly for probabilistic models and partition function calculations. In the absence of dangling end contributions, we may use D k l = C k l .
The basic idea of RNALfold [4] can be summarized, as follows: denote, by f k , the optimal free energy of a secondary structure with maximal base pair span L on the interval [ k , n ] . This quantity satisfies the recursion
f k = min f k + 1 min k < l k + L 1 D k l + f l + 1
The first alternative shown in Equation (2) corresponds to k being unpaired (and not subject to a dangling end contribution). The second alternative corresponds to a structure beginning with a single component structure of energy D k l . As noted in [4], a structure realizing D k l needs to be considered to be a possible part of the minimum free energy structure only if f k < f k + 1 . Otherwise, the extension of a substructure on [ k + 1 , l ] by an unpaired base at position k can be chosen instead. The index position l is determined by an evaluation of Equation (2) in the next step of the recursion.
The idea of span-restricted structures is also of interest in the context of maximum expected accuracy (MEA) methods [10,11]. The expected accuracy of a given secondary structure Ψ is the sum of its base pairing probabilities p ^ i j , ( i , j ) Ψ , plus the sum of probabilities p ^ k : = 1 j < k p ^ j k j > k p ^ k j for the unpaired positions. Instead of treating this as a maximization problem, we mininimize S i j , the negative of the accuracy. This highlights the similiarity of the MEA recursions with the thermodynamic folding models. MEA requires the base pairing probabolites p ^ k l as input. Therefore, these are computed with alternate methods, e.g., the partition function version of RNALfold [4], Rfold [5], or as the average over sequence windows that enclose the base pair of interest, as in RNAplfold [12] or LocalFold [6]. MEA models also use the weight p ^ k : = 1 j < k p ^ j k j > k p ^ k j for base k to be unpaired, which leads to a slight generalization of Equation (2):
f k = min D k + f k + 1 min k < l k + L 1 D k l + f l + 1
Here, an unpaired position k contributes D k = p ^ k instead of 0, and the contributions of a single-component structure that is enclosed by the pair ( k , l ) becomes D k l = ( p ^ k l ) + S k + 1 , l 1 . The negative expected accuracy S k l follows the Nussinov-like [13] recursion
S k l = min ( p ^ k ) + S k + 1 , l min k < j l ( p ^ k j ) + S k + 1 , j 1 + S j + 1 , l
with S k k : = p ^ k and the convention that S l + 1 , l = 0 for the empty interval. The condition for local structure candidates also needs to be modified in order to account for the contribution of unpaired bases and it becomes
f k < D k + f k + 1 ,
in the general case. Note that it is not necessary to store all of the values of the matrix D k l in the forward recursion. Instead, we backtrack at position k the optimal structure whenever f k satisfies the second alternative shown in Equation (3) and only record that structure and the values of p ^ k l for the base pairs in that structure. Optimal structures contained as substructures in a larger one are omitted, as in the MFE case.
The same scheme applies to generalization of the MEA structures. In order to obtain the centroid structure [14], it suffices to consider only the base pairs with p ^ k l 1 / 2 . The γ -centroid that was proposed in [15] is obtained by p ^ k 0 and p ^ k l ( γ + 1 ) p ^ k l 1 . Similar expressions pertain to the estimators discussed in [16].

2.2. Increased Memory Efficiency by Reduced Redundancy

RNALfold reduces the memory requirements of the algorithm by only keeping a small part of the D (or C) matrices in memory, namely the range [ k , k + L 1 ] that is necessary to evaluate Equation (2). Instead of storing the dynamic programming tables to enable backtracking, RNALfold immediately backtracks a single-component structure Ψ k l k for k and then stores it on disk. Here, l k is the end position of the first component of an optimal structure on [ k , n ] . Because of the restriction on the span L, we know a priori that this structure cannot reach beyond the interval [ k , k + L ] , i.e., l k k + L . More precisely, the end position l k is the value of l, for which the minimum in Equation (2) is attained. In the most straighforward version, the triple ( k , Ψ k l k , D k l k ) is written to disk, where triples of the form ( k , . , D k k ) can be omitted in minimum energy directed folding, since D k k = 0 , by definition, for all exterior bases.
In the simplest case, the substructure Ψ k l k are stored in dot-parenthesis notation. Ref. [4] already noted that (together with the sequence information) these are sufficient for constructing the globally optimal secondary structure. In the case of MEA structures, D k l also needs to be stored explicitly. The required disk space is O ( n L ) . It can be reduced by a considerable constant factor; however, since the energy of a given structure can be evaluated in linear time. Therefore, it suffices to store structures ( k , Ψ k l k ) that are maximal in the sense that there is no ( k , Ψ k l k ) , such that Ψ k l k is proper substructure of Ψ k l k . In addition, inthe case of MEA structures, we need the proabilities p ^ j and p ^ i j for the unpaired bases and the base pairs in the candidate structure in order to be able to compute the D k l value for substructures that have not been explicitly stored.
In the case of MFE structures, the energy of a stored structure can be directly evaluated from the energy model. In the case of MEA structures; however, the base pairing probabilities, or more generally the derived scores, p ^ k l of all pairs ( k , l ) as well as the scores of the unpaired p ^ k of all unpaired positions must be available in the input. An implementation of the MEA option is forthcoming.
So far, backtracking of the global MFE or MEA structure in not available in RNALfold. Here, we close this gap. Backtracking starts from the 5’ end, i.e., from the end of the file storing the candidate fragments. For a given k, the task is to find l k , such that f k = D k , l k + f l + 1 , unless f k = D k + f k + 1 . In the latter case position k is unpaired and the recursion continues with k k + 1 . The difficulty in the first case is that there is not necessarily an entry for k in the output of RNALfold. However, it suffices to consider the set of candidate structure that contain position k, i.e.,
L ( k ) : = { Ψ k , l k | k [ k , l k ] }
For each Ψ in L ( k ) , one can determine in linear time the corresponding candidate structures, as follows: (1) determine the base pair ( p , q ) in Ψ with the smallest value of p k . If the base following q is paired, the only candidate is the restriction Ψ [ k , q ] . In the case of an model with dangling ends, both Ψ [ k , q ] and Ψ [ k , q + 1 ] must be considered. The free energies ε ( Ψ [ k , q ] ) and ε ( Ψ [ k , q + 1 ] ) for these (explicitly given) sub-structures can be evaluated in linear time. Then one has to check, for Ψ L ( k ) and q = q and, in the case of dangling ends, also q = q + 1 , where the structure satisfies
f k = ε ( Ψ [ k , q ] ) + f q + 1 .
The evaluation continues at position k q + 1 , where q is the first alternative for which equality is found in Equation (7). The backtracking method is also applicable without change to computations with constrained structures [17], since it only relies on the fact that a structure fragment is available in the output of the forward recursion that satisfies Equation (7).

2.3. Performance Analysis and Implementation

A naïve estimate of the CPU requirement that is required for backtracking yields an upper bound of O ( n L 2 ) , since | L ( k ) | contains, at most, O ( L ) entries of size at most O ( | L | ) , each of which certainly can be evaluated in linear time. However, it is not necessary to construct the list L ( k ) “from scratch” in each step. Instead, for each position k, at most one additional entry Ψ k , l k is added to the list, and every other entry can be “edited” after it has been processed for position k 1 by removing from the 5 end a leading unpaired position or the base pair ( k 1 , l k 1 ) , respectively, as well as any structures trailing ( k , l k + 1 ) . Assuming that the dot-parenthesis structure has been converted into an ordered list of base pairs, the effort to adjust a list entry requires only constant time to obtain Ψ [ k , l k ] from Ψ [ k 1 , l k 1 ] . Thus, the evaluation of the energies or MEA scores requires only constant effort for each position that is removed. Because the total size of the stored structures is bounded by O ( n L ) , the total effort for backtracking is also bounded by O ( n L ) .
The backtracking algorithm is integrated into the ViennaRNA package and it si available for RNALfold with the command line option -b/--backtrack-global. Empirical tests, see Figure 1, show that the implementation conforms to the theoretical O ( n L ) performance bound.

2.4. New Options in RNALfold

In order to better support genome-wide screens for structured RNA elements, we added options to filter structural components, which is, maximal substructures that are enclosed by a base pair. This is motivated, in particular, by the observation that the secondary structures of many structured small ncRNAs are more stable than expected from their sequence composition [18,19,20]. This effect is particularly pronounced for miRNAs [21]. This relative stabilization for a candidate sequence x is conveniently quantified as a z-score, z ( x ) : = ( f ( x ) f ¯ ) / σ f , where f ( x ) is the folding energy of x, and f ¯ and σ f denote the mean and standard deviation of the folding energies of an ensemble of sequences with the same sequence composition. Computing z ( x ) can be viewed as a regression problem in terms of parameters that specify the composition of x [22]. Here, we use the SVM model of RNAz 2.0 [23], which explicitly depends on dinucleotide frequencies.
The regression approach, in contrast to shuffling, allows for a very fast (and deterministic) computation of the z-score z k l C of the sub-structure that is enclosed by the base pair ( k , l ) . This can be used in two ways to restrict the predicted structure to components with z k l C below a user-defined threshold z : (1) one can already restrict the forward recursion Equation (2) to base pairs enclosing components with a sufficiently negative z-score (pre-filter), and (2) one can suppress components with an insufficient z-score in the backtracking step (post-filter). The two methods are not equivalent. For example, in case (2), it is possible that larger component structure with better MFE but below-threshold z-score is computed at the expense of a smaller structure with better z-score.
Both of the methods have been implemented in RNALfold. The restriction of the forward recursion is accessed with the new option RNALfold --zscore-pre-filter. Backtracking is then unaffected by the restriction to components that surpass the z-score threshold. As an alternative, filtered backtracking of the unmodified RNALfold output (post-filter) is performed in default mode, i.e., whenever this option is omitted. For combinations of z-score filtering and backtracking of global MFE structures, as described in Section 2.1; however, RNALfold automatically activates the newly implemented restriction of the forward recursion. This is due to the fact that all of the structural alternatives that constitute the global solution are required for successful backtracking. Furthermore, RNALfold defaults to omit locally optimal structures if they are constituents of another, larger structure with less free energy. This might be undesirable for predictions with z-score filtering, as the substructure may exhibit a lower z-score than the larger, enclosing structure. The novel option RNALfold --zscore-report-subsumed can be used in order to alleviate this effect.

3. Application: Scanning Genomes for “Hyper-Stable” RNA Structures

Some of the early surveys for ncRNAs used GC content and folding energy as indicators of structured RNAs. This approach was successful in particular in A/T-rich genomes of hyperthermophiles, such as Methanococcus jannaschii or Pyrococcus furiosus [24]. The extended version of RNALfold now makes it particularly easy to scan genomes for unexpectedly stable local structure.
As a show-case application, we screened the genomes of nematode Caenorhabditis elegans (Assembly WBcel235, Genome Assembly ID GCA_000002985.3) for highly stable component structures. For a given cut-off value z , we recorded all of the components with a z-score z z and compared the results to the ncRNA annotation available at Ensembl Release-101. In terms of the annotated elements, we found that there are only marginal differences between the two alternative strategies for z 2 , see Figure 2. As expected, recall decreases in a class-specific manner as the z-scores become more negative. In particular, microRNAs persist longer than other classes of ncRNAs.
A comparison of the real data with a pseudo-genome that are generated by dinucleotide-shuffling [25] shows that the number of local structures that are more stable than a given z-score threshold z decreases exponentially with z , as in Figure 2A. The real data only follow the same distribution for small z , but they show a tail with a smaller slope for large values of z . This indicates that the genome is enriched in “hyperstable” RNA structures. A comparison of the distribution with annotated ncRNAs (including long non-coding RNAs, which are not expected to be particularly heavily structured over their whole length) suggests that this tail, indeed, corresponds to structured RNAs. The data also indicate that the vast majority of the approximately 57,000 “hyper-stable” elements with z-scores below 8 have remained unannotated. Approximately 41,000 (>70%) of those elements are predicted within low-complexity and repeat regions, as detected by RepeatMasker, while only 222 partially overlap with annotated coding sequences. For the former, we find that a large number of the predicted hyper-stable elements overlap with repeat classes/families that are annotated as DNA transposon (11,561), Simple Repeats (7977), and Satellite (7832). Long terminal repeats (LTR) are overlapped by 417 hyper-stable elements, while general low complexity regions, LINEs, and SINEs are overlapped by 153, 55, and 14, respectively. Low complexity repeats have previously been described to form highly stable structures and they have been studied, in particular, in the context of triplet repeat expansion diseases [26].
We further compared our predictions for the A/T-rich genomes of hyperthermophiles against the 32 candidate ncRNAs of length 49–238 nt listed in Klein et al. [24]. Here, we find that using default settings ( L = 150 , z = 2.0 ), both approaches, pre- and post-filter, predict locally stable elements that overlap with at least 10% for virtually all of the candidate ncRNAs. The only exception is Mj8, which is not detected by the post-filter method. When requiring 50% overlap, the pre- and post-filter approach detects 21 and 22 out of a total of 22 candidate ncRNAs for Pyrococcus furiosus, respectively. For Methanococcus jannaschii, pre- and post-filter yields nine and eight of a total of 10 candidate ncRNA loci. With 12 and 10 out of 22 candidate ncRNA loci in P. furiosus for pre- and post-filter, respectively, approximately one half is fully overlapped (100%) by our predictions. This is similar to the predictions for M. jannaschii, where we find seven and four out of 10 candidate ncRNA loci, respectively. When we increase the window length to L = 250 to accomodate the lengths of the queries, all 10 candidate ncRNAs in M. jannaschii, and the majority (20 for pre-filter, 18 for post-filter) of the 22 candidate ncRNAs in P. furiosus are detected with an overlap of 100%. For the elements that fully overlap with the candidates, the majority of z-scores is larger than 3.0 , where the lowest z-score found is about 4.8 . Still, among our pre-filtered predictions are a further 927 (P. furiosus) and 3007 (M. jannaschii) locally stable structures with z < 4.8 , which account for 2.5% and 4.5% of the genomic DNA, respectively. A closer investigation reveals that approximately 29% (P. furiosus) and 22% (M. jannaschii) of these predicted elements overlap, at least in part, with other annotated ncRNAs, including rRNAs amd tRNAs. On the other hand, about 35% and 27% partially overlap with protein coding regions in the two genomes, respectively. This leaves 338 elements at 136 distinct non-coding loci in P. furiosus and 1609 elements at 287 loci in M. jannaschii as novel ncRNA candidates.

4. Conclusions

In this contribution, we have described an algorithm to reconstitute the MFE RNA secondary structure with limited base pair span from locally optimal structures. The method is applicable to effectively arbitrarily long RNA sequences and it closes the gap in the current toolkit that is provided by the ViennaRNA package. Arguably, the exact computation of such span-restricted MFE is of limited interest, since most RNA molecules of practical interest do not exceed the length range tractable without span restrictions. Furthermore, RNALfold and RNAplfold are primarily intended to scan entire genomic regions and provide local information, i.e., tasks for which local predictions that were provided by RNALfold could be used. However, the overlapping nature of these predictions is inconvenient, in particular, in the context of annotation, where one would like a partition of the input sequence into disjoint local structures. In order to become interpretable, the output of RNALfold therefore requires some form of postprocessing to reconcile overlapping local structures. The span-restricted MFE structure by construction consists of a partioning into pairwise disjoint components, i.e., base pair enclosed domains. Because the backtracking procedure that is described here has a running time of O ( n L ) , it is asymptotically optimal in the sense that postprocessing tools cannot be much faster, since the total amount of output of the forward recursion is also of size O ( n L ) .
The new backtracking functionality makes it easy to scan genome-scale data set for unusually stable structure. First and foremost, this provides a potentially useful pre-filter for other, more computationally demanding methods that search for specific types of non-coding RNAs, in particular microRNAs. However, Figure 2 also indicated that there is a large number of “hyper-stable” secondary structure elements that deserve more attention in their own right. The bulk of the hyperstable structures in C. elegans falls into repetitive elements. Earlier studies of structured ncRNAs explicitly excluded repetitive DNA. Our results suggest that these deserve more detailed attention in future research.

Author Contributions

P.F.S. and R.L. jointly designed the study, P.F.S. focussed on the theory, R.L. was responsible for the implementation and conducted the showcase application. Both authors collaborated in writing the manuscript. All authors have read and agreed to the published version of the manuscript.

Funding

This work was supported in part by the German Federal Ministry for Education and Research (BMBF 031A538B as part of de.NBI, to P.F.S.).

Data Availability Statement

The software described in this contribution is available as part of the ViennaRNA package https://www.tbi.univie.ac.at/RNA/.

Acknowledgments

This research originated over beer during a conference in Valetta, Malta in March 2020.

Conflicts of Interest

The authors declare no conflict of interest.

Abbreviations

The following abbreviations are used in this manuscript:
MFEMinimum free energy (secondary structure)
miRNAmicroRNA
ncRNANon-coding RNA
MEAMaximum expected accuracy (secondary structure)
TLAThree letter acronym

References

  1. Doshi, K.; Cannone, J.; Cobaugh, C.; Gutell, R. Evaluation of the suitability of free-energy minimization using nearest-neighbor energy parameters for RNA secondary structure prediction. BMC Bioinform. 2004, 5, 105. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  2. Proctor, J.R.P.; Meyer, I.M. CoFold: An RNA secondary structure prediction method that takes co-transcriptional folding into account. Nucleic Acids Res. 2013, 41, e102. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  3. Amman, F.; Bernhart, S.H.; Doose, G.; Hofacker, I.L.; Qin, J.; Stadler, P.F.; The Students of the Bioinformatics II Lab Class 2013; Will, S. The Trouble with Long-Range Base Pairs in RNA Folding. In Advances in Bioinformatics and Computational Biology, 8th BSB; Setubal, J.C., Almeida, N.F., Eds.; Lect. Notes Comp. Sci.; Springer: Berlin/Heidelberg, Germany, 2013; Volume 8213, pp. 1–11. [Google Scholar] [CrossRef]
  4. Hofacker, I.L.; Priwitzer, B.; Stadler, P.F. Prediction of Locally Stable RNA Secondary Structures for Genome-Wide Surveys. Bioinformatics 2004, 20, 191–198. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  5. Kiryu, H.; Kin, T.; Asai, K. Rfold: An exact algorithm for computing local base pairing probabilities. Bioinformatics 2008, 24, 367–373. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  6. Lange, S.J.; Daniel, M.; Möhl, M.; Joshua, J.N.; Brown, C.M.; Backofen, R. Global or local? Predicting secondary structure and accessibility in mRNAs. Nucleic Acids Res. 2012, 40, 5215–5226. [Google Scholar] [CrossRef] [Green Version]
  7. Hofacker, I.L.; Fontana, W.; Stadler, P.F.; Bonhoeffer, L.S.; Tacker, M.; Schuster, P. Fast Folding and Comparison of RNA Secondary Structures. Monatsh. Chem. 1994, 125, 167–188. [Google Scholar] [CrossRef]
  8. Lorenz, R.; Bernhart, S.H.; Höner zu Siederdissen, C.; Tafer, H.; Flamm, C.; Stadler, P.F.; Hofacker, I.L. ViennaRNA Package 2.0. Algorithms Mol. Biol. 2011, 6, 26. [Google Scholar] [CrossRef]
  9. Turner, D.H.; Mathews, D.H. NNDB: The nearest neighbor parameter database for predicting stability of nucleic acid secondary structure. Nucl. Acids Res. 2010, 38, D280–D282. [Google Scholar] [CrossRef]
  10. Do, C.; Woods, D.; Batzoglou, S. CONTRAfold: RNA secondary structure prediction without physics-based models. Bioinformatics 2006, 22, e90–e98. [Google Scholar] [CrossRef]
  11. Lu, Z.J.; Gloor, J.W.; Mathews, D.H. Improved RNA secondary structure prediction by maximizing expected pair accuracy. RNA 2009, 15, 1805–1813. [Google Scholar] [CrossRef] [Green Version]
  12. Bernhart, S.; Hofacker, I.L.; Stadler, P.F. Local RNA Base Pairing Probabilities in Large Sequences. Bioinformatics 2006, 22, 614–615. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  13. Nussinov, R.; Piecznik, G.; Griggs, J.R.; Kleitman, D.J. Algorithms for Loop Matching. SIAM J. Appl. Math. 1978, 35, 68–82. [Google Scholar] [CrossRef]
  14. Ding, Y.; Chan, C.Y.; Lawrence, C.E. RNA secondary structure prediction by centroids in a Boltzmann weighted ensemble. RNA 2005, 11, 1157–1166. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  15. Hamada, M.; Kiryu, H.; Sato, K.; Mituyama, T.; Asai, K. Prediction of RNA secondary structure using generalized centroid estimators. Bioinformatics 2009, 25, 465–473. [Google Scholar] [CrossRef] [PubMed]
  16. Hamada, M.; Sato, K.; Asai, K. Prediction of RNA secondary structure by maximizing pseudo-expected accuracy. BMC Bioinform. 2010, 11, 586. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  17. Lorenz, R.; Hofacker, I.L.; Stadler, P.F. RNA Folding with Hard and Soft Constraints. Algorithms Mol. Biol. 2016, 11, 8. [Google Scholar] [CrossRef] [Green Version]
  18. Le, S.Y.; Maizel, J.V., Jr. A method for assessing the statistical significance of RNA folding. J. Theor. Biol. 1989, 138, 495–510. [Google Scholar] [CrossRef]
  19. Rivas, E.; Eddy, S.R. Secondary structure alone is generally not statistically significant for the detection of noncoding RNAs. Bioinformatics 2000, 16, 583–605. [Google Scholar] [CrossRef] [Green Version]
  20. Clote, P.; Ferré, F.; Kranakis, E.; Krizanc, D. Structural RNA has lower folding energy than random RNA of the same dinucleotide frequency. RNA 2005, 11, 578–591. [Google Scholar] [CrossRef] [Green Version]
  21. Freyhult, E.; Gardner, P.P.; Moulton, V. A comparison of RNA folding measures. BMC Bioinform. 2005, 6, 241. [Google Scholar] [CrossRef]
  22. Washietl, S.; Hofacker, I.L.; Stadler, P.F. Fast and reliable prediction of noncoding RNAs. Proc. Natl. Acad. Sci. USA 2005, 102, 2454–2459. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  23. Gruber, A.R.; Findeiß, S.; Washietl, S.; Hofacker, I.L.; Stadler, P.F. RNAz 2.0: Improved noncoding RNA detection. Pac. Symp. Biocomput. 2010, 15, 69–79. [Google Scholar] [CrossRef]
  24. Klein, R.J.; Misulovin, Z.; Eddy, S.R. Noncoding RNA genes identified in AT-rich hyperthermophiles. Proc. Natl. Acad. Sci. USA 2002, 99, 7542–7547. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  25. Jiang, M.; Anderson, J.; Gillespie, J.; Mayne, M. uShuffle: A useful tool for shuffling biological sequences while preserving the k-let counts. BMC Bioinform. 2008, 9, 192. [Google Scholar] [CrossRef] [Green Version]
  26. Ciesiolka, A.; Jazurek, M.; Drazkowska, K.; Krzyzosiak, W.J. Structural Characteristics of Simple RNA Repeats Associated with Disease and their Deleterious Protein Interactions. Front. Cell. Neurosci. 2017, 11, 97. [Google Scholar] [CrossRef] [Green Version]
Figure 1. CPU requirements for backtracking the MFE structure in RNALfold. The performance of the implementation ViennaRNA conforms to a linear dependence of backtracking time per nucleotide with base pair span L, i.e., t CPU n L . Shown is the computational overhead for different window sizes L that were obtained from averaging over 100 random sequences of length (A) 10 , 000 nt and (B) 100 , 000 nt. Error bars denote the standard deviation within the sets of 100 runs, and a linear fit is depicted by a dashed black line.
Figure 1. CPU requirements for backtracking the MFE structure in RNALfold. The performance of the implementation ViennaRNA conforms to a linear dependence of backtracking time per nucleotide with base pair span L, i.e., t CPU n L . Shown is the computational overhead for different window sizes L that were obtained from averaging over 100 random sequences of length (A) 10 , 000 nt and (B) 100 , 000 nt. Error bars denote the standard deviation within the sets of 100 runs, and a linear fit is depicted by a dashed black line.
Genes 12 00014 g001
Figure 2. Predictions on the C. elegans genome. (A) Cumulative z-score distribution of predicted blocks with pre-filtering and default z-score threshold of z 2.0 and window length L = 150 . Shown are all predicted blocks for the entire C.elegans genome (black line) and those that sufficiently overlap with annotated ncRNAs (yellow line). The pseudo-genome (lightblue line) denotes blocks that were predicted on a di-nucleotide shuffled C. elegans genome. (B) Comparison of prediction coverage ( L = 150 ) of the two z-score filter methods. Shown is the percentage of annotated ncRNAs that are sufficiently overlapped by the predicted locally stable structures at different z-score filter thresholds.
Figure 2. Predictions on the C. elegans genome. (A) Cumulative z-score distribution of predicted blocks with pre-filtering and default z-score threshold of z 2.0 and window length L = 150 . Shown are all predicted blocks for the entire C.elegans genome (black line) and those that sufficiently overlap with annotated ncRNAs (yellow line). The pseudo-genome (lightblue line) denotes blocks that were predicted on a di-nucleotide shuffled C. elegans genome. (B) Comparison of prediction coverage ( L = 150 ) of the two z-score filter methods. Shown is the percentage of annotated ncRNAs that are sufficiently overlapped by the predicted locally stable structures at different z-score filter thresholds.
Genes 12 00014 g002
Publisher’s Note: MDPI stays neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Share and Cite

MDPI and ACS Style

Lorenz, R.; Stadler, P.F. RNA Secondary Structures with Limited Base Pair Span: Exact Backtracking and an Application. Genes 2021, 12, 14. https://doi.org/10.3390/genes12010014

AMA Style

Lorenz R, Stadler PF. RNA Secondary Structures with Limited Base Pair Span: Exact Backtracking and an Application. Genes. 2021; 12(1):14. https://doi.org/10.3390/genes12010014

Chicago/Turabian Style

Lorenz, Ronny, and Peter F. Stadler. 2021. "RNA Secondary Structures with Limited Base Pair Span: Exact Backtracking and an Application" Genes 12, no. 1: 14. https://doi.org/10.3390/genes12010014

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop