61
CS612 - Algorithms in Bioinformatics Protein Folding March 1, 2019

CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

  • Upload
    others

  • View
    1

  • Download
    0

Embed Size (px)

Citation preview

Page 1: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

CS612 - Algorithms in Bioinformatics

Protein Folding

March 1, 2019

Page 2: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

The Protein Folding Problem

Protein folding is the translation ofprimary sequence information intosecondary, tertiary and quaternarystructural information

Don’t forget post-translationalmodifications.

They change the chemical natureof the primary sequence and thusaffect the final structure

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 3: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Relationship Between Structure and Function

H. Wu, 1931: First formulation of the protein folding problemon record

Mirsky and Pauling 1936:

Chemical and physical properties of protein moleculesattributed to amino-acid composition and structuralarrangement of the amino-acid chainDenaturing conditions like heating assumed to abolishchemical and physical properties of a protein by “meltingaway” the protein structure

The relationship between protein structure and function wasunder significant debate until the revolutionizing experimentsof Christian Anfinsen and colleagues at the National Instituteof Health (NIH) in the 1960s

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 4: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Anfinsen’s Experiments: Spontaneous Refolding

Experiments by Christian B.Anfinsen showed that the smallribonuclease enzyme wouldre-assume structure and enzymaticactivity after denaturation

This ability to regain both structureand function was confirmed onthousands of other proteins.

It seemed to be an inherent propertyof amino-acid chains

After a decade of experiments,Anfinsen concluded that theamino-acid sequence governed thefolding of a protein chain into a“biologically-active conformation”under a “normal physiologicalmilieu”

He received the Nobel prize inchemistry for his formulation of thisrelationship between the amino acidsequence and the biologically-active(functional) structure of a protein

The telegram that I received from the Swedish RoyalAcademy of Sciences specifically cites “...studies onribonuclease, in particular on the relationship between theamino acid sequence and the biologically activeconformation...”“Studies on the Principles that Govern the Folding ofProtein Chains”Nobel Lecture, Dec. 11, 1972

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 5: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

From Anfinsen’s Experiments to Simulations

Let the 3D spatial arrangement ofatoms constituting the protein chainbe referred to as a conformation

How does the amino-acid sequencedetermine the biologically-activeconformation?

If one knows the answer to theabove, one can formulateinstructions for a computeralgorithm to compute thebiologically-active conformation

There are many conformations(possible arrangements of the chain)of a protein chain

What makes the biologically-activeconformation different from the rest?

Can this information be used to“guide” a computer algorithm to thisspecial conformation?

The telegram that I received from the Swedish RoyalAcademy of Sciences specifically cites “...studies onribonuclease, in particular on the relationship between theamino acid sequence and the biologically activeconformation...”“Studies on the Principles that Govern the Folding ofProtein Chains”Nobel Lecture, Dec. 11, 1972

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 6: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

The Thermodynamic Hypothesis

Anfinsen’ experiments made the case for the thermodynamichypothesis:

This hypothesis states that the three-dimensional structure ofa native protein in its normal physiological milieu (solvent,pH, ionic strength, presence of other components such asmetal ions or prosthetic groups, temperature, etc.) is the onein which the Gibbs free energy of the whole system is lowest.

That is, that the native conformation is determined by thetotality of inter-atomic interactions and hence by the aminoacid sequence, in a given environment.

[Anfinsen′s Nobel Lecture, December 11, 1972]

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 7: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Case Study... What Happens When it All Goes Wrong

Eligibility criteria for blood donation, from the red cross website:

”You are not eligible to donate if:

From January 1, 1980, through December 31, 1996, you spent(visited or lived) a cumulative time of 3 months or more, in theUnited Kingdom (UK), or From January 1, 1980, to present, youhad a blood transfusion in any country(ies) in the (UK) or France.”

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 8: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Case Study... What Happens When it All Goes Wrong

A bovine epidemic struck the UKin 1986, 170,000 cows appearedto be mad: they drooled andstaggered, were extremelynervous, or bizarrely aggressive.They all died. As the brains ofthe dead “mad” cows resembled asponge, the disease was calledbovine spongiformencephalopathy, or BSE.

