45
S.Will, 18.417, Fall 2011 18.417 Introduction to Computational Molecular Biology — Foundations of Structural Bioinformatics — Sebastian Will MIT, Math Department Fall 2011 Credits: Slides borrow from slides of J´ erˆomeWaldisp¨ uhl and Dominic Rose/Rolf Backofen

18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

  • Upload
    others

  • View
    9

  • Download
    0

Embed Size (px)

Citation preview

Page 1: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

18.417Introduction to Computational Molecular Biology

— Foundations of Structural Bioinformatics —

Sebastian Will

MIT, Math Department

Fall 2011

Credits: Slides borrow from slides of Jerome Waldispuhland Dominic Rose/Rolf Backofen

Page 2: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Before we start

Instructor: Sebastian Will

Contact: [email protected]

Office hours: by appointment, Office: 2-155

Lecture: Tuesday, Thursday, 9:30-11:00 am

Room: 8-205

Web: http://math.mit.edu/classes/18.417/

(slides, further information)

Credits/Evaluation: no assignments, no exam, but Final Project

Final Project: • study paper in depth, implement/extendalgorithm, or theoretical proof

• project report (2-4 pages), talk (20 min)• find a topic during term

Page 3: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

What is Computational Molecular Biology(a.k.a. Bioinformatics)?

Short answer: study of computational approaches to study ofbiological systems (at the molecular level)

Today: somewhat longer answer, including

• What are the components of biological systems?

• How do they work together?

• What is their chemistry and structure?

• Which aspects do we want to study in Computational Biology?

• What is Structural Bioinformatics?

• What can you learn in this course?

Page 4: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Components of Biological Systems

• Three classes of biological macromolecules:• DNA (= deoxyribonucleic acid)

• RNA (= ribonucleic acid)

• Protein

• Single molecules are linear chains of building blocks, specifiedby sequence of their building blocks, e.g. ACTGGAGCGTC.

• Molecules form 3D-structures. Folding is a physical process(minimize energy)

• “Levinthal Paradox”: fast folding but huge conformation space

• Structure allows macromolecules to interact.Structure=Function, e.g. ’lock&key’

Page 5: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Information Flow — Central Dogma

DNA RNA ProteinTranscription Translation

Replication

DNA: store genetic information (e.g. in genome);regular double helix structurebuilding blocks: 4 nucleotides A,C,G, and T(Adenine, Cytosine, Guanine, Thymine)

RNA: intermediate for protein synthesis (messenger RNA),catalytic and regulatory function (non-coding RNA)building blocks: 4 nucleotides A,C,G, and U(U=Uracil) and some rare other nucleotides

Protein: catalytic and regulatory function (‘enzymes’)building blocks: 20 amino acids + 1 rare aa

Page 6: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Genetic code

• Transcription: A,C,G,T 7→ A,C,G,U

• Translation: Tripletts from alphabet {A,C,G,U} (= codons)redundantly code for amino acids

Page 7: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Information Flow (Cell Compartments)

Page 8: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Protein Bio-Synthesis

Important for molecular mechanism: complementarity ofnucleotides G-C, A-T, A-U

Page 9: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Evolution ( )

ACCGA

ACCCGA

ACCTA

TCCTA

T

C T CACTA

Animals

Slime moulds

Plants

Algae

Protozoa

Crenarchaeota

Nanoarchaeota

Euryarchaeota

ProtoeobacteriaAcidobacteria

Thermophilicsulfate-reducers

Cyanobacteria(blue-green algae)

Fusobacteria

Spirochaetes

Planctomycetes

Actinobacteria

Green nonsulfur bacteria

ChlamydiaeGram-positivesFungi

• variaton (imperfect replication: point mutation, deletion,insertion, ... )

• selection

• homologous sequences

Page 10: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

What can we study (computationally)?

Page 11: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

What can we study (computationally)?

• Evolutionary relation between homologousmolecules/fragments of molecules

• Structural relation between molecules

• Relation between sequence and structure

• Interaction between molecules

• Interaction networks, Regulatory networks, Metabolic networks

• Structure of genomes, Relation between genomes

• . . .

Page 12: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Areas of Bioinformatics

1. Genomics: Study of entire genomes.Huge amount of data, fast algorithms,limited to sequence.

2. Systems Biology: Study of complex in-teractions in biological systems. Highlevel of representation.

3. Structural Bioinformatics: Study of thefolding process of bio-molecules. Lessstructural data than sequence data avail-able, step toward function, fills gap be-tween genomics and systems biology.

Page 13: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Some Organic Chemistry

Biological macromolecules (and most organic compounds) are builtfrom only few different types of atoms• C — Carbon • H — Hydrogen • O — Oxygen• N — Nitrogen • P — Phosphor • S — Sulfur

