DNA/RNA Structure Prediction

Size: px
Start display at page:

Download "DNA/RNA Structure Prediction"

Transcription

1 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

2 Epigenectics Epigenomics: Gene Expression Transcription factors (TF) are essential for transcription initialisation Transcription is done by polymerase type II (eukaryotes) mrna must then move from nucleus to ribosomes (extranuclear) for translation In eukaryotes there can be many TF-binding sites upstream of an ORF that together regulate transcription Nucleosomes (chromatin structures composed of histones) are structures round of which DNA coils. This blocks access of TFs

3 Epigenectics Epigenomics: Gene Expression TF binding site (closed) mrna transcription TATA Nucleosome TF binding site (open)

4 Expression Because DNA has flexibility, bound TFs can move in order to interact with pol II, which is necessary for transcription initiation (see next slide) Recent TF-based initialisation theory includes a wave function (Carlsberg) of TF-binding, which is supposed to go from left to right. In this way the TF-binding site nearest to the TATA box would be bound by a TF which will then in turn bind Pol II. It has been suggested that Speckles have something to do with this (speckels are observed protein plaques in the nucleus) Current prediction methods for gene co-expression, e.g. finding a single shared TF binding site, do not take this TF cooperativity into account ( parking lot optimisation )

5 Expression.. TF binding site TF Pol II mrna transcription TATA mrna Speckel This is still a hypothetical model TF binding site

6 DNA/RNA Structure-Function relationships Apart from coding for proteins via genes, DNA is now known to code for many more RNA-based cell components (snrna, rrna,..) The importance of structural features of DNA (e.g. bendability, binding histones, methylation) is becoming ever more important. For the many different classes of RNA molecules, structure is directly causing function It is therefore important to analyse and predict DNA structure, but particularly, RNA structure

7 Canonical base pairs The complementary bases, C-G and A-U form stable base pairs with each other through the creation of hydrogen bonds between donor and acceptor sites on the bases. These are called Watson-Crick base pairs and are also referred to as canonical base pairs. In addition, we consider the weaker G-U wobble pair, where the bases bond in a skewed fashion. Other base pairs also occur, some of which are stable. These are all called noncanonical base pairs.

8 RNA secondary structure The secondary structure of an RNA molecule is the collection of base pairs that occur in its 3-dimensional structure. An RNA sequence will be represented as R = r 1, r 1, r 2, r 3,, r n, where r i is called the i th (ribo)nucleotide. Each r i belongs to the set {a,c,g,u}..

9 Secondary Structure and Pseudoknots A secondary structure, or folding, on R is a set S of ordered pairs, written as i-j, satisfying: 1.j - i > 4 2.If i-j and i -j are 2 base pairs, (assuming without loss in generality that i i ), then either: 1. i = i and j = j (they are the same base pair), 2. i j i j (i-j precedes i -j ), or 3. i i j j (i-j includes i -j ) The last condition excludes pseudoknots. These occur when 2 base pairs, i-j and i -j, satisfy i i j j.

10 Pseudoknots Pseudoknots are not taken into account in secondary structure prediction because energy minimizing methods cannot deal with them. It is not known how to assign energies to the loops created by pseudoknots and dynamic programming methods that compute minimum energy structures break down. For this reason, pseudoknots are often considered as belonging to tertiary structure. However, pseudoknots are real and important structural features. However, covariance methods (next slide) are able to predict them from aligned, homologous RNA sequences. The Figure on the next slide represents a small pseudoknot model.

11 A 3D model of a pseudoknot

12 A 3D model of a pseudoknot The 2 helices in the structure (preceding slide) are stacked coaxially. RNA structure can be predicted from sequence data. There are two basic routes. 1. The first attempts structure prediction of single sequences based on minimizing the free energy of folding. 2. The second computes common foldings for a family of aligned, homologous RNAs. Usually, the alignment and secondary structure inference must be performed simultaneously, or at least iteratively (see next slide)

13 Predicting RNA Secondary Structure By Thermodynamics Method Minimize Gibbs Free Energy By Phylogenetic Comparison Method (Covariance method) Compare RNA Sequences of Identical Function From Different Organisms By Combination of the Above Two Methods In principle, this could be the most powerful method

14 Thermodynamics Gibbs Free Energy, G Describes the energetics of biomolecules in aqueous solution. The change in free energy, G, for a chemical process, such as nucleic acid folding, can be used to determine the direction of the process: G=0: equilibrium G>0: unfavorable process G<0: favorable process Thus the natural tendency for biomolecules in solution is to minimize free energy of the entire system (biomolecules + solvent).

15 Thermodynamics G = H - T S H is enthalpy, S is entropy, and T is the temperature in Kelvin. Molecular interactions, such as hydrogen bonds, van der Waals and electrostatic interactions contribute to the H term. S describes the change of order of the system. Thus, both molecular interactions as well as the order of the system determine the direction of a chemical process. For any nucleic acid solution, it is extremely difficult to calculate the free energy from first principle Biophysical methods can be used to measure free energy changes

16 Thermodynamics The Equilibrium Partition Function For a population of structures S, a partition function Q and the probability for a particular folding, s can be calculated: Q = s G s e RT S The heat capacity for the RNA can be obtained: G = RT ln Q and Gs e RT Heat capacity Cp (heat required to change temperature by 1 degree) can be measured experimentally, and can then be used to get information on G Q 2 G Cp = T T 2 is probability