Other examples of spongiformencephalopathy are scrapie whichdevelops in sheep,Creutzfeld-Jacob Disease (CJD)and its variant (vCJD) whichdevelop in humans.

In 1982 the infectious agentsresponsible for transmittingspongiform encephalopathy weredefined and named prions(Stanley Prusiner, 1982).

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 9: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

The Mad Cow... What Happens When it All Goes Wrong

Prions are proteins that are foundin the nerve cells of all mammals.Many abnormally-shaped prionsare found in the brains ofBSE-infected cows and vCJD orCJD patients.

The difference in normal andinfectious prions may lie in theway they fold.

Evidence indicates that theinfectious agent in transmissiblespongiform encephalopathy is aprotein.

The normal protein is called PrPC(for cellular). Its secondarystructure is dominated by alphahelices.

The abnormal, disease producingprotein called PrPSc (for scrapie),has the same primary structure asthe normal protein, but itssecondary structure is dominatedby beta conformations.

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 10: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

The “Kiss of Death” or ”Attack of the Zombies”

The abnormally-shaped prion gets absorbed into thebloodstream and crosses into the nervous system.

The abnormal prion touches a normal prion and changes thenormal prion’s shape into an abnormal one, thereby destroyingthe normal prion’s original function.

Both abnormal prions then contact and change the shapes ofother normal prions in the nerve cell.

The nerve cell tries to get rid of the abnormal prions byclumping them together in small sacs.

Because the nerve cells cannot digest the abnormal prions,they accumulate in the sacs that grow and engorge the nervecell, which eventually dies.

When the cell dies, the abnormal prions are released to infectother cells. Large, sponge-like holes form where many cells die.

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 11: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Prion Misfolding

The Prion Hypothesis suggeststhat diseases like mad cow andhuman CJD are caused by themisfolding of a protein known asPrP that most cells contain.

Once a few copies of the proteinbecome misfolded ), they causeother PrPs to misfold, leading toan accumulation of insolubleproteins in the cell.

misfolded proteins cause cell deathand damage the nervous system.

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 12: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Not Only Cows: Human Prion Diseases

Creutzfeldt-Jakob disease (CJD) is a rare fatal brain disorderthat usually occurs in late life and runs a rapid course.

No known treatment or cure.

Most CJD cases are sporadic (not hereditary).

It can also be acquired through contact with infected braintissue (iatrogenic CJD) or consuming infected beef

About 5 to 10% of cases are due to an inherited geneticmutation associated with CJD (familial CJD)

The mutation makes the prion protein more susceptible tomisfolding.

How and why? Still not entirely clear...

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 13: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Similar yet Different: Huntington’s Disease

A (usually) hereditarydisease that causes death ofbrain cells

Autosomal dominantinheritance pattern

Symptoms: Mood disorders,uncoordinated movements,eventually dementia

Typical age at onset: 30-50

Life expectancy: 15-20 yearsfrom diagnosis

Woody Guthrie, 1912 – 1967

Dr. Remy Hadley (”13”), House MD

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 14: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Trinucleotide Repeat Disorder

The length of a repeated section of a gene exceeding a normalrange

The HTT gene contains a sequence of CAG– repeatedmultiple times (i.e. ... CAGCAGCAG ...)

This sequence codes to Glutamine (GLN, Q)

Number of repeats varies normally in the population

This creates a sequence of Glutamines, called PolyQ(polyglutamine chain).

An abnormally large number of CAG repeats in the HTT genecauses HD.

Repeat count Classification Disease status Risk to offspring<26 Normal None None27–35 Intermediate None Elevated but << 50%36–39 Reduced Penetrance Maybe 50%40+ Full Penetrance Will be affected 50%

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 15: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Trinucleotide Repeat Disorder

A sequence of 36 or more glutamines results in the production of aprotein which has different characteristics.

The PolyQ regions appears to adopt a β-sheet structure

This altered form, called mutant huntingtin (mHTT), increases the decayrate of certain types of neurons.

The huntingtin protein interacts with over 100 other proteins, andappears to have multiple biological functions.

Enzymes in the cell often cut the elongated protein into fragments, whichform abnormal clumps inside nerve cells, and may attract other, normalproteins into the clumps (Sounds familiar?)

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 16: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Computational Modeling of Protein Folding

