BIOINF 4120 Bioinforma2cs 2 - Structures and Systems -

Size: px
Start display at page:

Download "BIOINF 4120 Bioinforma2cs 2 - Structures and Systems -"

Transcription

1 BIOINF 4120 Bioinforma2cs 2 - Structures and Systems - Oliver Kohlbacher Summer RNA Structure Part II Overview RNA Folding Free energy as a criterion Folding free energy of RNA Zuker- SCegler algorithm k- loops Free energy definicon Dynamic program Folding by comparacve analysis ConservaCon of structure vs. sequence Mutual informacon 2 RNA Folding Problems of Nussinov s alg.: All base pairs considered equal Stability of different base pairs not accounted for Stability is not only determined by base pairs Adjacent bases in helices contribute to stability through base stacking Base stacking in DNA/RNA 3 1

2 Free Energy of RNA Folding The surrounding of the base pair has an influence as well: Stacking of a base with an adjacent base stabilizes the structure Loops, bulges, and interior loops are destabilizing the structure A more complete list of energecc contribucons could thus look like this: Free energy of base pairing (stabilizing) Free energy of base stacking (stabilizing) Free energy of end loops (destabilizing) Free energy of interior loops (destabilizing) Free energy of bulges (destabilizing) 4 Free Energy of RNA Folding Reasonable escmates for the free energies of the base pairs C- G, A- U, and G- U at 37 C are - 12 kj/mol, - 8 kj/mol, and - 4 kj/mol, respeccvely A simple definicon of e(i, j) could for example look like this The total energy E(s, P) of a sequence s folding into secondary structure P is then the sum of the base pair contribucons: 5 Free Energy Minimiza2on Nussinov s algorithm can be easily adapted to account for different base pair energies Replace ±(i, j) by an energy funccon e(i, j) Now the maximizacon of the number of base pairs has to be turned into a free energy minimiza2on Fortunately, the algorithm can be easily adapted to minimizacon instead of maximizacon The free energy minimizacon problem can scll be solved easily using dynamic programming with the following recursion: 6 2

3 Free Energy Minimiza2on Unfortunately, even these generalizacons of Nussinov s algorithm do not yield good structures The algorithm does not account for the stabilizing effect of base stacking in stems the destabilizing effect of loops More sophisccated approaches are required for this However, we want to hold on to the idea of energy minimizacon this idea is perfectly reasonable from a thermodynamic point of view What we need are bejer energy func2ons These should scll be efficiently computable 7 Zuker- S2egler Algorithm In 1981, Zuker and SCegler proposed a more sophisccated dynamic programming algorithm for RNA folding The algorithm is based on a more sophisccated energy funccon accouncng for loops, stacked base pairs, and other secondary structure elements. The key idea in their algorithm is the decomposicon of the structure into loops rather than base pairs Their energy funccon is thus more complex and captures biochemical reality beger M. Zuker, P. Stiegler, Optimal computer folding of large RNA sequences using thermodynamics and auxiliary information. Nucl. Acids Res. (1981), 9: F 8 Accessibility and Loops Defini2on 1: If (i, j) is a base pair in secondary structure P and i < h < j then we say that base h is accessible from (i, j) if there is no base pair (i, j ) 2 P such that i < i < h < j < j. A base pair (k, l) is accessible from (i, j) if both k and l are accessible from (i, j). Defini2on 2: The set of all bases accessible from a base pair (i, j) 2 P is called a loop. The size of the loop is the number of unpaired bases it contains. k i j l 9 3

4 k- Loops DefiniCon 2 implies that base pairs can form loops of size 0: i j Defini2on 3: The set l of all k- 1 base pairs and k unpaired bases that are accessible from (i, j) is called the k- loop closed by (i, j). The null k- loop l 0 consists of those single bases and base pairs that are accessible from no base pair. 10 k- Loops Defini2on 4: Based on the above we can define well- known secondary structures in terms of k- loops: 1. A hairpin loop is a 1- loop. 2. Let (k, l) be the pair accessible from the 2- loop closed by (i, j). The 2- loop is then called stacked pair if k - i = 1 and j - l = 1, bulge loop if k - i > 1 or j - l > 1, but not both, and interior loop if k - i > 1 and j - l > Mul2- loops are k- loops for k > Dangling ends of a structure form a null k- loop. 11 k- Loops and Secondary Structures i k i k j l j l i k j l D. Mount, Bioinformatics, p

5 k- Loop Decomposi2on Observa2on: Any secondary structure P on a sequence s = (s 1, s 2,, s n ) can be parcconed into k- loops l 0, l 1, l m where m > 0 iff P. This k- loop decomposicon was first suggested by Sankoff et al. (1983). It allows the decomposicon into individual loops and given an energy funccon e(l) for k- loops the addicve determinacon of the total energy of the decomposed secondary structure P: Sankoff, D., Kruskal, J., Mainville, S., Cedergren, R., In: Sankoff, D., Kruskal, J. (Eds.), Time Warps, String Edits, and Macromolecules: The Theory and Practice of Sequence Comparison. Addison- Wesley, Reading, MA, pp k- Loop Decomposi2on Miklósa et al., Bull. Math. Biol., 67 (2005), k- Loop Decomposi2on Observa2on The number of non- null k- loops of a structure equals the number of base pairs it contains. Miklósa et al., Bull. Math. Biol., 67 (2005),

6 k- Loop Energies Only stacked base pairs yield a negacve contribucon to G. We denote the energy of stacked pairs (i, j) and (k, l) in the stacking loop closed by (i, j) as e s (i, j). e s A/U C/G G/C U/A G/U U/G A/U C/G G/C U/A G/U U/G (free energies in kcal/mol at 37 C) 16 k- Loop Energies All other k- loops contribute posicve energies to G. size interior loop bulge hairpin (free energies in kcal/mol at 37 C) 17 k- Loop Energies The full energy funccon for a secondary structure is then composed of the following contribucons: e h (i, j), the energy for a hairpin loop closed by (i, j) e s (i, j), the energy of the stacked pair (i, j) and (i+1, j- 1) e bi (i, j, k, l), the energy of the bulge or interior loop closed by (i, j) with (k, l) accessible from (i, j) e ml denotes a constant energy associated with mulc- loops 18 6