17 Zuker s Energy Minimization Method (mfold) An RNA Sequence is called R= {r 1,r 2,r 3 r n }, where r i is the i th ribonucleotide and it belongs to a set of {A, U, G, C} A secondary structure of R is a set S of base pairs, i.j, which satisfies: 1=<i<j=<n; j-i>4 (can t have loop containing less than 4 nucleotides); If i,j and i.j are two basepairs, (assume i =< i ), then either» i = i and j = j (same base pair)» i < j < i < j (i.j proceeds i.j ) or» i < i < j < j (i.j includes i. j ) (this excludes pseudoknots which is i<i <j<j ) If e(i,j) is the energy for the base pair i.j, the total energy for R is The objective is to minimize E(S). E( S) = i, j S e( i, j)

18 Zuker s Energy Minimization Method (mfold) Free Energy Parameters Extensive database of free energies for the following RNA units has been obtained (so called Tinoco Rules and Turner Rules ): Single Strand Stacking energy Canonical (AU GC) and non-canonical (GU) basepairs in duplexes Still lacking accurate free energy parameters for Loops Mismatches (AA, CA etc) Using these energy parameters, the current version of mfold can predict ~73% phylogenetically deduced secondary structures.

19 Dynamic Programming (mfold) An Example of W(i,j) A matrix W(i,j) is computed that is dependent on the experimentally measured basepair energy e(i,j) Recursion begins with i=1, j=n 1. If W(i+1,j)=W(i,j), then i is not paired. Set i=i+1 and start the recursion again. 2. If W(i,j-1)=W(i,j), then j is not paired. Set j=j-1 and start the recursion again. 3. If W(i,j)=W(i,k)+W(k+1,j), the fragment k+1,j gets put on a stack and the fragment i k is analyzed by setting j = k and going back to the recursion beginning. 4. If W(i,j)=e(i,j)+W(i+1,j-1), a basepair is identified and is added to the list by setting i=i+1 and j=j-1

20 Suboptimal Folding (mfold) For any sequence of N nucleotides, the expected number of structures is greater than 1.8 N A sequence of 100 nucleotides has 3x10 25 foldings. If a computer can calculate 1000 strs./s -1, it would take years! mfold generates suboptimal foldings whose free energy fall within a certain range of values. Many of these structures are different in trivial ways. These suboptimal foldings can still be useful for designing experiments.

21 A computer predicted folding of Bacillus subtilis RNase P RNA These three representations are equivalent..

22 Secondary Structure Prediction for Aligned RNA Sequences Both energy as well as RNA sequence covariation can be combined to predict RNA secondary structures To quantify sequence covariation, let f i (X) be the frequency of base X at aligned position I and f ij (XY) be the frequency of finding X in i and Y in j, the mutual information score is (Chiu & Kolodziejczak and Gutell & Woese) fij ( XY ) M ij= fij ( XY )log X, Y fi ( X ) f j ( Y ) if for instance only GC and GU pairs at positions i and j then M ij =0. The total energy for RNA is set to a linear combination of measured free energy plus the covariance contribution

23 Other Secondary Prediction Methods Nusinov algorithm (historically important), Hogeweg and Hesper (1984) Vienna: uses the same recursive method in searching the folding space Added the option of computing the population of RNA secondary structures by the equilibrium partition function Specific heat of an RNA can be calculated by numerical differentiation from the equilibrium partition function RNACAD: An effort in improving multiple RNA sequence alignment by taking into account both primary as well secondary structure information Use Stochastic Context-Free Grammars (SCFGs), an extension of hidden Markov models (HMMs) method Bundschuh, R., and Hwa, T. (1999) RNA secondary structure formation: A solvable model of heteropolymer folding. PHYSICAL REVIEW LETTERS 83, This work treats RNA as heteropolymer and uses a simplified Go-like model to provide an exact solution for RNA transition between its native and molten phases.

24 Running mfold Constraints can be entered 1. force bases i,i+1,...,i+k-1 to be double stranded by entering: F i 0 k on 1 line in the constraint box. 2. force consecutive base pairs i.j,i+1.j-1,...,i+k-1.j-k+1 by entering: F i j k on 1 line in the constraint box. 3. force bases i,i+1,...,i+k-1 to be single stranded by entering: P i 0 k on 1 line in the constraint box. 4. prohibit the consecutive base pairs i.j,i+1.j-1,...,i+k-1.j-k+1 by entering: P i j k on 1 line in the constraint box. 5. prohibit bases i to j from pairing with bases k to l by entering: P i-j k-l on 1 line in the constraint box.

25 Running mfold 5 -CUUGGAUGGGUGACCACCUGGG-3 No constraint F entered

26 Predicting RNA 3D Structures Currently available RNA 3D structure prediction programs make use the fact that a tertiary structure is built upon preformed secondary structures So once a solid secondary structure can be predicted, it is possible to predict its 3D structure The chances of obtaining a valid 3D structure can be increased by known space constraints among the different secondary segments (e.g. cross-linking, NMR results). However, there are far less thermodynamic data on 3- D RNA structures which makes 3-D structure prediction challenging.