CHNO: 99% of cell mass

Organic Chemistry = Chemistry of Carbon

Special properties of Carbon

• binds up to 4 other atoms,

e.g. Methane (tetrahedron conformation)

• small size

• strong covalent bonds covalent bond:

H – H

+1

1e

+1 +1

H

2e

H H

• chains and rings

⇒ large, stable, complex molecules

Page 14: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Non-covalent bonds• Covalent

H – H

+1

1e

+1 +1

H

2e

H H

• Non-covalent• Van der Waals (sum of the attractive or repulsive forces

between molecules, caused by correlations in the fluctuatingpolarizations of nearby particles)

• hydrogen bonds (attractive interaction of a hydrogen atomwith an electronegative atom)

• ionic bonds (electrostatic attraction between two oppositelycharged ions, e.g. Na+ Cl )

0.1 1 10 100 1000

thermalmovement C−−C Bond

completeglucose oxidationBond

non−covalent

[in kcal/mol]

Page 15: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Functional groupsorganic molecules: carbon skeleton + functional groupsfunctional groups are involved in specific chemical reactions

C

C

O

OH

C

Alcohol

Carboxylic Acid

Amine

OH

C

H

H

N

hydroxyl group

carboxyl group

amino group

CKetone O carbonyl group/Aldehyde

Page 16: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Small organic molecules

Small: ≤ 30 atoms

4 families:

• sugars⇒ component of building blocks, main energy source

• fats / fatty acids⇒ cell membrane, energy source

• amino acids⇒ proteins

• nucleotides⇒ DNA + RNA, energy currency

Page 17: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Sugars

⇒ component of building blocks, main energy source

• general formula (CH2O)n,different lengths (e.g n=5, n=6)

• linear, cyclic

For example, saccharose (glucose+fructose):

O

OOH H

H

H

HH

H

H

HOHO

OH

OH

OH

CH OH2CH OH2

CH OH2

Page 18: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Fats

Fat = Triglyceride of fatty acids

⇒ cell membrane (lipid bilayer), energy source

Page 19: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Amino Acids

• all aa same build

• aa differ in side chains R• size• charge: positiv/negativ (sauer/basisch)• hydrophobicity: hydrophobic/hydrophilic

• in naturally occuring proteins: 21 different amino acids

Page 20: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Amino Acids

Page 21: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Nucleotides

R

pentose

Base

glycosidic bond

OH = riboseH = deoxyribose

Purines

Pyrimidinesnucleoside

nucleotide monophosphate

nucleotide diphosphate

nucleotide triphosphate

Adenine Guanine

Cytosine Uracil Thymine

Nucleotides work as energy currency of metabolismNTP −→ P + NDP + E(split of nucleoside triphosphate into phosphate + nucleosidediphosphate releases energy)

Page 22: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Complementarity of Organic Bases

N

N

N

N

N

O

ON

N

H

H

H

Adenine Thymine

N

N

N O

N

H

H

H

H

H

N

N

N

O

N

Guanine Cytosine

Page 23: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

DNA structurePrimary structure: chain of nucleotidesTertiary Structure: antiparallel double helix

Phosphate-deoxyribosebackbone

Adenine

CytosineGuanine

Thymine

O

O

O

OO

O

O

O O

O

O

O

O

O

O

O

OO

O

O

O

OO

O

O

O

O

O

O

O

O

OO

O

O

O

OO

N

N

N

N

N

N

N

N

N

N

N

NN

N

N

NN

N

NN

O_

O_

O_

O_

O_

_O

_O

_O

_O

_O

P

P

P

P

P

P

P

P

NH2

OH

OH

NH

H2N

HN

NH2

H2N

HN

H2N

NH

NH2

3' end

5' end

3' end

5' end

RNA primary structure similar, but• ribose not deoxyribose, • U not T, • single stranded

Page 24: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

RNA structure

tRNA Hammerhead Ribozyme

mainly stabilized by contacts between complementary bases(H-bonds)⇒ RNA secondary structure = set of base pairs

Page 25: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

RNA secondary structure• set of pairs of (complementary) bases that form H-bonds• 2D representation (typical tRNA clover-leaf)

G

G

G

C

G

U

GUG

GCGU

AGU

C

G

GU A

G C G CG

C

U

C

C

CU

U

AG C

A

UG

GAG

A

GGUCU C C G G

U UC

G

AUU

CCGGAC

A

C

G

C

C

CA

CCA

• linear representationGGGCGUGUGGCGUAGUCGGUAGCGCGCUCCCUUAGCAUGGAGAGGUCUCCGGUUCGAUUCCGGACACGCCCACCA

(((((((..((((........)))).(((((.......)).)))...(((((.......))))))))))))....