7 Zuker- S2egler Algorithm Input: A sequence s 2 RNA n Output: A set of base pairings P describing a secondary structure of s of minimal free energy. The Zuker- SCegler algorithm now finds a minimum free energy secondary structure for s given an energy funccon for k- loops through dynamic programming In contrast to Nussinov s algorithm the recursion is centered on k- loops, not on base pairs. The recursion is a bit more complicated, requiring two DP matrices, V and W 19 Zuker- S2egler Algorithm The matrix W(i, j) denotes the minimum folding free energy of all non- empty foldings of the subsequence s i,, s j for all i < j. AddiConally, V(i, j) denotes the minimum folding free energy of all non- empty foldings of the subsequence s i,, s j containing the base pair (i, j). From the energy funccon described earlier, it is evident that the following relacon holds: W(i, j) V(i, j) for all i, j Both matrices are inicalized as follows: W(i, j) = V(i, j) = 1 for all i, j with j 4 < i < j 20 Zuker- S2egler Algorithm Main recursion: For all i, j with 1 i < j n: We consider the four well- known cases: 1. i is unpaired 2. j is unpaired 3. i and j are paired to each other (and thus close a k- loop). Best free energies for the k- loop come from matrix V. 4. i and j are possibly paired, but not to each other. 21 7

8 Zuker- S2egler Algorithm Energies for the main recursion: Deriving the energies is fairly simple for the first two cases, hairpins and stacking pairs 1. For a hairpin we just add the energy e h (i, j) of the hairpin closed by (i, j) 2. For a stacking loop closed by (i, j) we add the energy of the stacking loop plus the energy of the remaining secondary structure (i+1, j- 1) The other two cases are a bit more complicated. 22 Zuker- S2egler Algorithm Case 3: bulges and interior loops For this case we have to consider every possible way to define a bulge or interior loop i k j l The energy V BI is then the minimum over all possible bulges/interior loops and the energy of the secondary structure closed by (k, l): 23 Zuker- S2egler Algorithm Case 4: mul:- loops For mulc- loops we consider the different ways to compose a mulc- loop from two substructures: To account for the destabilizing effect of the mulc- loop, we add a constant energy e ML i 24 8

9 Complexity of the Algorithm Let us consider Nussinov s algorithm first: For l = 2 to n: For j = l to n: i = j l + 1 From the above it is evident that there are n 2 entries in (O(n 2 ) space) and the computacon of the fourth case takes at most O(n) Cme. Overall run Cme complexity is thus O(n 3 ) 25 Complexity of the Algorithm Now for the Zuker- S2egler algorithm: For all i, j with 1 i < j n: Matrices V and W have O(n 2 ) entries ComputaCon of W takes O(n 3 ) steps (same as Nussinov!) ComputaCon of V takes O(n 2 ) steps (without V BI and V M!) 26 Complexity of the Algorithm Now for the Zuker- S2egler algorithm: ComputaCon of O(n 2 ) possible V BI (i, j) takes O(n 2 ), resulcng in O(n 4 ) in total ComputaCon of V M requires similarly O(n) Cme and O(n 3 ) Cme in total Total 2me complexity of the Zuker- S2egler algorithm is thus: O(n 4 ) By limicng the size of bulges or interior loops to some fixed number d, usually about 30, the runcme can be reduced to O(n 3 ). This can be done by restriccng the search in the definicon of V BI. 27 9

10 Mul2- Loops Constant energy funccons for mulc- loops are an oversimplificacon A more general energy funccon could look like this: e ml = a + b n unp + c n p where a, b, c are constants and n unp and n p are the number of unpaired and paired bases in the mulc- loop. Similar to the nocon of affine gap costs in sequence alignment, this type of mulc- loop energy allows the construccon of an efficient O(n 3 ) algorithm Over the years, numerous addicons and modificacons have been proposed to improve on this. These are, however, beyond the scope of this lecture. 28 Example We can now try to fold a simple sequence: AAACAUGAGGAUUACCCAUGU Applying the Zuker- SCegler algorithm results in the following structure: 29 MFOLD Web Server Michael Zuker provides a web server that can be used to fold RNA sequences It uses a slightly modified algorithm and a different energy funccon, in this case it provides us with the same structure, though:

11 Folding by Compara2ve Analysis Another way to predict secondary structure is to look at the sequences of related structures As with protein structures, RNA structure is highly conserved even if sequences similarity is completely gone ComparaCve analysis of RNA sequences/structures can reveal the common structure, though The underlying mechanism that conserves structure is called compensatory change: in order to conserve the secondary structure not one, but two bases have to change. A G C G A U 31 Folding by Compara2ve Analysis Analysis of sequence covariance in related RNAs can thus help to idencfy posicons that form base pairs Mount, Bioinformatics, p Mutual Informa2on To measure the amount of correlacon between two posicons, one can use mutual informa2on: if you tell me the base at posibon i, how much do I learn about the base at posibon j? Consider base frequencies in a given alignment First, the frequencies f i (x) for each column i and base x is computed Second, the 16 joint frequencies f ij (x, y) of two nucleocdes x in column i and y in column j are computed. For each pair of columns (i, j) we compute the raco If the base frequencies are independent of each other, then that raco should be close to 1, otherwise it will be larger than

12 Mutual Informa2on To calculate the mutual informa2on H(i, j) in bits between the two columns i and j, the logarithm of this raco is summed up for all base combinacons: For RNA sequences, we expect a maximum of two bits if there is perfect correlacon, zero if the two columns are encrely independent If either site is totally conserved, the mutual informacon is zero, because there is no covariance Problem: what happens for f i (x) = 0? 34 Mutual Informa2on To compensate for small sample size or unobserved bases, a so- called unbiased probability es2mator replaces the frequencies: where n is the number of sequences in the alignment Mutual informacon is then given as: Chiu & Kolodziejczak, CABIOS 7 (1991), Mutual Informa2on Example Compute the mutual informacon: C G C G A U C G G C C G C G C G G C C G G C U A H 1,2 =? H 3,4 =? H 5,6 =? 36 12

13 Mutual Informa2on Example An alignment of 1088 trnas taken from Rfam: CGCG.GGAU.A.GAGCAGUC.UGGU...AGCUCG.U.CGGGC.UCAUAACCCG.AAG GCCA.AAGU.A.GUUUAAU...GGU...AGAACA.A.UAAUU.UCAUGAAUUA.AGA GUCC.CUUU.C.GUCCAGU...GGUU..AGGACA.U.CGUCU.UUUCAUGUCG.AAG UGCA.AUAU.G.AUGUAAUU..GGUU..AACAUU.U.UAGGG.UCAUGACCUA.AUU GUGA.AUUU.A.GUUUAAUA..GAU...AAAACA.U.UUGCU.UUGCAAGCAA.AAC AGGG.GUUU.A.AGUUAA...UCU...AAACUA.A.AAGCC.UUCAAAGCUU.UAA ACUU.UUAA.A.GGAUAGA...AGU...AAUCCA.U.UGGCC.UUAGGAGCCA.AAA GUCU.CUGU.G.GCGCAAUC..GGUU..AGCGCG.U.UCGGC.UGUUAACCGA.AAG [ ] 37 Mutual Informa2on Example Consensus structure (from Rfam) 38 Links Web sites RFam: The Rfam database of RNA alignments and CMs hgp://rfam.janelia.org NonCode - database of non- coding RNAs hgp:// RNAdb - mammalian non- coding RNA database hgp://research.imb.uq.edu.au/rnadb/ many more links at IMB Jena hgp:// jena.de/rna.php 39 13