27 Mc-Sym Mc-Sym uses backtracking method to solve a general problem in computer science called the constraint satisfaction problem (CSP) Backtracking algorithm organizes the search space as a tree where each node corresponds to the application of an operator At each application, if the partially folded RNA structure is consistent with its RNA conformational database, the next operator is applied, otherwise the entire attached branch is pruned and the algorithm backtracks to the previous node.

28 Mc-Sym (Continued) The selection of a spanning tree for a particular RNA is left to the user, but it is suggested that the nucleotides imposing the most constraints are introduced first Users also supply a particular Mc-Sym conformation for each nucleotide. These conformers are derived from currently available 3D databases

29 Sample script: Mc-Sym (Continued) SEQUENCE 1 A r GAAUGCCUGCGAGCAUC CC ;; DECLARE ;; 1 helixa * 2 helixa * 3 helixa * 4 helixa * 5 helixa * 6 helixa * 19 helixa * ;; ;; RELATIONS ;; 18 helix * helix * helix * helix * 6 4 helix * 5 3 helix * 4 2 helix * 3 1 helix * 2 ;; BUILD ; ;; CONSTRAINTS ;; (enter experimental constraints)

30 RNA-protein Interactions There is currently no computational method that can predict the RNA-protein interaction interfaces; Statistical methods have been applied to identify structure features at the protein-rna interface. For instance, ENTANCLE finds that most atoms contributed from a protein to recogonizing an RNA are from main chains (C, O, N, H), not from side chains! But much remains to be done; Electrostatic potential has primary importance in protein-rna recognition due to the negatively charged phosphate backbones. Efforts are made to quantify electrostatic potential at the molecular surface of a protein and RNA in order to predict the site of RNA interaction. This often provides good prediction at least for the site on the protein.

31 References Predicting RNA secondary structures: good reviews 1. Turner, D. H., and Sugimoto, N. (1988) RNA structure prediction. Annu Rev Biophys Biophys Chem 17, Zuker, M. (2000) Calculating nucleic acid secondary structure. Curr Opin Struct Biol 10, Obtaining experimental thermodynamics parameters: 3. Xia, T., SantaLucia, J., Jr., Burkard, M. E., Kierzek, R., Schroeder, S. J., Jiao, X., Cox, C., and Turner, D. H. (1998) Thermodynamic parameters for an expanded nearest-neighbor model for formation of RNA duplexes with Watson- Crick base pairs. Biochemistry 37, Borer, P. N., Dengler, B., Tinoco, I., Jr., and Uhlenbeck, O. C. (1974) Stability of ribonucleic acid double-stranded helices. J Mol Biol 86, Thermodynamics Theory for RNA structure prediction: 5. Bundschuh, R., and Hwa, T. (1999) RNA secondary structure formation: A solvable model of heteropolymer folding. PHYSICAL REVIEW LETTERS 83, McCaskill, J. S. (1990) The equilibrium partition function and base pair binding probabilities for RNA secondary structure. Biopolymers 29,

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

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

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

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

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

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

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

DNA Structure. Voet & Voet: Chapter 29 Pages Slide 1

DNA Structure. Voet & Voet: Chapter 29 Pages Slide 1 DNA Structure Voet & Voet: Chapter 29 Pages 1107-1122 Slide 1 Review The four DNA bases and their atom names The four common -D-ribose conformations All B-DNA ribose adopt the C2' endo conformation All

More information

Chapter 9 DNA recognition by eukaryotic transcription factors

Chapter 9 DNA recognition by eukaryotic transcription factors Chapter 9 DNA recognition by eukaryotic transcription factors TRANSCRIPTION 101 Eukaryotic RNA polymerases RNA polymerase RNA polymerase I RNA polymerase II RNA polymerase III RNA polymerase IV Function

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

Biomolecules. Energetics in biology. Biomolecules inside the cell

Biomolecules. Energetics in biology. Biomolecules inside the cell Biomolecules Energetics in biology Biomolecules inside the cell Energetics in biology The production of energy, its storage, and its use are central to the economy of the cell. Energy may be defined as

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

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

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

Biophysical Model Building

Biophysical Model Building Biophysical Model Building Step 1: Come up with a hypothesis about how a system works How many binding sites? Is there cooperativity? Step 2: Translate the qualitative hypotheses into an observable mathematical

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

THE TANGO ALGORITHM: SECONDARY STRUCTURE PROPENSITIES, STATISTICAL MECHANICS APPROXIMATION

THE TANGO ALGORITHM: SECONDARY STRUCTURE PROPENSITIES, STATISTICAL MECHANICS APPROXIMATION THE TANGO ALGORITHM: SECONDARY STRUCTURE PROPENSITIES, STATISTICAL MECHANICS APPROXIMATION AND CALIBRATION Calculation of turn and beta intrinsic propensities. A statistical analysis of a protein structure

More information

Ranjit P. Bahadur Assistant Professor Department of Biotechnology Indian Institute of Technology Kharagpur, India. 1 st November, 2013

Ranjit P. Bahadur Assistant Professor Department of Biotechnology Indian Institute of Technology Kharagpur, India. 1 st November, 2013 Hydration of protein-rna recognition sites Ranjit P. Bahadur Assistant Professor Department of Biotechnology Indian Institute of Technology Kharagpur, India 1 st November, 2013 Central Dogma of life DNA

More information