Problem definition: Given the amino acid sequence, computethe correct 3-D arrangement (folded structure) of the protein.

3D coordinates representing locations of atoms.

An energy function representing physical interactions.

It should model how atoms interact with each other.

Tells us how physically favorable is a given arrangement ofatoms in space (conformation).

We should able to compute it for every given conformation.

Thermodynamics states that a molecule aims to fold into itsminimum energy conformation.

Exploration of the dynamics of proteins → search in the spacespanned by the possible structures, guided by the energyfunction.

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 17: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Degrees of Freedom (DOFs)

Definition (Degrees of Freedom)

The degree of freedom (DOF) is the set of independent parametersthat can be varied to define the state of the system

Examples:The location of a point in a 2-D cartesian system has twoindependent parameters – its (x , y) coordinates.

x

y

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 18: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Degrees of Freedom (DOFs)

Definition (Degrees of Freedom)

The degree of freedom (DOF) is the set of independent parametersthat can be varied to define the state of the system

Examples:An alternative representation – (r , θ), distance from the origin androtation about the origin, respectively.

rθ r

θ

r cos θ

r sin θ

a

b

dist(a,b)=r

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 19: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Degrees of Freedom (DOFs)

Definition (Degrees of Freedom)

The degree of freedom (DOF) is the set of independent parametersthat can be varied to define the state of the system

Examples:

The location of a point in a 2-D cartesian system has threeindependent parameters – its (x , y) coordinates.

An alternative representation – (r , θ), distance from the originand rotation about the origin, respectively.

A molecule with n atoms can be represented by a set of 3×Ncartesian coordinates, so it has 3× N DOFs...

...or does it?

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 20: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Degrees of Freedom (DOFs)

The atoms are mutually restricted by bond lengths and angles.

Each such bond/angle poses a constraint on the system.

For example – if we know that the bond length (distance)between two atoms is 1.5A , then they are no longerindependent!

So the “real” number of DOFs is much smaller than 3× N.

To simulate folding, we have to manipulate the “real” degreesof freedom of the protein (usually a subset of the dihedralangles).

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 21: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Computational Modeling of Protein Folding

What does the thermodynamic hypothesis suggest a navecomputer algorithm can do?

The basic search involves enumeration of conformations

Exhaustive, brute-force search

To be able to enumerate, the algorithm needs to have a wayto first represent and then compute new conformations

Modeling, degrees of freedom

To determine that some conformations are more relevant thanothers, the interatomic interactions need to be summed overto associate an energy estimate with each computerconformation

Energy function, scoring, ranking

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 22: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Enumeration and Cyrus Levinthal’s Paradox

Consider a bond connectingtwo amino acids as the onlysource of flexibility

Also consider that this bondcan be in a limited numberof configurations

Back-of-the-envelope calculation:

A chain of 101 amino acids

Has 100 such rotatablebonds

Assume there are only 3configurations available toeach rotatable bond

Then there are of 3100

conformations available tothe protein chain

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 23: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Enumeration and Cyrus Levinthal’s Paradox

Levinthal’s Paradox:

Can a protein or algorithm enumerate 3100 conformations?

Assuming a rate of 1013 conformations per second, it wouldtake 1027 years for a protein sample all conformations

Conclusion: This is NOT how proteins fold! [in the lab,proteins fold in milliseconds/microseconds]

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 24: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

The Non-paradoxical Levinthal’s Paradox

Levinthal’s paradox serves toillustrate that proteins doNOT sample conformationsrandomly and somehowstumble across thelowest-energy one

There is method to themadness!

Proteins fold faster thanrandom trial suggests

Then there must be anenergetic bias that “guides”the protein towards thebiologically-activeconformation without goingthrough unnecessaryconformations

What does the energylandscape look like?

What does this mean forhow proteins actually fold?

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 25: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Pathway vs. Landscape

Maybe there arespecificpathways

Information onwhich pathwaysthe protein takesis encodedsomehow in theunfolded states

Each state is seenas a conformationalensemble

The energylandscape showsthat the range ofstates becomesmore limited withlower energy

The landscape viewencompasses the“preferred”pathways

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 26: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Framework vs. Collapse

Since proteins do not seem to fold at random, there must be anorder of events that drives the folding of a protein chain.

Important question: what drives the folding of a protein chain?