14 Links Webservers Zuker's mfold Server: hgp://frontend.bioinfo.rpi.edu/applicacons/mfold/ Vienna RNA Secondary Structure PredicCon: hgp://rna.tbi.univie.ac.at/cgi- bin/rnafold.cgi 40 Sources Kay Nieselt, Lecture RNA Secondary Structure from Algorithms in BioinformaCcs M. S. Waterman. IntroducCon to ComputaConal Biology Maps, sequences and genomes. Chapman & Hall, Boca Raton, 1995 D. W. Mount. BioinformaCcs. Sequences and genome analysis, 2001 M. Zuker and P. SCegler. OpCmal computer folding of large RNA sequences using thermodynamics and auxiliary informacon. Nucl. Acids Res. (1981), 9(1): (PMID: ) 41 14

98 Algorithms in Bioinformatics I, WS 06, ZBIT, D. Huson, December 6, 2006

98 Algorithms in Bioinformatics I, WS 06, ZBIT, D. Huson, December 6, 2006 98 Algorithms in Bioinformatics I, WS 06, ZBIT, D. Huson, December 6, 2006 8.3.1 Simple energy minimization Maximizing the number of base pairs as described above does not lead to good structure predictions.

More information

Rapid Dynamic Programming Algorithms for RNA Secondary Structure

Rapid Dynamic Programming Algorithms for RNA Secondary Structure ADVANCES IN APPLIED MATHEMATICS 7,455-464 I f Rapid Dynamic Programming Algorithms for RNA Secondary Structure MICHAEL S. WATERMAN* Depurtments of Muthemutics und of Biologicul Sciences, Universitk of

More information

Algorithms in Bioinformatics

Algorithms in Bioinformatics Algorithms in Bioinformatics Sami Khuri Department of Computer Science San José State University San José, California, USA khuri@cs.sjsu.edu www.cs.sjsu.edu/faculty/khuri RNA Structure Prediction Secondary

More information

RNA secondary structure prediction. Farhat Habib

RNA secondary structure prediction. Farhat Habib RNA secondary structure prediction Farhat Habib RNA RNA is similar to DNA chemically. It is usually only a single strand. T(hyamine) is replaced by U(racil) Some forms of RNA can form secondary structures

More information

proteins are the basic building blocks and active players in the cell, and

proteins are the basic building blocks and active players in the cell, and 12 RN Secondary Structure Sources for this lecture: R. Durbin, S. Eddy,. Krogh und. Mitchison, Biological sequence analysis, ambridge, 1998 J. Setubal & J. Meidanis, Introduction to computational molecular

More information

RNA Basics. RNA bases A,C,G,U Canonical Base Pairs A-U G-C G-U. Bases can only pair with one other base. wobble pairing. 23 Hydrogen Bonds more stable

RNA Basics. RNA bases A,C,G,U Canonical Base Pairs A-U G-C G-U. Bases can only pair with one other base. wobble pairing. 23 Hydrogen Bonds more stable RNA STRUCTURE RNA Basics RNA bases A,C,G,U Canonical Base Pairs A-U G-C G-U wobble pairing Bases can only pair with one other base. 23 Hydrogen Bonds more stable RNA Basics transfer RNA (trna) messenger

More information

RNA-Strukturvorhersage Strukturelle Bioinformatik WS16/17

RNA-Strukturvorhersage Strukturelle Bioinformatik WS16/17 RNA-Strukturvorhersage Strukturelle Bioinformatik WS16/17 Dr. Stefan Simm, 01.11.2016 simm@bio.uni-frankfurt.de RNA secondary structures a. hairpin loop b. stem c. bulge loop d. interior loop e. multi

More information

Combinatorial approaches to RNA folding Part II: Energy minimization via dynamic programming

Combinatorial approaches to RNA folding Part II: Energy minimization via dynamic programming ombinatorial approaches to RNA folding Part II: Energy minimization via dynamic programming Matthew Macauley Department of Mathematical Sciences lemson niversity http://www.math.clemson.edu/~macaule/ Math

More information

Predicting RNA Secondary Structure

Predicting RNA Secondary Structure 7.91 / 7.36 / BE.490 Lecture #6 Mar. 11, 2004 Predicting RNA Secondary Structure Chris Burge Review of Markov Models & DNA Evolution CpG Island HMM The Viterbi Algorithm Real World HMMs Markov Models for

More information

Computational Approaches for determination of Most Probable RNA Secondary Structure Using Different Thermodynamics Parameters

Computational Approaches for determination of Most Probable RNA Secondary Structure Using Different Thermodynamics Parameters Computational Approaches for determination of Most Probable RNA Secondary Structure Using Different Thermodynamics Parameters 1 Binod Kumar, Assistant Professor, Computer Sc. Dept, ISTAR, Vallabh Vidyanagar,

More information

RNA Structure Prediction and Comparison. RNA folding

RNA Structure Prediction and Comparison. RNA folding RNA Structure Prediction and Comparison Session 3 RNA folding Faculty of Technology robert@techfak.uni-bielefeld.de Bielefeld, WS 2013/2014 Base Pair Maximization This was the first structure prediction

More information

13 Comparative RNA analysis

13 Comparative RNA analysis 13 Comparative RNA analysis Sources for this lecture: R. Durbin, S. Eddy, A. Krogh und G. Mitchison, Biological sequence analysis, Cambridge, 1998 D.W. Mount. Bioinformatics: Sequences and Genome analysis,

More information

CS681: Advanced Topics in Computational Biology

CS681: Advanced Topics in Computational Biology CS681: Advanced Topics in Computational Biology Can Alkan EA224 calkan@cs.bilkent.edu.tr Week 10 Lecture 1 http://www.cs.bilkent.edu.tr/~calkan/teaching/cs681/ RNA folding Prediction of secondary structure

More information

Combinatorial approaches to RNA folding Part I: Basics

Combinatorial approaches to RNA folding Part I: Basics Combinatorial approaches to RNA folding Part I: Basics Matthew Macauley Department of Mathematical Sciences Clemson University http://www.math.clemson.edu/~macaule/ Math 4500, Spring 2015 M. Macauley (Clemson)

More information