BME 5742 Biosystems Modeling and Control

BME 5742 Biosystems Modeling and Control BME 5742 Biosystems Modeling and Control Lecture 24 Unregulated Gene Expression Model Dr. Zvi Roth (FAU) 1 The genetic material inside a cell, encoded in its DNA, governs the response of a cell to various

More information

Predicting free energy landscapes for complexes of double-stranded chain molecules

Predicting free energy landscapes for complexes of double-stranded chain molecules JOURNAL OF CHEMICAL PHYSICS VOLUME 114, NUMBER 9 1 MARCH 2001 Predicting free energy landscapes for complexes of double-stranded chain molecules Wenbing Zhang and Shi-Jie Chen a) Department of Physics

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

Computational Biology: Basics & Interesting Problems

Computational Biology: Basics & Interesting Problems Computational Biology: Basics & Interesting Problems Summary Sources of information Biological concepts: structure & terminology Sequencing Gene finding Protein structure prediction Sources of information

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

GCD3033:Cell Biology. Transcription

GCD3033:Cell Biology. Transcription Transcription Transcription: DNA to RNA A) production of complementary strand of DNA B) RNA types C) transcription start/stop signals D) Initiation of eukaryotic gene expression E) transcription factors

More information

Biophysics Lectures Three and Four

Biophysics Lectures Three and Four Biophysics Lectures Three and Four Kevin Cahill cahill@unm.edu http://dna.phys.unm.edu/ 1 The Atoms and Molecules of Life Cells are mostly made from the most abundant chemical elements, H, C, O, N, Ca,

More information

Newly made RNA is called primary transcript and is modified in three ways before leaving the nucleus:

Newly made RNA is called primary transcript and is modified in three ways before leaving the nucleus: m Eukaryotic mrna processing Newly made RNA is called primary transcript and is modified in three ways before leaving the nucleus: Cap structure a modified guanine base is added to the 5 end. Poly-A tail

More information

Proteins are not rigid structures: Protein dynamics, conformational variability, and thermodynamic stability

Proteins are not rigid structures: Protein dynamics, conformational variability, and thermodynamic stability Proteins are not rigid structures: Protein dynamics, conformational variability, and thermodynamic stability Dr. Andrew Lee UNC School of Pharmacy (Div. Chemical Biology and Medicinal Chemistry) UNC Med

More information

From gene to protein. Premedical biology

From gene to protein. Premedical biology From gene to protein Premedical biology Central dogma of Biology, Molecular Biology, Genetics transcription replication reverse transcription translation DNA RNA Protein RNA chemically similar to DNA,

More information

Lecture 2 and 3: Review of forces (ctd.) and elementary statistical mechanics. Contributions to protein stability

Lecture 2 and 3: Review of forces (ctd.) and elementary statistical mechanics. Contributions to protein stability Lecture 2 and 3: Review of forces (ctd.) and elementary statistical mechanics. Contributions to protein stability Part I. Review of forces Covalent bonds Non-covalent Interactions: Van der Waals Interactions

More information

Lecture 9:3 RNA Structure and Function

Lecture 9:3 RNA Structure and Function Lecture 9:3 RNA Structure and Function Day 9: Day June 4, 2003: 13:45 15:15 Marcel Turcotte, University of Ottawa Key Concepts - Structure and function. - Primary, secondary and tertiary structure. - Structure

More information

2.4 DNA structure. S(l) bl + c log l + d, with c 1.8k B. (2.72)

2.4 DNA structure. S(l) bl + c log l + d, with c 1.8k B. (2.72) 2.4 DNA structure DNA molecules come in a wide range of length scales, from roughly 50,000 monomers in a λ-phage, 6 0 9 for human, to 9 0 0 nucleotides in the lily. The latter would be around thirty meters

More information

Chapter 1. Topic: Overview of basic principles

Chapter 1. Topic: Overview of basic principles Chapter 1 Topic: Overview of basic principles Four major themes of biochemistry I. What are living organism made from? II. How do organism acquire and use energy? III. How does an organism maintain its

More information

COMP 598 Advanced Computational Biology Methods & Research. Introduction. Jérôme Waldispühl School of Computer Science McGill University

COMP 598 Advanced Computational Biology Methods & Research. Introduction. Jérôme Waldispühl School of Computer Science McGill University COMP 598 Advanced Computational Biology Methods & Research Introduction Jérôme Waldispühl School of Computer Science McGill University General informations (1) Office hours: by appointment Office: TR3018

More information

From Gene to Protein

From Gene to Protein From Gene to Protein Gene Expression Process by which DNA directs the synthesis of a protein 2 stages transcription translation All organisms One gene one protein 1. Transcription of DNA Gene Composed

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

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

UNIT 5. Protein Synthesis 11/22/16

UNIT 5. Protein Synthesis 11/22/16 UNIT 5 Protein Synthesis IV. Transcription (8.4) A. RNA carries DNA s instruction 1. Francis Crick defined the central dogma of molecular biology a. Replication copies DNA b. Transcription converts DNA

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

= (-22) = +2kJ /mol

= (-22) = +2kJ /mol Lecture 8: Thermodynamics & Protein Stability Assigned reading in Campbell: Chapter 4.4-4.6 Key Terms: DG = -RT lnk eq = DH - TDS Transition Curve, Melting Curve, Tm DH calculation DS calculation van der