Local interactions drive folding

There is an order of events:

Secondary structures form first

Once formed, they stay that way

The stable secondary structures thenself-assemble in the native tertiarystructure (folded conformation)

Non-local interactions drive folding

Proposed by Ken Dill in 1985

Global collapse drives the secondarystructure formation and not thereverse

Folding code resides mainly in globalpatterns of contact interactions thatare non-local

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 27: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Funnel Landscape View of Protein Folding

If proteins search for conformations, they doso on an energy landscape similar to amultidimensional funnel

The slope of the funnel guides the proteindown towards the energy minimum, wherethe native state resides

The “folding funnel” leads to increase inrates of protein folding compared to expectedrates for random diffusion processes

The folding funnel also largely preventsentrapment of partially folded states

The funnel view of protein folding wassimultaneously proposed by Ken Dill andPeter Wolynes

This energy landscape view of protein folding

Has been confirmed in experimentIs now well acceptedDrives the logic/rules behind manycomputer algorithms that foldsequences in silico

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 28: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

The Landscape Encompasses the Pathways

As more sections of the native structurefall into place, the protein achieves lowerenergy, with the final folded nativestructure at the bottom of the funnel

The landscape view allows thinking ofmultiple molecules rolling down thepathways of successive local minima untilthey all converge to the global minimum

This process closely resembles theexperiment, where measurements areobtained over multiple protein molecules– multiple replicas

Width of the funnel (cross-section) givesthe entropy – a measurement of howmany different conformations achievesimilar energy value

As a protein folds, the free energy goesdown – what is free energy?

The (Gibbs) free energy G = E -TS

E = potential energy(interatomic interactions)

T = temperature (on whichfolding happens)

S = entropy (measuresdegeneracy of a state)

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 29: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Landscape View and Assisted Folding

Some experiments suggest that folding doesnot always lead to a unique state or structurecorresponding to the overall free-energyminimum

Kinetic hypothesis: a protein may gettrapped in a local minimum in a really ruggedenergy landscape

Some proteins are assisted in their folding bychaperones (other proteins that oversee andcorrect the folding process)

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 30: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Folding With a Computer

Protein folding tries to answer thehow together with the what:

Given a random conformation, howdoes the protein find itslowest-energy (native) state andwhat does this state look like

Interested in both the final answerand in the actual manner the answeris obtained

Protein Structure Determinationaddresses mainly the what:

Given the amino-acid sequence, whatis the native state (one structure, anentire ensemble of native-likeconformations)?

Computational methods thatconsider the how are categorized asfolding methods

Methods that address the what arecategorized as structuredetermination/prediction methods

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 31: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Challenges for a Computer Scientist

Modeling – how are protein conformations represented

If all atoms are explicitly modeled and followed in space, thisputs a lot of computational burden on a search algorithm. Ifnot all atoms are explicitly modeled, how does one determinewhich ones to model?Example: Focus on spatial arrangements of the backbone firstAre the modeled atoms allowed to move anywhere in space?Example: Force atoms to be on a lattice – brings enumerationinto the realms of feasible computationCoarse-grained (not all atomic detail) vs. all-atom modeling isan important decision

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 32: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Challenges for a Computer Scientist

Exploration/Search algorithm to traverse the conformationalspace

Trajectory-based exploration is one strategy to search theprotein conformational spaceProbabilistic Exploration that does not generate conformationsin a trajectory is another

Scoring – Energy function to determine whether aconformation is of low or high energy

Practical functions are empirical AND there are many of themVery important to design functions that can accurately scorecoarse-grained conformationsEvaluation of an energy function on an all-atom representationis quite expensive

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 33: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Representation of Protein Conformations

Discrete atoms in alattice – realm ofenumeration.

Continuous – off-lattice models.

Coarse-grainedmodeling

Fine-grained modeling

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 34: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Energy of Protein Conformations

Empirical force-fields to measure potential energy AMBER ff*,CHARMM, OPLS, knowledge-based, ...

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 35: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Launching Trajectories To Sample the Basin

Trajectory-based exploration:1. Start with a conformation2. Generate a next one3. Continue until ...

Systematic Search – MolecularDynamics (MD)

Probabilistic Walks – (Metropolis)Monte Carlo (MC)