Lecture 4. Laminar Premixed Flame Configura6on 4.- 1

Lecture 4. Laminar Premixed Flame Configura6on 4.- 1 Lecture 4 Laminar Premixed Flame Configura6on 4.- 1 Bunsen Burner Classical device to generate a laminar premixed flame Gaseous fuel enters into the mixing chamber, into which air is entrained Velocity

More information

RNA Secondary Structure Prediction

RNA Secondary Structure Prediction RN Secondary Structure Prediction Perry Hooker S 531: dvanced lgorithms Prof. Mike Rosulek University of Montana December 10, 2010 Introduction Ribonucleic acid (RN) is a macromolecule that is essential

More information

RecitaLon CB Lecture #10 RNA Secondary Structure

RecitaLon CB Lecture #10 RNA Secondary Structure RecitaLon 3-19 CB Lecture #10 RNA Secondary Structure 1 Announcements 2 Exam 1 grades and answer key will be posted Friday a=ernoon We will try to make exams available for pickup Friday a=ernoon (probably

More information

BCB 444/544 Fall 07 Dobbs 1

BCB 444/544 Fall 07 Dobbs 1 BCB 444/544 Required Reading (before lecture) Lecture 25 Mon Oct 15 - Lecture 23 Protein Tertiary Structure Prediction Chp 15 - pp 214-230 More RNA Structure Wed Oct 17 & Thurs Oct 18 - Lecture 24 & Lab

More information

BIOINFORMATICS. Prediction of RNA secondary structure based on helical regions distribution

BIOINFORMATICS. Prediction of RNA secondary structure based on helical regions distribution BIOINFORMATICS Prediction of RNA secondary structure based on helical regions distribution Abstract Motivation: RNAs play an important role in many biological processes and knowing their structure is important

More information

CONTRAfold: RNA Secondary Structure Prediction without Physics-Based Models

CONTRAfold: RNA Secondary Structure Prediction without Physics-Based Models Supplementary Material for CONTRAfold: RNA Secondary Structure Prediction without Physics-Based Models Chuong B Do, Daniel A Woods, and Serafim Batzoglou Stanford University, Stanford, CA 94305, USA, {chuongdo,danwoods,serafim}@csstanfordedu,

More information

Semi-Supervised CONTRAfold for RNA Secondary Structure Prediction: A Maximum Entropy Approach

Semi-Supervised CONTRAfold for RNA Secondary Structure Prediction: A Maximum Entropy Approach Wright State University CORE Scholar Browse all Theses and Dissertations Theses and Dissertations 2011 Semi-Supervised CONTRAfold for RNA Secondary Structure Prediction: A Maximum Entropy Approach Jianping

More information

BIOINF 4120 Bioinforma2cs 2 - Structures and Systems -

BIOINF 4120 Bioinforma2cs 2 - Structures and Systems - BIIF 4120 Bioinforma2cs 2 - Structures and Systems - liver Kohlbacher SS 2011 2. RA Structure Part I verview RA Types of RA and their biological func@on Two- dimensional structure Three- dimensional structure

More information

RNA Folding Algorithms. Michal Ziv-Ukelson Ben Gurion University of the Negev

RNA Folding Algorithms. Michal Ziv-Ukelson Ben Gurion University of the Negev RNA Folding Algorithms Michal Ziv-Ukelson Ben Gurion University of the Negev The RNA Folding Problem: Given an RNA sequence, predict its energetically most stable structure (minimal free energy). AUCCCCGUAUCGAUC

More information

RNA Folding Algorithms. Michal Ziv-Ukelson Ben Gurion University of the Negev

RNA Folding Algorithms. Michal Ziv-Ukelson Ben Gurion University of the Negev RNA Folding Algorithms Michal Ziv-Ukelson Ben Gurion University of the Negev The RNA Folding Problem: Given an RNA sequence, predict its energetically most stable structure (minimal free energy). AUCCCCGUAUCGAUC

More information

The Ensemble of RNA Structures Example: some good structures of the RNA sequence

The Ensemble of RNA Structures Example: some good structures of the RNA sequence The Ensemble of RNA Structures Example: some good structures of the RNA sequence GGGGGUAUAGCUCAGGGGUAGAGCAUUUGACUGCAGAUCAAGAGGUCCCUGGUUCAAAUCCAGGUGCCCCCU free energy in kcal/mol (((((((..((((...))))...((((...))))(((((...)))))))))))).

More information

DYNAMIC PROGRAMMING ALGORITHMS FOR RNA STRUCTURE PREDICTION WITH BINDING SITES

DYNAMIC PROGRAMMING ALGORITHMS FOR RNA STRUCTURE PREDICTION WITH BINDING SITES DYNAMIC PROGRAMMING ALGORITHMS FOR RNA STRUCTURE PREDICTION WITH BINDING SITES UNYANEE POOLSAP, YUKI KATO, TATSUYA AKUTSU Bioinformatics Center, Institute for Chemical Research, Kyoto University, Gokasho,

More information

BIOINFORMATICS. Fast evaluation of internal loops in RNA secondary structure prediction. Abstract. Introduction

BIOINFORMATICS. Fast evaluation of internal loops in RNA secondary structure prediction. Abstract. Introduction BIOINFORMATICS Fast evaluation of internal loops in RNA secondary structure prediction Abstract Motivation: Though not as abundant in known biological processes as proteins, RNA molecules serve as more

More information

In Genomes, Two Types of Genes

In Genomes, Two Types of Genes In Genomes, Two Types of Genes Protein-coding: [Start codon] [codon 1] [codon 2] [ ] [Stop codon] + DNA codons translated to amino acids to form a protein Non-coding RNAs (NcRNAs) No consistent patterns

More information

Lab III: Computational Biology and RNA Structure Prediction. Biochemistry 208 David Mathews Department of Biochemistry & Biophysics

Lab III: Computational Biology and RNA Structure Prediction. Biochemistry 208 David Mathews Department of Biochemistry & Biophysics Lab III: Computational Biology and RNA Structure Prediction Biochemistry 208 David Mathews Department of Biochemistry & Biophysics Contact Info: David_Mathews@urmc.rochester.edu Phone: x51734 Office: 3-8816

More information

Shape Based Indexing For Faster Search Of RNA Family Databases

Shape Based Indexing For Faster Search Of RNA Family Databases For Faster Search Of RNA Family Databases Stefan Janssen Jens Reeder Robert Giegerich 26. April 2008 RNA homology Why? build homologous groups find new group members How? sequence & structure Covariance

More information

DANNY BARASH ABSTRACT