More information

Exploring the Sequence Dependent Structure and Dynamics of DNA with Molecular Dynamics Simulation

Exploring the Sequence Dependent Structure and Dynamics of DNA with Molecular Dynamics Simulation Exploring the Sequence Dependent Structure and Dynamics of DNA with Molecular Dynamics Simulation Sarah Harris School of Physics and Astronomy University of Leeds Introduction Calculations of the charge

More information

Chapter 1. A Method to Predict the 3D Structure of an RNA Scaffold. Xiaojun Xu and Shi-Jie Chen. Abstract. 1 Introduction

Chapter 1. A Method to Predict the 3D Structure of an RNA Scaffold. Xiaojun Xu and Shi-Jie Chen. Abstract. 1 Introduction Chapter 1 Abstract The ever increasing discoveries of noncoding RNA functions draw a strong demand for RNA structure determination from the sequence. In recently years, computational studies for RNA structures,

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

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

Section 10/5/06. Junaid Malek, M.D.

Section 10/5/06. Junaid Malek, M.D. Section 10/5/06 Junaid Malek, M.D. Equilibrium Occurs when two interconverting states are stable This is represented using stacked arrows: State A State B, where State A and State B can represent any number

More information

Chapters 12&13 Notes: DNA, RNA & Protein Synthesis

Chapters 12&13 Notes: DNA, RNA & Protein Synthesis Chapters 12&13 Notes: DNA, RNA & Protein Synthesis Name Period Words to Know: nucleotides, DNA, complementary base pairing, replication, genes, proteins, mrna, rrna, trna, transcription, translation, codon,

More information

15.2 Prokaryotic Transcription *

15.2 Prokaryotic Transcription * OpenStax-CNX module: m52697 1 15.2 Prokaryotic Transcription * Shannon McDermott Based on Prokaryotic Transcription by OpenStax This work is produced by OpenStax-CNX and licensed under the Creative Commons

More information

Chapter

Chapter Chapter 17 17.4-17.6 Molecular Components of Translation A cell interprets a genetic message and builds a polypeptide The message is a series of codons on mrna The interpreter is called transfer (trna)

More information

Using SetPSO to determine RNA secondary structure

Using SetPSO to determine RNA secondary structure Using SetPSO to determine RNA secondary structure by Charles Marais Neethling Submitted in partial fulfilment of the requirements for the degree of Master of Science (Computer Science) in the Faculty of

More information

Protein Synthesis. Unit 6 Goal: Students will be able to describe the processes of transcription and translation.

Protein Synthesis. Unit 6 Goal: Students will be able to describe the processes of transcription and translation. Protein Synthesis Unit 6 Goal: Students will be able to describe the processes of transcription and translation. Types of RNA Messenger RNA (mrna) makes a copy of DNA, carries instructions for making proteins,

More information

Biophysics II. Hydrophobic Bio-molecules. Key points to be covered. Molecular Interactions in Bio-molecular Structures - van der Waals Interaction

Biophysics II. Hydrophobic Bio-molecules. Key points to be covered. Molecular Interactions in Bio-molecular Structures - van der Waals Interaction Biophysics II Key points to be covered By A/Prof. Xiang Yang Liu Biophysics & Micro/nanostructures Lab Department of Physics, NUS 1. van der Waals Interaction 2. Hydrogen bond 3. Hydrophilic vs hydrophobic

More information

Contents. xiii. Preface v

Contents. xiii. Preface v Contents Preface Chapter 1 Biological Macromolecules 1.1 General PrincipIes 1.1.1 Macrornolecules 1.2 1.1.2 Configuration and Conformation Molecular lnteractions in Macromolecular Structures 1.2.1 Weak

More information

RNA & PROTEIN SYNTHESIS. Making Proteins Using Directions From DNA

RNA & PROTEIN SYNTHESIS. Making Proteins Using Directions From DNA RNA & PROTEIN SYNTHESIS Making Proteins Using Directions From DNA RNA & Protein Synthesis v Nitrogenous bases in DNA contain information that directs protein synthesis v DNA remains in nucleus v in order

More information

Nucleus. The nucleus is a membrane bound organelle that store, protect and express most of the genetic information(dna) found in the cell.

Nucleus. The nucleus is a membrane bound organelle that store, protect and express most of the genetic information(dna) found in the cell. Nucleus The nucleus is a membrane bound organelle that store, protect and express most of the genetic information(dna) found in the cell. Since regulation of gene expression takes place in the nucleus,

More information

Short Announcements. 1 st Quiz today: 15 minutes. Homework 3: Due next Wednesday.

Short Announcements. 1 st Quiz today: 15 minutes. Homework 3: Due next Wednesday. Short Announcements 1 st Quiz today: 15 minutes Homework 3: Due next Wednesday. Next Lecture, on Visualizing Molecular Dynamics (VMD) by Klaus Schulten Today s Lecture: Protein Folding, Misfolding, Aggregation

More information

Lecture 18 June 2 nd, Gene Expression Regulation Mutations

Lecture 18 June 2 nd, Gene Expression Regulation Mutations Lecture 18 June 2 nd, 2016 Gene Expression Regulation Mutations From Gene to Protein Central Dogma Replication DNA RNA PROTEIN Transcription Translation RNA Viruses: genome is RNA Reverse Transcriptase

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