In MD, consecutive conformations inthe trajectory are generated byfollowing the gradient of the energyfunction.

In MC, moves are sampled from amove set to generate the nextconformation in the trajectory.

The generated conformation is thenaccepted according to the Metropoliscriterion.

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 36: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Trajectory-based Search of the Native State

Systematic Search: Molecular Dynamics (MD)

Uses Newton’s laws of motion

Employs thermodynamics and statistical mechanics tosimulate the folding process

Detailed simulations follow the motion of each atom in space

MD simulations demand a lot of computer time to simulate afew nanoseconds of the folding process

Reveal detailed information about the folding process

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 37: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

The Conformational Space is Vast

Conformational space ishigh-dimensional: many atoms tofollow in space

Energy surface associated withconformational space [OnuchicJ.N., Luthey-Schulten Z., andWolynes P.G. Annu. Rev. Phys.Chem. 48, 1997]

Evolution has “guided” native state(in naturally-occurring proteins) tobe lowest free-energy state [UngerR. and Moult, J. Bull. Math. Biol.55, 1993]

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 38: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Locating the Basin of the Funnel with MD

1 evaluate forces on each atom

2 move atom according to forcenumerical update: x(t + dt) = x(t)+ dt * f(x(t)) + ...

3 go back to 1.

Numerical update is the bottleneck

dt needs to be small for accuracy(1-2 fs)

Generates a single trajectory

Results depend on initialconditions, since MD is essentiallya local optimization technique

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 39: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Trajectory-based Search of the Native State

Random (Probabilistic) Search: Monte Carlo (MC)

Conducts biased probabilistic walks

At each point in time (iteration), a move is made that is notnecessarily physical or representative of what the protein doesto transition between conformations

A conformation resulting from a move is accepted with theMetropolis criterion based on its potential energy

The paths taken to the native state may be actuallyimpossible for a protein to follow

By computing conformations through moves, MC exhibithigher sampling efficiency – they can make big jumps inconformational space

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 40: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Locating the Basin of the Funnel with MC

Metropolis Monte-Carlo (MMC)

1 Start with a random/extendedconformation Ccurr ← Cstart

2 Make a move (change Ccurr ) whichresults in a new conformation Cnew

3 Give a value to one of theparameters considered example:rotate a bond

4 If E (Cnew ) < E (Ccurr ) thenCcurr ← Cnew

5 else dE = E (Cnew)− E (Ccurr)Ccurr ← Cnew with prob.e−dE/scalingf actor

6 Goto 2.

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 41: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Pros and Cons of MD and MC

Both MD and MC launch trajectories in conformational space

The end-point of these trajectories depend to an extent on theinitial conditions (conformations from which the trajectorieswere initiated)

Both MD and MC are local optimization techniques aimed atsampling the global minimum in the energy landscape

While MD gives physical trajectories, MC’s trajectories maynot correspond to a sequence of moves that a protein actuallyfollows

There may be nothing physical about the moves/parameterschosen to generate consecutive conformations

This gives MC the ability to make bigger jumps inconformational space and sample the space faster than MD

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 42: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Lattice Models – The Simplest Model

The conformational space is vast

So, let’s restrict positions in spacefor an amino acid to a lattice(cubic or diamond)

This simple model allows toenumerate all possibleconformations (on a short chain)

The model can actually helpanswer the following question:

Possible question 1: Whichsequences lead to a stable nativeconformation? (protein design)

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 43: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Lattice Models – The Simplest Model

The conformational space is vast

So, let’s restrict positions in spacefor an amino acid to a lattice(cubic or diamond)

This simple model allows toenumerate all possibleconformations (on a short chain)

The model can actually helpanswer the following question:

Possible question 2: Given asequence, what is its most stableconfiguration? (protein folding,structure prediction)

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 44: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Lattice Based Models

Potential course of action:

1 Enumerate possible amino-acid sequences

2 Twenty amino acids is too many, so we will have certain“representative” classes of amino acids

3 For each sequence, we will compute/enumerate the number ofconformations on the lattice

4 We will then rank (through a ranking/scoring energy function)the enumerated conformations to determine the good folds

Hopefully we will find out which sequences yield good folds

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 45: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

HP Lattice Model: Ranking Sequences and Folds