DANNY BARASH ABSTRACT JOURNAL OF COMPUTATIONAL BIOLOGY Volume 11, Number 6, 2004 Mary Ann Liebert, Inc. Pp. 1169 1174 Spectral Decomposition for the Search and Analysis of RNA Secondary Structure DANNY BARASH ABSTRACT Scales

More information

Sparse RNA Folding Revisited: Space-Efficient Minimum Free Energy Prediction

Sparse RNA Folding Revisited: Space-Efficient Minimum Free Energy Prediction Sparse RNA Folding Revisited: Space-Efficient Minimum Free Energy Prediction Sebastian Will 1 and Hosna Jabbari 2 1 Bioinformatics/IZBI, University Leipzig, swill@csail.mit.edu 2 Ingenuity Lab, National

More information

Computing the partition function and sampling for saturated secondary structures of RNA, with respect to the Turner energy model

Computing the partition function and sampling for saturated secondary structures of RNA, with respect to the Turner energy model Computing the partition function and sampling for saturated secondary structures of RNA, with respect to the Turner energy model J. Waldispühl 1,3 P. Clote 1,2, 1 Department of Biology, Higgins 355, Boston

More information

RNA Abstract Shape Analysis

RNA Abstract Shape Analysis ourse: iegerich RN bstract nalysis omplete shape iegerich enter of Biotechnology Bielefeld niversity robert@techfak.ni-bielefeld.de ourse on omputational RN Biology, Tübingen, March 2006 iegerich ourse:

More information

Genome 559 Wi RNA Function, Search, Discovery

Genome 559 Wi RNA Function, Search, Discovery Genome 559 Wi 2009 RN Function, Search, Discovery The Message Cells make lots of RN noncoding RN Functionally important, functionally diverse Structurally complex New tools required alignment, discovery,

More information

A two length scale polymer theory for RNA loop free energies and helix stacking

A two length scale polymer theory for RNA loop free energies and helix stacking A two length scale polymer theory for RNA loop free energies and helix stacking Daniel P. Aalberts and Nagarajan Nandagopal Physics Department, Williams College, Williamstown, MA 01267 RNA, in press (2010).

More information

DNA/RNA Structure Prediction

DNA/RNA Structure Prediction C E N T R E F O R I N T E G R A T I V E B I O I N F O R M A T I C S V U Master Course DNA/Protein Structurefunction Analysis and Prediction Lecture 12 DNA/RNA Structure Prediction Epigenectics Epigenomics:

More information

A Method for Aligning RNA Secondary Structures

A Method for Aligning RNA Secondary Structures Method for ligning RN Secondary Structures Jason T. L. Wang New Jersey Institute of Technology J Liu, JTL Wang, J Hu and B Tian, BM Bioinformatics, 2005 1 Outline Introduction Structural alignment of RN

More information

Moments of the Boltzmann distribution for RNA secondary structures

Moments of the Boltzmann distribution for RNA secondary structures Bulletin of Mathematical Biology 67 (2005) 1031 1047 www.elsevier.com/locate/ybulm Moments of the Boltzmann distribution for RNA secondary structures István Miklós a, Irmtraud M. Meyer b,,borbála Nagy

More information

Recent measurements of low- energy hadronic cross seccons at BABAR & implicacons for g- 2 of the muon

Recent measurements of low- energy hadronic cross seccons at BABAR & implicacons for g- 2 of the muon Recent measurements of low- energy hadronic cross seccons at & implicacons for g- 2 of the muon J. William Gary U. California, Riverside on behalf of the CollaboraCon XLVII InternaConal Symposium on MulCparCcle

More information

Sparse RNA folding revisited: space efficient minimum free energy structure prediction

Sparse RNA folding revisited: space efficient minimum free energy structure prediction DOI 10.1186/s13015-016-0071-y Algorithms for Molecular Biology RESEARCH ARTICLE Sparse RNA folding revisited: space efficient minimum free energy structure prediction Sebastian Will 1* and Hosna Jabbari

More information

Introduction to Polymer Physics

Introduction to Polymer Physics Introduction to Polymer Physics Enrico Carlon, KU Leuven, Belgium February-May, 2016 Enrico Carlon, KU Leuven, Belgium Introduction to Polymer Physics February-May, 2016 1 / 28 Polymers in Chemistry and

More information

Structure-Based Comparison of Biomolecules

Structure-Based Comparison of Biomolecules Structure-Based Comparison of Biomolecules Benedikt Christoph Wolters Seminar Bioinformatics Algorithms RWTH AACHEN 07/17/2015 Outline 1 Introduction and Motivation Protein Structure Hierarchy Protein

More information

Complete Suboptimal Folding of RNA and the Stability of Secondary Structures

Complete Suboptimal Folding of RNA and the Stability of Secondary Structures Stefan Wuchty 1 Walter Fontana 1,2 Ivo L. Hofacker 1 Peter Schuster 1,2 1 Institut für Theoretische Chemie, Universität Wien, Währingerstrasse 17, A-1090 Wien, Austria Complete Suboptimal Folding of RNA

More information

Motivating the need for optimal sequence alignments...

Motivating the need for optimal sequence alignments... 1 Motivating the need for optimal sequence alignments... 2 3 Note that this actually combines two objectives of optimal sequence alignments: (i) use the score of the alignment o infer homology; (ii) use

More information

COMBINATORICS OF LOCALLY OPTIMAL RNA SECONDARY STRUCTURES

COMBINATORICS OF LOCALLY OPTIMAL RNA SECONDARY STRUCTURES COMBINATORICS OF LOCALLY OPTIMAL RNA SECONDARY STRUCTURES ÉRIC FUSY AND PETER CLOTE Abstract. It is a classical result of Stein and Waterman that the asymptotic number of RNA secondary structures is 1.104366

More information

Prediction of Locally Stable RNA Secondary Structures for Genome-Wide Surveys

Prediction of Locally Stable RNA Secondary Structures for Genome-Wide Surveys Preprint Prediction of Locally Stable RNA Secondary Structures for Genome-Wide Surveys I.L. Hofacker, B. Priwitzer and P.F. Stadler Institut für Theoretische Chemie und Molekulare Strukturbiologie, Universität

More information

Sequence Comparison with Mixed Convex and Concave Costs

Sequence Comparison with Mixed Convex and Concave Costs Sequence Comparison with Mixed Convex and Concave Costs David Eppstein Computer Science Department Columbia University New York, NY 10027 February 20, 1989 Running Head: Sequence Comparison with Mixed

More information

Broadcast EncrypCon Amos Fiat & Moni Naor

Broadcast EncrypCon Amos Fiat & Moni Naor Broadcast EncrypCon Amos Fiat & Moni Naor Presented By Gayathri VS Outline q The Problem q Zero Message Schemes à Basic Scheme à 1- resilient Scheme based on 1- way funccon à 1- resilient Scheme based