• note: example is pseudoknot-free

Page 26: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Protein Primary Structure

• Protein = chain of amino acids (AA)

• aa connected by peptide bonds

and so on . . .

Page 27: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Protein Structure Formation / Folding

• minimization of free energy

• Forces between amino acid side chains• hydrophobic interaction• H-bonds• electro-static force• van-der-Waals force• disulfide bonds

Page 28: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Protein secondary structure: α-helix

Features:

• 3.6 amino acids per turn

• hydrogen bond betweenresidues n and n + 4

• local motif

• approximately 40% of thestructure

Page 29: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Protein secondary structure: β-sheets

Features:

• 2 amino acids per turn

• hydrogen bond betweenresidues of different strands

• involve long-rangeinteractions

• approximately 20% of thestructure

Page 30: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Protein secondary structure: Turns

Features:

• Up to 5 residue length

• hydrogen bonds depend oftype

• local interactions

• approximately 5-10% of thestructure

Page 31: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Protein structure hierarchy

Page 32: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

DNA sequencingA very incomplete overview

= determining the order of nucleotides in DNA

• early 1970s: first DNA sequencing, but ’laborious’

• 1977: Sanger Chain-Termination ’rapid’ sequencing

• whole genome sequencing, 2001 draft version of Humangenome published

• high throughput sequencing (454, Illumina/Solexa, . . . )

• 2011 sequencing of a human genome costs about USD 10,000

• constant progress in technology (speed & accuracy)

⇒ RNA and protein sequences are usually inferred from DNA

Page 33: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Experimental Structure Determination

• How can we know the 3D structure of a protein/RNA?• X-ray cristallography

• Requires crystalls of macromolecule.Often extremely difficult and time-intensive

• X-rays send through crystall produce specific patterns• Angles and intensities allow to construct 3D-electron density• From this, one can determine atom positions, bonds, etc.

• Nuclear magnetic resonance spectroscopy (NMR)• uses phenomenon of nuclear magnetic resonance• only relatively small molecules• does not require crystalls• measure distances between pairs of atoms within the molecule• structure has to be predicted using these constraints

• Experimentally resolved structures are available in the proteindata base (PDB) in a machine-readable format.

• The number of resolved structures grows exponentially, butslower than the one of known sequences.

Page 34: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Topics of the Class

Page 35: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Sequence Alignment

• pairwise alignment

Sequence A: ACGTGAACT

Sequence B: AGTGAGT

⇓align A and B

Sequence A: ACGTGAACT

Sequence B: A-GTGA-GT

• global and local alignment

• multiple alignment (NP-complete ⇒ heuristics)

Page 36: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

RNA Secondary Structure Prediction

• Predict minimal free energy structure for single sequence

• Predict minimal free energy structure for aligned sequences

• Predict common structure for alignment for unalignedsequences:

Simultaneous Alignment and Folding

G

G

G

C

G

U

GUG

GCGU

AGU

C

G

GU A

G C G CG

C

U

C

C

CU

U

AG C

A

UG

GAG

A

GGUCU C C G G

U UC

G

AUU

CCGGAC

A

C

G

C

C

CA

CCA

((..((((((((...(((.................))).))))))))..))

fdhA CGC-CACCCUGCGAACCCAAUAUAAAAUAAUACAAGGGAGCAG-GUGG-CG 48fwdB AUG-UUGGAGGGGAACCCGU-------------AAGGGACCCUCCAAG-AU 36selD UUACGAUGUGCCGAACCCUU------------UAAGGGAGGCACAUCGAAA 39vhuD GU--UCUCUCGGGAACCCGU------------CAAGGGACCGAGAGA--AC 35vhuU AGC-UCACAACCGAACCCAU-------------UUGGGAGGUUGUGAG-CU 36fruA CC--UCGAGGG-GAACCCGA-------------AA-GGGACCCGAGA--GG 32hdrA GG--CACCACUCGAAGGCUA-------------AG-CCAAAGUGGUG--CU 33

.........10........20........30........40........50

Page 37: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Studying the Structure Ensemble of an RNA• Prediction of the structure ensemble⇒ probabilities of structures⇒ probabilities of structure elements and features

• Suboptimal Structures

• Shape Abstraction of RNA Structure

G G G C G U G U G G C G U A G U C G G U A G C G C G C U C C C U U J G C J U G G A G A G G U C U C C G G U U C G A U U C C G G A C A C G C C C A C C A

G G G C G U G U G G C G U A G U C G G U A G C G C G C U C C C U U J G C J U G G A G A G G U C U C C G G U U C G A U U C C G G A C A C G C C C A C C A

GG

GC

GU

GU

GG

CG

UA

GU

CG

GU

AG

CG

CG

CU

CC

CU