There are only two types of amino acids – H(red) for hydrophobic, P (blue) for polar(hydrophilic)

H units repel water, P units attract water

The energetic forces acting between the units

are reduced to a single rule:

H’s like to stick together (P units areinert, neither attracting nor repelling)This is a very simplified model.The chain folds on a lattice laid out ongraph paper.

H’s and P’s are placed at the grid points ofthe 2D lattice

The peptide bonds are lines drawn on the grid

Confinement on the lattice keeps the numberof conformations finite (amenable toenumeration)

Several lattice geometries are possible in both2D and 3D

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 46: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

HP Lattice Model: Self-avoiding Walks

We can ask ourselves two relatedquestions:

Given an n-aa chain of H’s and P’s– How many sequences are there?

Given a specific sequence of H’sand P’s – How manyconformations are there?

This translates to the number ofself-avoiding walks on the 2Dlattice on the right

A self-avoiding walk is a path onthe 2D grid that does not cross thesame grid point more than once

Remember course of action:

Enumerate all possible HPsequences

For each sequence,enumerate the number ofconformations (self-avoidingwalks) on the 2D lattice

Collect statistics on whichsequences give good folds

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 47: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

HP Lattice Model: Self-avoiding Walks

How many shortest self-avoidingwalks of length n-1 are there onthe 2D grid?

Walks of length 1: four possibledirections: North, West, South,East [4 walks]

Walks of length 2: From the endsof the walk of length 1, threechoices (remember self-avoiding) [3x 4 = 12 walks]

Walks of length 3: 36

... Walks of length 51: 1022

Remember course of action:

Enumerate all possible HPsequences

For each sequence,enumerate the number ofconformations (self-avoidingwalks) on the 2D lattice

Collect statistics on whichsequences give good folds

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 48: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

HP Lattice Model: Good and Bad Folds

What makes a fold good?

Low Gibbs free energy G = E - TS

Low potential energy, high entropy

An extended chain has high E but low S

E is high because amino acids that“want” to be close together are forced tobe apart

S is low because the extended chain ishighly ordered

Folding the chain should bring it backinto a shape with a low overall value for G

How do we model G here?

Approximation: count only thenumber of H-H contacts (dashedlines)

This should reflect the tendency ofhydrophobic amino acids to gotowards the core of the protein toavoid water

Low G is now maximum number ofH-H contacts – this is our scoringfunction

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 49: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Finding Best 2D Lattice Folds of HP sequences

12 of the 107 most stable folds of 80 21-aa sequences: Red H’s form stabilizingcontacts (dotted white lines) when nearest neighbors blue P beads have nointeractions (not counted in the G function)

There are 117,676,504,514,560 possible folds of 21-aa sequences. The 5 shownhere are selected at random.

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 50: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Monte Carlo to Sample the Conformational Space

On long chains, enumeration is impractical: Monte Carlocould compute self-avoiding walks in the lattice

Given an HP chain of length N

Start with a random self-avoiding walk on the N × N grid

For i = 1 to Ncycles

Propose a move to obtain a new self-avoiding walk from thecurrent oneEstimate the G value of the proposed walk with the rankingH-H score and compare it to the G value of the current walkIf the difference in energy meets the Metropolis criterionaccept the new walk and resume the next cycle from it

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 51: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Monte Carlo on Off-lattice models

Lattice models are a crude approximation of the real conformationalspace of proteins

How would you apply Monte Carlo to a backbone chain of atoms in3D (off-lattice models)?

Your parameters (movable set) are the φ, ψ angles of the chain

Where would you draw values from to attempt moves?

Suggestion 1: random angle values from -π to πSuggestion 2: angle values sampled from the Ramachandranmap of an amino-acid

What energy function would you implement to score the newconformations?

Suggestion 1: minimize the number of collisions - crudeapproximation. Often works, not very accurate.Suggestion 2: also reward atoms in specific distances fromeach-other (van der Waals)

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 52: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Methods for Structure Prediction and CASP

Problems

Secondary structure predictionFold recognitionTertiary structure prediction

Methods

Knowledge-based methods for secondary structure predictionHomology modeling for fold recognition and tertiary structurepredictionAb-initio or physics-based methods for tertiary structurepredictionHybrid methods combine knowledge and physics for tertiarystructure prediction