More information

The wonderful world of RNA informatics

The wonderful world of RNA informatics December 9, 2012 Course Goals Familiarize you with the challenges involved in RNA informatics. Introduce commonly used tools, and provide an intuition for how they work. Give you the background and confidence

More information

Lecture 5: September Time Complexity Analysis of Local Alignment

Lecture 5: September Time Complexity Analysis of Local Alignment CSCI1810: Computational Molecular Biology Fall 2017 Lecture 5: September 21 Lecturer: Sorin Istrail Scribe: Cyrus Cousins Note: LaTeX template courtesy of UC Berkeley EECS dept. Disclaimer: These notes

More information

SA-REPC - Sequence Alignment with a Regular Expression Path Constraint

SA-REPC - Sequence Alignment with a Regular Expression Path Constraint SA-REPC - Sequence Alignment with a Regular Expression Path Constraint Nimrod Milo Tamar Pinhas Michal Ziv-Ukelson Ben-Gurion University of the Negev, Be er Sheva, Israel Graduate Seminar, BGU 2010 Milo,

More information

Hierarchical Modeling of Astronomical Images and Uncertainty in Truncated Data Sets. Brandon Kelly Harvard Smithsonian Center for Astrophysics

Hierarchical Modeling of Astronomical Images and Uncertainty in Truncated Data Sets. Brandon Kelly Harvard Smithsonian Center for Astrophysics Hierarchical Modeling of Astronomical Images and Uncertainty in Truncated Data Sets Brandon Kelly Harvard Smithsonian Center for Astrophysics Overview Deriving physical parameters from astronomical images

More information

PROTEIN SYNTHESIS: TRANSLATION AND THE GENETIC CODE

PROTEIN SYNTHESIS: TRANSLATION AND THE GENETIC CODE PROTEIN SYNTHESIS: TRANSLATION AND THE GENETIC CODE HLeeYu Jsuico Junsay Department of Chemistry School of Science and Engineering Ateneo de Manila University 1 Nucleic Acids are important for their roles

More information

II MoCvaCon SUBSIDENCE MECHANICS: HEAT FLOW ANALOG (38)

II MoCvaCon SUBSIDENCE MECHANICS: HEAT FLOW ANALOG (38) SUBSIDENCE MECHANICS: HEAT FLOW ANALOG (38) I Main Topics A MoCvaCon: Why invescgate heat flow? B Development of 1-D heat flow equacon as analog for consolidacon C Finite-difference interpretacon of heat

More information

RNALogo: a new approach to display structural RNA alignment

RNALogo: a new approach to display structural RNA alignment Published online 21 May 2008 W91 W96 doi:10.1093/nar/gkn258 RNALogo: a new approach to display structural RNA alignment Tzu-Hao Chang 1, Jorng-Tzong Horng 1,2 and Hsien-Da Huang 3,4, * 1 Department of

More information

A Structure-Based Flexible Search Method for Motifs in RNA

A Structure-Based Flexible Search Method for Motifs in RNA JOURNAL OF COMPUTATIONAL BIOLOGY Volume 14, Number 7, 2007 Mary Ann Liebert, Inc. Pp. 908 926 DOI: 10.1089/cmb.2007.0061 A Structure-Based Flexible Search Method for Motifs in RNA ISANA VEKSLER-LUBLINSKY,

More information

RNA and Protein Structure Prediction

RNA and Protein Structure Prediction RNA and Protein Structure Prediction Bioinformatics: Issues and Algorithms CSE 308-408 Spring 2007 Lecture 18-1- Outline Multi-Dimensional Nature of Life RNA Secondary Structure Prediction Protein Structure

More information

Lecture 2: Pairwise Alignment. CG Ron Shamir

Lecture 2: Pairwise Alignment. CG Ron Shamir Lecture 2: Pairwise Alignment 1 Main source 2 Why compare sequences? Human hexosaminidase A vs Mouse hexosaminidase A 3 www.mathworks.com/.../jan04/bio_genome.html Sequence Alignment עימוד רצפים The problem:

More information

Conserved RNA Structures. Ivo L. Hofacker. Institut for Theoretical Chemistry, University Vienna.

Conserved RNA Structures. Ivo L. Hofacker. Institut for Theoretical Chemistry, University Vienna. onserved RN Structures Ivo L. Hofacker Institut for Theoretical hemistry, University Vienna http://www.tbi.univie.ac.at/~ivo/ Bled, January 2002 Energy Directed Folding Predict structures from sequence

More information

Pairwise sequence alignment

Pairwise sequence alignment Department of Evolutionary Biology Example Alignment between very similar human alpha- and beta globins: GSAQVKGHGKKVADALTNAVAHVDDMPNALSALSDLHAHKL G+ +VK+HGKKV A+++++AH+D++ +++++LS+LH KL GNPKVKAHGKKVLGAFSDGLAHLDNLKGTFATLSELHCDKL

More information

A New Similarity Measure among Protein Sequences

A New Similarity Measure among Protein Sequences A New Similarity Measure among Protein Sequences Kuen-Pin Wu, Hsin-Nan Lin, Ting-Yi Sung and Wen-Lian Hsu * Institute of Information Science Academia Sinica, Taipei 115, Taiwan Abstract Protein sequence

More information

Predicting RNA Secondary Structure Using Profile Stochastic Context-Free Grammars and Phylogenic Analysis

Predicting RNA Secondary Structure Using Profile Stochastic Context-Free Grammars and Phylogenic Analysis Fang XY, Luo ZG, Wang ZH. Predicting RNA secondary structure using profile stochastic context-free grammars and phylogenic analysis. JOURNAL OF COMPUTER SCIENCE AND TECHNOLOGY 23(4): 582 589 July 2008

More information

Math 8803/4803, Spring 2008: Discrete Mathematical Biology

Math 8803/4803, Spring 2008: Discrete Mathematical Biology Math 8803/4803, Spring 2008: Discrete Mathematical Biology Prof. hristine Heitsch School of Mathematics eorgia Institute of Technology Lecture 12 February 4, 2008 Levels of RN structure Selective base

More information

Pure Multiple RNA Secondary Structure Alignments: A Progressive Profile Approach

Pure Multiple RNA Secondary Structure Alignments: A Progressive Profile Approach IEEE TRANSACTIONS ON COMPUTATIONAL BIOLOGY AND BIOINFORMATICS, VOL. 1, NO. 1, JANUARY-MARCH 2004 1 Pure Multiple RNA Secondary Structure Alignments: A Progressive Profile Approach Matthias Höchsmann, Björn

More information

Supplementary Material