A Novel Statistical Model for the Secondary Structure of RNA

A Novel Statistical Model for the Secondary Structure of RNA ISBN 978-1-8466-93-3 Proceedings of the 5th International ongress on Mathematical Biology (IMB11) Vol. 3 Nanjing, P. R. hina, June 3-5, 11 Novel Statistical Model for the Secondary Structure of RN Liu

More information

Chapter 1. DNA is made from the building blocks adenine, guanine, cytosine, and. Answer: d

Chapter 1. DNA is made from the building blocks adenine, guanine, cytosine, and. Answer: d Chapter 1 1. Matching Questions DNA is made from the building blocks adenine, guanine, cytosine, and. Answer: d 2. Matching Questions : Unbranched polymer that, when folded into its three-dimensional shape,

More information

A rule of seven in Watson-Crick base-pairing of mismatched sequences

A rule of seven in Watson-Crick base-pairing of mismatched sequences A rule of seven in Watson-Crick base-pairing of mismatched sequences Ibrahim I. Cisse 1,3, Hajin Kim 1,2, Taekjip Ha 1,2 1 Department of Physics and Center for the Physics of Living Cells, University of

More information

Organic Chemistry Option II: Chemical Biology

Organic Chemistry Option II: Chemical Biology Organic Chemistry Option II: Chemical Biology Recommended books: Dr Stuart Conway Department of Chemistry, Chemistry Research Laboratory, University of Oxford email: stuart.conway@chem.ox.ac.uk Teaching

More information

Principles of Physical Biochemistry

Principles of Physical Biochemistry Principles of Physical Biochemistry Kensal E. van Hold e W. Curtis Johnso n P. Shing Ho Preface x i PART 1 MACROMOLECULAR STRUCTURE AND DYNAMICS 1 1 Biological Macromolecules 2 1.1 General Principles

More information

D Dobbs ISU - BCB 444/544X 1

D Dobbs ISU - BCB 444/544X 1 11/7/05 Protein Structure: Classification, Databases, Visualization Announcements BCB 544 Projects - Important Dates: Nov 2 Wed noon - Project proposals due to David/Drena Nov 4 Fri PM - Approvals/responses

More information

Flow of Genetic Information

Flow of Genetic Information presents Flow of Genetic Information A Montagud E Navarro P Fernández de Córdoba JF Urchueguía Elements Nucleic acid DNA RNA building block structure & organization genome building block types Amino acid

More information

Review. Membrane proteins. Membrane transport

Review. Membrane proteins. Membrane transport Quiz 1 For problem set 11 Q1, you need the equation for the average lateral distance transversed (s) of a molecule in the membrane with respect to the diffusion constant (D) and time (t). s = (4 D t) 1/2

More information

Biology Tutorial. Aarti Balasubramani Anusha Bharadwaj Massa Shoura Stefan Giovan

Biology Tutorial. Aarti Balasubramani Anusha Bharadwaj Massa Shoura Stefan Giovan Biology Tutorial Aarti Balasubramani Anusha Bharadwaj Massa Shoura Stefan Giovan Viruses A T4 bacteriophage injecting DNA into a cell. Influenza A virus Electron micrograph of HIV. Cone-shaped cores are

More information

The wonderful world of NUCLEIC ACID NMR!

The wonderful world of NUCLEIC ACID NMR! Lecture 12 M230 Feigon Sequential resonance assignments in DNA (and RNA): homonuclear method 2 structure determination Reading resources Evans Chap 9 The wonderful world of NUCLEIC ACID NMR! Catalytically

More information

Types of RNA. 1. Messenger RNA(mRNA): 1. Represents only 5% of the total RNA in the cell.

Types of RNA. 1. Messenger RNA(mRNA): 1. Represents only 5% of the total RNA in the cell. RNAs L.Os. Know the different types of RNA & their relative concentration Know the structure of each RNA Understand their functions Know their locations in the cell Understand the differences between prokaryotic

More information

Bi 8 Lecture 11. Quantitative aspects of transcription factor binding and gene regulatory circuit design. Ellen Rothenberg 9 February 2016

Bi 8 Lecture 11. Quantitative aspects of transcription factor binding and gene regulatory circuit design. Ellen Rothenberg 9 February 2016 Bi 8 Lecture 11 Quantitative aspects of transcription factor binding and gene regulatory circuit design Ellen Rothenberg 9 February 2016 Major take-home messages from λ phage system that apply to many

More information

Lecture 2-3: Review of forces (ctd.) and elementary statistical mechanics. Contributions to protein stability

Lecture 2-3: Review of forces (ctd.) and elementary statistical mechanics. Contributions to protein stability Lecture 2-3: Review of forces (ctd.) and elementary statistical mechanics. Contributions to protein stability Part I. Review of forces Covalent bonds Non-covalent Interactions Van der Waals Interactions

More information

GENE ACTIVITY Gene structure Transcription Transcript processing mrna transport mrna stability Translation Posttranslational modifications

GENE ACTIVITY Gene structure Transcription Transcript processing mrna transport mrna stability Translation Posttranslational modifications 1 GENE ACTIVITY Gene structure Transcription Transcript processing mrna transport mrna stability Translation Posttranslational modifications 2 DNA Promoter Gene A Gene B Termination Signal Transcription