Quality assessment

For tertiary structures: RMSD, lRMSD, LGAFor binding sites: Shapes, Surfaces, Cavities

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 53: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

CASP: History and Motivation

Critical Assessment of techniques for protein StructurePrediction (CASP)

First held in 1994 on a biennial basis – 9 meetings up to 2010

Protein Structure Prediction Center:http://predictioncenter.org/

A competition that pitches computational groups against oneanother on their solutions to the structure prediction problemon various proteins (whose experimental structures have justbecome available but are temporarily withheld from depositionin the PDB)

Problems addressed since 1994 (some of them discontinueddue to great success):

Secondary Structure Prediction – discontinued due to highaccuracyFold Prediction/Remote Homology Detection MethodTertiary Structure Prediction

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 54: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

CASP – The Process

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 55: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

CASP – List of Addressed Problems

Domain prediction: Identify regions that fold into independentcompact structures

Secondary structure prediction: Identify local structuralregions of the protein

Contact-map prediction: Identify residue pairs of residues innative contacts

Fold recognition: Determine whether the protein adopts ashape that is already known

New-fold prediction: Determine the tertiary structure of aprotein with an unknown shape

Function Prediction: Determine the functional class of theprotein

Model Quality Assessment: How well each group does

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 56: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

CASP: Pushes State of In-silico Research

Human experts are allowed to have their submissions assessedand ranked

The focus of CASP, however, is on assessing computationalapproaches and methods

Another problem considered in CASP competitions is foldrecognition or prediction

Reason: even if one cannot obtain the precise details of thetertiary 3D structure, one can at least recognize the fold fromthe sequenceUse: tertiary structure details are easier to compute once theoverall fold is known

The main interesting problem in the last years is prediction oftertiary structure from the amino-acid sequence

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 57: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Secondary Structure Prediction: State of the Art

Generative Models: learn a model based on specific signals and seehow well the model explains (classifies/annotates) candidate queries

Bayesian Methods, HMM

Example: OSS-HMM with accuracy 75.5%

Discriminative Models: Key idea is to separate between the variousclasses or groups

SVM, Neural Net, Logistic Regression

Example: YASSPP uses SVM-based models for each C(oil),E(xtended), H(elix) state

http://www.pubmedcentral.nih.gov/picrender.fcgi?

artid=1769381&blobtype=pdf

Karypis 2005

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 58: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

CASP: Fold Recognition

http://www.rcsb.org (PDB)

New “fold” discovery is decreasing

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 59: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Approaches to In-silico Structure Prediction

Homology modeling: use information from knownstructure(s) with similar sequence(s)

Main idea: knowledge-based approach, exploiting databases ofknown protein structuresApplicability: if > 60% sequence identity, problem is (manytimes...) solvedChallenge: < 30% sequence identity, poor resultsChallenge: Loop regions are usually not very well conservedGood for sequences that have close homologs with knownstructures.

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 60: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Approaches to In-silico Structure Prediction

Ab-initio structure prediction: predict without priorknowledge of other structures

Main idea: conformational sampling/searching combined withoptimization of an energy functionConformational sampling includes trajectory-based exploration,enhanced sampling, robotics-inspired methods, and moreEnergy function can be physics-based (CHARMM, AMBER),knowledge-based (obtained from statistics over database ofknown structures), or have terms of bothApplicability: on proteins with < 30% sequence identity (ormore...)Challenge: trajectory-based exploration methods may take toolong

Nurit Haspel CS612 - Algorithms in Bioinformatics

Page 61: CS612 - Algorithms in Bioinformaticsnurith/cs612/proteinFolding.pdf\Studies on the Principles that Govern the Folding of Protein Chains" Nobel Lecture, Dec. 11, 1972 Nurit Haspel CS612

Approaches to In-silico Structure Prediction

Hybrid methods: combine ingredients from knowledge-basedand ab-initio methods

Hierarchical approaches, fragment-based assembly dominate atCASPApplicability: where just knowledge-based or just ab-initio areinadequateChallenge: extend applicability to longer protein chains andmulti-chain complexesEven most sophisticated methods are still not very accurate

Nurit Haspel CS612 - Algorithms in Bioinformatics