Supplementary Material Supplementary Material Sm-I Formal Description of the Sampling Process In the sequel, given an RNA molecule r consisting of n nucleotides, we denote the corresponding sequence fragment from position i

More information

STRUCTURAL BIOINFORMATICS I. Fall 2015

STRUCTURAL BIOINFORMATICS I. Fall 2015 STRUCTURAL BIOINFORMATICS I Fall 2015 Info Course Number - Classification: Biology 5411 Class Schedule: Monday 5:30-7:50 PM, SERC Room 456 (4 th floor) Instructors: Vincenzo Carnevale - SERC, Room 704C;

More information

of all secondary structures of k-point mutants of a is an RNA sequence s = s 1,..., s n obtained by mutating

of all secondary structures of k-point mutants of a is an RNA sequence s = s 1,..., s n obtained by mutating BIOINFORMICS Vol. 00 no. 00 2005 Pages 1 10 Energy landscape of k-point mutants of an RN molecule P. Clote 1,2, J. Waldispühl 1,3,4,, B. Behzadi 3, J.-M. Steyaert 3, 1 Department of Biology, Higgins 355,

More information

Lecture 12. DNA/RNA Structure Prediction. Epigenectics Epigenomics: Gene Expression

Lecture 12. DNA/RNA Structure Prediction. Epigenectics Epigenomics: Gene Expression C N F O N G A V B O N F O M A C S V U Master Course DNA/Protein Structurefunction Analysis and Prediction Lecture 12 DNA/NA Structure Prediction pigenectics pigenomics: Gene xpression ranscription factors

More information

RNAdualPF: software to compute the dual partition function with sample applications in molecular evolution theory

RNAdualPF: software to compute the dual partition function with sample applications in molecular evolution theory Garcia-Martin et al. BMC Bioinformatics 2016 17:424 DOI 10.1186/s12859-016-1280-6 SOFTWARE RNAdualPF: software to compute the dual partition function with sample applications in molecular evolution theory

More information

RNA Secondary Structure Prediction: taking conservation into account

RNA Secondary Structure Prediction: taking conservation into account RNA Secondary Structure Prediction: taking conservation into account 1 13 June 2006 2 Main approaches to RNA secondary structure prediction Energy minimization (Single-strand Folding) does not require

More information

Outline. Approximation: Theory and Algorithms. Motivation. Outline. The String Edit Distance. Nikolaus Augsten. Unit 2 March 6, 2009

Outline. Approximation: Theory and Algorithms. Motivation. Outline. The String Edit Distance. Nikolaus Augsten. Unit 2 March 6, 2009 Outline Approximation: Theory and Algorithms The Nikolaus Augsten Free University of Bozen-Bolzano Faculty of Computer Science DIS Unit 2 March 6, 2009 1 Nikolaus Augsten (DIS) Approximation: Theory and

More information

Homology Modeling (Comparative Structure Modeling) GBCB 5874: Problem Solving in GBCB

Homology Modeling (Comparative Structure Modeling) GBCB 5874: Problem Solving in GBCB Homology Modeling (Comparative Structure Modeling) Aims of Structural Genomics High-throughput 3D structure determination and analysis To determine or predict the 3D structures of all the proteins encoded

More information

Collabora've Filtering

Collabora've Filtering Collabora've Filtering EECS 349 Machine Learning Bongjun Kim Fall, 2015 What is CollaboraCve Filtering? RecommendaCon system Amazon recommends items based on your purchase history and racngs RecommendaCon

More information

Page 1. References. Hidden Markov models and multiple sequence alignment. Markov chains. Probability review. Example. Markovian sequence

Page 1. References. Hidden Markov models and multiple sequence alignment. Markov chains. Probability review. Example. Markovian sequence Page Hidden Markov models and multiple sequence alignment Russ B Altman BMI 4 CS 74 Some slides borrowed from Scott C Schmidler (BMI graduate student) References Bioinformatics Classic: Krogh et al (994)

More information

Analytical Study of Hexapod mirnas using Phylogenetic Methods

Analytical Study of Hexapod mirnas using Phylogenetic Methods Analytical Study of Hexapod mirnas using Phylogenetic Methods A.K. Mishra and H.Chandrasekharan Unit of Simulation & Informatics, Indian Agricultural Research Institute, New Delhi, India akmishra@iari.res.in,

More information

arxiv: v1 [q-bio.bm] 25 Jul 2012

arxiv: v1 [q-bio.bm] 25 Jul 2012 CoFold: thermodynamic RNA structure prediction with a kinetic twist arxiv:1207.6013v1 [q-bio.bm] 25 Jul 2012 Jeff R. Proctor and Irmtraud M. Meyer Centre for High-Throughput Biology & Department of Computer

More information

Bioinformatics Advance Access published July 14, Jens Reeder, Robert Giegerich

Bioinformatics Advance Access published July 14, Jens Reeder, Robert Giegerich Bioinformatics Advance Access published July 14, 2005 BIOINFORMATICS Consensus Shapes: An Alternative to the Sankoff Algorithm for RNA Consensus Structure Prediction Jens Reeder, Robert Giegerich Faculty

More information

Junction-Explorer Help File

Junction-Explorer Help File Junction-Explorer Help File Dongrong Wen, Christian Laing, Jason T. L. Wang and Tamar Schlick Overview RNA junctions are important structural elements of three or more helices in the organization of the

More information

CMPS 6630: Introduction to Computational Biology and Bioinformatics. Structure Comparison

CMPS 6630: Introduction to Computational Biology and Bioinformatics. Structure Comparison CMPS 6630: Introduction to Computational Biology and Bioinformatics Structure Comparison Protein Structure Comparison Motivation Understand sequence and structure variability Understand Domain architecture

More information

Algorithms in Bioinformatics FOUR Pairwise Sequence Alignment. Pairwise Sequence Alignment. Convention: DNA Sequences 5. Sequence Alignment

Algorithms in Bioinformatics FOUR Pairwise Sequence Alignment. Pairwise Sequence Alignment. Convention: DNA Sequences 5. Sequence Alignment Algorithms in Bioinformatics FOUR Sami Khuri Department of Computer Science San José State University Pairwise Sequence Alignment Homology Similarity Global string alignment Local string alignment Dot

More information

Finding Consensus Energy Folding Landscapes Between RNA Sequences

Finding Consensus Energy Folding Landscapes Between RNA Sequences University of Central Florida Electronic Theses and Dissertations Masters Thesis (Open Access) Finding Consensus Energy Folding Landscapes Between RNA Sequences 2015 Joshua Burbridge University of Central

More information

BLAST: Target frequencies and information content Dannie Durand