More information

1. (5) Draw a diagram of an isomeric molecule to demonstrate a structural, geometric, and an enantiomer organization.

1. (5) Draw a diagram of an isomeric molecule to demonstrate a structural, geometric, and an enantiomer organization. Organic Chemistry Assignment Score. Name Sec.. Date. Working by yourself or in a group, answer the following questions about the Organic Chemistry material. This assignment is worth 35 points with the

More information

Macromolecule Stability Curves

Macromolecule Stability Curves Chem728 page 1 Spring 2012 Macromolecule Stability Curves Macromolecule Transitions - We have discussed in class the factors that determine the spontaneity of processes using conformational transitions

More information

Chemical Principles and Biomolecules (Chapter 2) Lecture Materials for Amy Warenda Czura, Ph.D. Suffolk County Community College Eastern Campus

Chemical Principles and Biomolecules (Chapter 2) Lecture Materials for Amy Warenda Czura, Ph.D. Suffolk County Community College Eastern Campus Chemical Principles and Biomolecules (Chapter 2) Lecture Materials for Amy Warenda Czura, Ph.D. Suffolk County Community College Eastern Campus Primary Source for figures and content: Tortora, G.J. Microbiology

More information

UE Praktikum Bioinformatik

UE Praktikum Bioinformatik UE Praktikum Bioinformatik WS 08/09 University of Vienna 7SK snrna 7SK was discovered as an abundant small nuclear RNA in the mid 70s but a possible function has only recently been suggested. Two independent

More information

Protein structure (and biomolecular structure more generally) CS/CME/BioE/Biophys/BMI 279 Sept. 28 and Oct. 3, 2017 Ron Dror

Protein structure (and biomolecular structure more generally) CS/CME/BioE/Biophys/BMI 279 Sept. 28 and Oct. 3, 2017 Ron Dror Protein structure (and biomolecular structure more generally) CS/CME/BioE/Biophys/BMI 279 Sept. 28 and Oct. 3, 2017 Ron Dror Please interrupt if you have questions, and especially if you re confused! Assignment

More information

Lesson Overview. Gene Regulation and Expression. Lesson Overview Gene Regulation and Expression

Lesson Overview. Gene Regulation and Expression. Lesson Overview Gene Regulation and Expression 13.4 Gene Regulation and Expression THINK ABOUT IT Think of a library filled with how-to books. Would you ever need to use all of those books at the same time? Of course not. Now picture a tiny bacterium

More information

Complete all warm up questions Focus on operon functioning we will be creating operon models on Monday

Complete all warm up questions Focus on operon functioning we will be creating operon models on Monday Complete all warm up questions Focus on operon functioning we will be creating operon models on Monday 1. What is the Central Dogma? 2. How does prokaryotic DNA compare to eukaryotic DNA? 3. How is DNA

More information

Salt Dependence of Nucleic Acid Hairpin Stability

Salt Dependence of Nucleic Acid Hairpin Stability 738 Biophysical Journal Volume 95 July 2008 738 752 Salt Dependence of Nucleic Acid Hairpin Stability Zhi-Jie Tan and Shi-Jie Chen Department of Physics and Astronomy and Department of Biochemistry, University

More information

Proteins polymer molecules, folded in complex structures. Konstantin Popov Department of Biochemistry and Biophysics

Proteins polymer molecules, folded in complex structures. Konstantin Popov Department of Biochemistry and Biophysics Proteins polymer molecules, folded in complex structures Konstantin Popov Department of Biochemistry and Biophysics Outline General aspects of polymer theory Size and persistent length of ideal linear

More information

DNA/RNA structure and packing

DNA/RNA structure and packing DNA/RNA structure and packing Reminder: Nucleic acids one oxygen atom distinguishes RNA from DNA, increases reactivity (so DNA is more stable) base attaches at 1, phosphate at 5 purines pyrimidines Replace

More information

Chapter 1 1) Biological Molecules a) Only a small subset of the known elements are found in living systems i) Most abundant- C, N, O, and H ii) Less

Chapter 1 1) Biological Molecules a) Only a small subset of the known elements are found in living systems i) Most abundant- C, N, O, and H ii) Less Chapter 1 1) Biological Molecules a) Only a small subset of the known elements are found in living systems i) Most abundant- C, N, O, and H ii) Less abundant- Ca, P, K, S, Cl, Na, and Mg b) Cells contain

More information

Bioinformatics 2 - Lecture 4

Bioinformatics 2 - Lecture 4 Bioinformatics 2 - Lecture 4 Guido Sanguinetti School of Informatics University of Edinburgh February 14, 2011 Sequences Many data types are ordered, i.e. you can naturally say what is before and what

More information

What is the central dogma of biology?

What is the central dogma of biology? Bellringer What is the central dogma of biology? A. RNA DNA Protein B. DNA Protein Gene C. DNA Gene RNA D. DNA RNA Protein Review of DNA processes Replication (7.1) Transcription(7.2) Translation(7.3)

More information

9/11/18. Molecular and Cellular Biology. 3. The Cell From Genes to Proteins. key processes