UJ

GC

JU

GG

AG

AG

GU

CU

CC

GG

UU

CG

AU

UC

CG

GA

CA

CG

CC

CA

CC

A

GG

GC

GU

GU

GG

CG

UA

GU

CG

GU

AG

CG

CG

CU

CC

CU

UJ

GC

JU

GG

AG

AG

GU

CU

CC

GG

UU

CG

AU

UC

CG

GA

CA

CG

CC

CA

CC

A

Page 38: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

RNA Pseudoknot Prediction

• Usually: for RNA structure analysis, assume no pseudoknots

• Pseudoknot (PK) prediciton is NP-complete

• Efficient PK prediction from restricted classes of PKs

AAA

AA

A

AA

A

C

C

C C

C

C

C

C

C

C

UU

U

U

U

UU

U

U U U UUU

G G

G G

G

G

GG C

C

GG

CG

G G

Page 39: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

RNA-RNA Interaction

• Prediction of interaction complex of two RNAs

• Similar to Pseudoknot-prediction, the unrestricted problem isNP-complete

• Efficient variants exist for restricted types of interaction

Page 40: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

RNA 3D Structure Modeling

• De-novo prediction of 3D structure from sequence

MC-FoldMC-FoldMC-Fold / MC-SymMC-SymMC-Sym:

• MC-Fold predicts secondary structureincluding non-canonical base pairs

• MC-Sym builds tertiary from secondary structure

Page 41: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Stochastic Context-Free Grammars

• SCFGs are a generalization ofHMMs, which can modelsecondary structure

• Consensus Models fordescribing RNA families.

• Tool Infernal scans database forfamily members

example structure:

AUA

:AAG

:GCG

<AAU

<CCC

<UUU

_UUU

_CCC

_GG-

_GGG

>AAC

-UUA

>CGC

>U-G

:GCG

<GAG

<CCC

-GCA

<AAC

_CAC

_AAA

_CGU

>CUU

>CGC

>humanmouse

orc

[structure]

g...

c...

.a..

.a..

inputmultiple alignment:

1 5 10 15 20 25 28

C

CGCG

CGA

AC

G CA U

AC GUU C

G

UAA2

5

10

15

2527

21

S 1IL 2IR 3ML 4D 5IL 6ML 7D 8IL 9B 10S 11MP 12ML 13MR 14D 15IL 16IR 17MP 18ML 19MR 20D 21IL 22IR 23MR 24D 25IR 26MP 27ML 28MR 29D 30IL 31IR 32ML 33D 34IL 35ML 36D 37IL 38ML 39D 40IL 41ML 42D 43IL 44E 45S 46IL 47ML 48D 49IL 50MP 51ML 52MR 53D 54IL 55IR 56MP 57ML 58MR 59D 60IL 61IR 62ML 63D 64IL 65MP 66ML 67MR 68D 69IL 70IR 71ML 72D 73IL 74ML 75D 76IL 77ML 78D 79IL 80E 81

ROOT 1

MATL 2

MATL 3

BIF 4BEGL 5

MATP 6

MATP 7

MATR 8

MATP 9

MATL 10

MATL 11

MATL 12

MATL 13

END 14

BEGR 15

MATL 16

MATP 17

MATP 18

MATL 19

MATP 20

MATL 21

MATL 22

MATL 23

END 24

MP 12 ML 13 MR 14 D 15

IL 16 IR 17

"split set"

inserts

"split set"

inserts

"split set"

insert

MATP 6

MATP 7

MATR 8

MP 18 ML 19 MR 20 D 21

IL 22 IR 23

MR 24 D 25

IR 26

Page 42: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

De-novo Prediction of Structural RNA

• scan whole genomealignments for potentialstructural RNA

• structural stability

• conservation of structure

• Fast methods RNAz,EvoFold

Page 43: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Protein Structure Prediction

• De-novo Protein Structure Prediction

• Homology-based prediction: Protein Threading

• Protein-Protein Interaction

Page 44: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

3D Lattice Protein Models

• protein structure prediction is NP-complete even in simpleprotein models

• optimal ab-initio prediction in HP-lattice protein models (3Dcubic and fcc)

P P P P PH H H −→P

H P

P HH

H P

P

P

Page 45: 18.417 Introduction to Computational Molecular Biology · 2011 Introduction What is Computational Molecular Biology (a.k.a. Bioinformatics)? Short answer: study of computational approaches

S.W

ill,

18

.41

7,

Fa

ll2

01

1

Introduction

Beyond Energy Minimization:Kinetiks of Protein and RNA folding

• Predicting Protein Folding-Pathways (Motion Planning)• Modeling of Folding as Markov Process, Energy Landscapes• Simulated and Exact Folding Kinetics

vs.