BLAST: Target frequencies and information content Dannie Durand Computational Genomics and Molecular Biology, Fall 2016 1 BLAST: Target frequencies and information content Dannie Durand BLAST has two components: a fast heuristic for searching for similar sequences

More information

Approximation: Theory and Algorithms

Approximation: Theory and Algorithms Approximation: Theory and Algorithms The String Edit Distance Nikolaus Augsten Free University of Bozen-Bolzano Faculty of Computer Science DIS Unit 2 March 6, 2009 Nikolaus Augsten (DIS) Approximation:

More information

Sequence analysis and Genomics

Sequence analysis and Genomics Sequence analysis and Genomics October 12 th November 23 rd 2 PM 5 PM Prof. Peter Stadler Dr. Katja Nowick Katja: group leader TFome and Transcriptome Evolution Bioinformatics group Paul-Flechsig-Institute

More information

Journal of Mathematical Analysis and Applications

Journal of Mathematical Analysis and Applications J. Math. Anal. Appl. 383 (011) 00 07 Contents lists available at ScienceDirect Journal of Mathematical Analysis and Applications www.elsevier.com/locate/jmaa Asymptotic enumeration of some RNA secondary

More information

A tutorial on RNA folding methods and resources

A tutorial on RNA folding methods and resources A tutorial on RNA folding methods and resources Alain Denise, LRI/IGM, Université Paris-Sud with invaluable help from Yann Ponty, CNRS/Ecole Polytechnique 1 Master BIBS 2014-2015 Goals To help your work

More information

Sparse RNA Folding: Time and Space Efficient Algorithms

Sparse RNA Folding: Time and Space Efficient Algorithms Sparse RNA Folding: Time and Space Efficient Algorithms Rolf Backofen 1, Dekel Tsur 2, Shay Zakov 2, and Michal Ziv-Ukelson 2 1 Albert Ludwigs University, Freiburg, Germany backofen@informatik.uni-freiburg.de

More information

RNA SECONDARY STRUCTURES AND THEIR PREDICTION 1. Centre de Recherche de MatMmatiques Appliqu6es, Universit6 de Montr6al, Montreal, Canada H3C 3J7

RNA SECONDARY STRUCTURES AND THEIR PREDICTION 1. Centre de Recherche de MatMmatiques Appliqu6es, Universit6 de Montr6al, Montreal, Canada H3C 3J7 Bulletin of Mathematical Biology Vol. 46, No. 4, pp. 591-621, 1984. Printed in Great Britain 0092-8240/8453.00 + 0.00 Pergamon Press Ltd. Society for Mathematical Biology RNA SECONDARY STRUCTURES AND THEIR

More information

Determinants of 2 2 Matrices

Determinants of 2 2 Matrices Determinants In section 4, we discussed inverses of matrices, and in particular asked an important question: How can we tell whether or not a particular square matrix A has an inverse? We will be able

More information

Lecture 4: Evolutionary Models and Substitution Matrices (PAM and BLOSUM)

Lecture 4: Evolutionary Models and Substitution Matrices (PAM and BLOSUM) Bioinformatics II Probability and Statistics Universität Zürich and ETH Zürich Spring Semester 2009 Lecture 4: Evolutionary Models and Substitution Matrices (PAM and BLOSUM) Dr Fraser Daly adapted from

More information

Characterising RNA secondary structure space using information entropy

Characterising RNA secondary structure space using information entropy Characterising RNA secondary structure space using information entropy Zsuzsanna Sükösd 1,2,3, Bjarne Knudsen 4, James WJ Anderson 5, Ádám Novák 5,6, Jørgen Kjems 2,3 and Christian NS Pedersen 1,7 1 Bioinformatics

More information

Grand Plan. RNA very basic structure 3D structure Secondary structure / predictions The RNA world

Grand Plan. RNA very basic structure 3D structure Secondary structure / predictions The RNA world Grand Plan RNA very basic structure 3D structure Secondary structure / predictions The RNA world very quick Andrew Torda, April 2017 Andrew Torda 10/04/2017 [ 1 ] Roles of molecules RNA DNA proteins genetic

More information

Hairpin Database: Why and How?

Hairpin Database: Why and How? Hairpin Database: Why and How? Clark Jeffries Research Professor Renaissance Computing Institute and School of Pharmacy University of North Carolina at Chapel Hill, United States Why should a database

More information

NUMERICAL SOLUTION OF THE 1- D DIFFUSION EQUATION (39)

NUMERICAL SOLUTION OF THE 1- D DIFFUSION EQUATION (39) 4/4/15 NUMERICAL SOLUTION OF THE 1- D DIFFUSION EQUATION (39) I Main Topics A MoCvaCon for using a numerical technique B Non- dimensionalizing the diffusion (heat flow) equacon C Finite- difference solucon

More information

Computational Biology

Computational Biology Computational Biology Lecture 6 31 October 2004 1 Overview Scoring matrices (Thanks to Shannon McWeeney) BLAST algorithm Start sequence alignment 2 1 What is a homologous sequence? A homologous sequence,

More information

Quantitative modeling of RNA single-molecule experiments. Ralf Bundschuh Department of Physics, Ohio State University

Quantitative modeling of RNA single-molecule experiments. Ralf Bundschuh Department of Physics, Ohio State University Quantitative modeling of RN single-molecule experiments Ralf Bundschuh Department of Physics, Ohio State niversity ollaborators: lrich erland, LM München Terence Hwa, San Diego Outline: Single-molecule

More information

Bioinformatics (GLOBEX, Summer 2015) Pairwise sequence alignment

Bioinformatics (GLOBEX, Summer 2015) Pairwise sequence alignment Bioinformatics (GLOBEX, Summer 2015) Pairwise sequence alignment Substitution score matrices, PAM, BLOSUM Needleman-Wunsch algorithm (Global) Smith-Waterman algorithm (Local) BLAST (local, heuristic) E-value

More information

Vincenzo Vagnoni (INFN Bologna) on behalf of the LHCb Collabora:on

Vincenzo Vagnoni (INFN Bologna) on behalf of the LHCb Collabora:on Vincenzo Vagnoni (INFN Bologna) on behalf of the LHCb Collabora:on 13th Interna:onal Conference on B- Physics at Hadron Machines April 4th- 8th 2011, Amsterdam 1 LHCb detector in brief B- hadron produc:on

More information

arxiv: v1 [q-bio.bm] 16 Aug 2015

arxiv: v1 [q-bio.bm] 16 Aug 2015 Asymptotic connectivity for the network of RNA secondary structures. Clote arxiv:1508.03815v1 [q-bio.bm] 16 Aug 2015 Biology Department, Boston College, Chestnut Hill, MA 02467, clote@bc.edu Abstract Given

More information