9/11/18. Molecular and Cellular Biology. 3. The Cell From Genes to Proteins. key processes Molecular and Cellular Biology Animal Cell ((eukaryotic cell) -----> compare with prokaryotic cell) ENDOPLASMIC RETICULUM (ER) Rough ER Smooth ER Flagellum Nuclear envelope Nucleolus NUCLEUS Chromatin

More information

RNA Search and! Motif Discovery" Genome 541! Intro to Computational! Molecular Biology"

RNA Search and! Motif Discovery Genome 541! Intro to Computational! Molecular Biology RNA Search and! Motif Discovery" Genome 541! Intro to Computational! Molecular Biology" Day 1" Many biologically interesting roles for RNA" RNA secondary structure prediction" 3 4 Approaches to Structure

More information

RNA Processing: Eukaryotic mrnas

RNA Processing: Eukaryotic mrnas RNA Processing: Eukaryotic mrnas Eukaryotic mrnas have three main parts (Figure 13.8): 5! untranslated region (5! UTR), varies in length. The coding sequence specifies the amino acid sequence of the protein

More information

Nature Structural & Molecular Biology: doi: /nsmb Supplementary Figure 1

Nature Structural & Molecular Biology: doi: /nsmb Supplementary Figure 1 Supplementary Figure 1 Resonance assignment and NMR spectra for hairpin and duplex A 6 constructs. (a) 2D HSQC spectra of hairpin construct (hp-a 6 -RNA) with labeled assignments. (b) 2D HSQC or SOFAST-HMQC

More information

More Protein Synthesis and a Model for Protein Transcription Error Rates

More Protein Synthesis and a Model for Protein Transcription Error Rates More Protein Synthesis and a Model for Protein James K. Peterson Department of Biological Sciences and Department of Mathematical Sciences Clemson University October 3, 2013 Outline 1 Signal Patterns Example

More information

Lecture 3: Markov chains.

Lecture 3: Markov chains. 1 BIOINFORMATIK II PROBABILITY & STATISTICS Summer semester 2008 The University of Zürich and ETH Zürich Lecture 3: Markov chains. Prof. Andrew Barbour Dr. Nicolas Pétrélis Adapted from a course by Dr.

More information

Genomics and bioinformatics summary. Finding genes -- computer searches

Genomics and bioinformatics summary. Finding genes -- computer searches Genomics and bioinformatics summary 1. Gene finding: computer searches, cdnas, ESTs, 2. Microarrays 3. Use BLAST to find homologous sequences 4. Multiple sequence alignments (MSAs) 5. Trees quantify sequence

More information

BIOC2000 Summaries. How are biomolecules/macromolecules organised and how does this determine their function?

BIOC2000 Summaries. How are biomolecules/macromolecules organised and how does this determine their function? BIOC2000 Summaries R Lecture 1 What kinds of molecules are biomolecules? Biomolecules are made by biological systems and have a function in biological systems They are macromolecules such as proteins,

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

Sequence analysis and comparison

Sequence analysis and comparison The aim with sequence identification: Sequence analysis and comparison Marjolein Thunnissen Lund September 2012 Is there any known protein sequence that is homologous to mine? Are there any other species

More information

Chapter 17. From Gene to Protein. Biology Kevin Dees

Chapter 17. From Gene to Protein. Biology Kevin Dees Chapter 17 From Gene to Protein DNA The information molecule Sequences of bases is a code DNA organized in to chromosomes Chromosomes are organized into genes What do the genes actually say??? Reflecting

More information

Prokaryotic Regulation

Prokaryotic Regulation Prokaryotic Regulation Control of transcription initiation can be: Positive control increases transcription when activators bind DNA Negative control reduces transcription when repressors bind to DNA regulatory

More information

BIBC 100. Structural Biochemistry

BIBC 100. Structural Biochemistry BIBC 100 Structural Biochemistry http://classes.biology.ucsd.edu/bibc100.wi14 Papers- Dialogue with Scientists Questions: Why? How? What? So What? Dialogue Structure to explain function Knowledge Food

More information

Simulation of Gene Regulatory Networks

Simulation of Gene Regulatory Networks Simulation of Gene Regulatory Networks Overview I have been assisting Professor Jacques Cohen at Brandeis University to explore and compare the the many available representations and interpretations of

More information

RNA Folding and Interaction Prediction: A Survey

RNA Folding and Interaction Prediction: A Survey RNA Folding and Interaction Prediction: A Survey Syed Ali Ahmed Graduate Center, City University of New York New York, NY November 19, 2015 Abstract The problem of computationally predicting the structure

More information

Bi 8 Midterm Review. TAs: Sarah Cohen, Doo Young Lee, Erin Isaza, and Courtney Chen

Bi 8 Midterm Review. TAs: Sarah Cohen, Doo Young Lee, Erin Isaza, and Courtney Chen Bi 8 Midterm Review TAs: Sarah Cohen, Doo Young Lee, Erin Isaza, and Courtney Chen The Central Dogma Biology Fundamental! Prokaryotes and Eukaryotes Nucleic Acid Components Nucleic Acid Structure DNA Base

More information

Applications of Free Energy. NC State University

Applications of Free Energy. NC State University Chemistry 433 Lecture 15 Applications of Free Energy NC State University Thermodynamics of glycolysis Reaction kj/mol D-glucose + ATP D-glucose-6-phosphate + ADP ΔG o = -16.7 D-glucose-6-phosphate p D-fructose-6-phosphate

More information