Potential Energy (hyper)surface

Size: px
Start display at page:

Download "Potential Energy (hyper)surface"

Transcription

1 The Molecular Dynamics Method Thermal motion of a lipid bilayer Water permeation through channels Selective sugar transport Potential Energy (hyper)surface What is Force? Energy U(x) F = " d dx U(x) Conformation (x) 1

2 Classical Molecular Dynamics r ( t +! = r( + v(! t v ( t +! = v( + a(! t a ( t ) = F( / F =! m d U (r) dr Classical Molecular Dynamics 1 qiq j U ( r) = 4!" 0 rij Coulomb interaction 12 &, R ), min, ij R U ( r) =. $ * ' - 2* ij $ % + rij ( + r van der Waals interaction min, ij ij 6 ) # '! (! " 2

3 Classical Molecular Dynamics U(r) = 1 + q i q $ j + # ij - R min,ij 4"# 0 r ij - & % r, ij ' ) ( 12 % F(r) = '" 1 q i q j 2 ' 4#$ 0 r & ij * 2 R 6 $ '. min,ij 0 & % r ) ij ( 0 / "12 $ ij r ij + % - - ',& R min,ij r ij ( * ) 12 " R 6 % (.( min,ij 0 * ' & r * ij ) 0 * ˆ /) r ij Classical Molecular Dynamics 3

4 Classical Molecular Dynamics Bond definitions, atom types, atom names, parameters,. What is a Force Field? In molecular dynamics a molecule is described as a series of charged points (atoms) linked by springs (bonds). To describe the time evolution of bond lengths, bond angles and torsions, also the non-bonding van der Waals and elecrostatic interactions between atoms, one uses a force field. The force field is a collection of equations and associated constants designed to reproduce molecular geometry and selected properties of tested structures. 4

5 Energy Functions U bond = oscillations about the equilibrium bond length U angle = oscillations of 3 atoms about an equilibrium bond angle U dihedral = torsional rotation of 4 atoms about a central bond U nonbond = non-bonded energy terms (electrostatics and Lenard-Jones) Energy Terms Described in the CHARMm Force Field Bond Angle Dihedral Improper 5

6 Interactions between bonded atoms V angle = K " ( ) 2 " #" o V bond = K b ( ) 2 b " b o V dihedral = K ( 1+ cos( n"! )) " # Energy function: Classical Dynamics F=ma at 300K used to determine the force on each atom: yields a set of 3N coupled 2 nd -order differential equations that can be propagated forward (or backward) in time. Initial coordinates obtained from crystal structure, velocities taken at random from Boltzmann distribution. Maintain appropriate temperature by adjusting velocities. 6

7 Langevin Dynamics Langevin dynamics deals with each atom separately, balancing a small friction term with Gaussian noise to control temperature: The most serious bottleneck steps Rotation of buried sidechains Local denaturations Allosteric transitions s ms µs 10 9 (year) Hinge bending Rotation of surface sidechains Elastic vibrations ns ps 10 6 (day) 10 3 SPEED LIMIT Bond stretching Molecular dynamics timestep fs 10 0 δt t = 1 fs 7

8 Potential Energy (hyper)surface r ( t +! = r( + v(! t Energy U(x) Conformation (x) ( b b ) 2 V = K! bond b o Chemical type K bond b o C-C 100 kcal/mole/å Å C=C 200 kcal/mole/å Å C=C 400 kcal/mole/å Å Bond Energy versus Bond length 400 Potential Energy, kcal/mol Single Bond Double Bond Triple Bond Bond length, Å Bond angles and improper terms have similar quadratic forms, but with softer spring constants. The force constants can be obtained from vibrational analysis of the molecule (experimentally or theoretically). 8

9 Dihedral Potential V dihedral = K ( 1+ cos( n"! )) " # Dihedral energy versus dihedral angle 20 Potential Energy, kcal/mol K=10, n=1 K=5, n=2 K=2.5, N= Dihedral Angle, degrees δ = 0 van der Waals interaction *# R & " min,ij ij,, % $ r ( + ij ' 12 ) 2 R 6 # & - min,ij / % $ r ( ij ' /. Short range 9

10 CHARMM Potential Function PDB file geometry Topology PSF file parameters Parameter file File Format/Structure The structure of a pdb file The structure of a psf file The topology file The parameter file Connection to potential energy terms 10

11 PDB Files a little information Simulations start with a crystal structure from the Protein Data Bank, in the standard PDB file format. PDB files contain standard records for species, tissue, authorship, citations, sequence, secondary structure, etc. Some of the available fields atom name (N, C, CA) residue name (ALA, HIS) residue id (integer) coordinates (x, y, z) occupancy (0.0 to 1.0) temp. factor (a.k.a. beta) segment id (6PTI) No hydrogen atoms! (We must add them ourselves.) PDB File (available from if structure of biopolymer solved) REMARK FILENAME="bpti19.pdb REMARK PROTEINASE INHIBITOR (TRYPSIN) 13-MAY-87 6PTI REMARK BOVINE PANCREATIC TRYPSIN INHIBITOR REMARK BOVINE (BOS TAURUS) PANCREAS REMARK A.WLODAWER REMARK DATE:26-Jun-00 21:34:42 created by user: ATOM 1 HT1 ARG BPTI ATOM 2 HT2 ARG BPTI etc etc etc ATOM 554 CA GLY BPTI ATOM 555 C GLY BPTI ATOM 556 OT1 GLY BPTI ATOM 557 OT2 GLY BPTI END 11

12 PSF Files atomic properties (mass, charge, type) Every atom in the simulation is listed. Provides all static atom-specific values: atom name (N, C, CA) atom type (NH1, CT1) Ala residue name (ALA, HIS) residue id (integer) HA segment id (6PTI) atomic mass (in atomic mass units) partial charge (in electronic charge units) What is not in the PSF file? CA coordinates (dynamic data, initially read from PDB file) velocities (dynamic data, initially from Boltzmann distribution) force field parameters (non-specific, used for many molecules) N O C HN CB HB1 HB3 HB2 MASS HS ! thiol hydrogen MASS C ! carbonyl C, peptide backbone MASS CA ! aromatic C... (missing data here)! AUTOGENERATE ANGLES=TRUE DIHEDRALS=TRUE END! RESIDUE ALA Example of PSF File GROUP ATOM N TYPE=NH1 CHARGE= END! ATOM HN TYPE=H CHARGE=.3100 END! N--HN ATOM CA TYPE=CT1 CHARGE=.0700 END! HB1 ATOM HA TYPE=HB CHARGE=.0900 END! / GROUP! HA-CA--CB-HB2 ATOM CB TYPE=CT3 CHARGE= END! \ ATOM HB1 TYPE=HA CHARGE=.0900 END! HB3 ATOM HB2 TYPE=HA CHARGE=.0900 END! O=C ATOM HB3 TYPE=HA CHARGE=.0900 END! GROUP! ATOM C TYPE=C CHARGE=.5100 END ATOM O TYPE=O CHARGE= END!END GROUP BOND CB CA BOND N HN BOND N CA BOND O C BOND C CA BOND CA HA BOND CB HB1 BOND CB HB2 BOND CB HB3 DONOR HN N ACCEPTOR O C END {ALA } N CA HA C O HN HB1 CB HB2 HB3 12

13 Steps in a Typical MD Simulation 1. Prepare molecule Read in pdb and psf file 2. Minimization Reconcile observed structure with force field used (T = 0) 3. Heating Raise temperature of the system 4. Equilibration Ensure system is stable 5. Dynamics Simulate under desired conditions (NVE, NpT, etc) Collect your data 6. Analysis Evaluate observables (macroscopic level properties) Or relate to single molecule experiments Preparing Your System for MD Solvation Biological activity is the result of interactions between molecules and occurs at the interfaces between molecules (protein-protein, protein- DNA, protein-solvent, DNA-solvent, etc). Why model solvation? many biological processes occur in aqueous solution solvation effects play a crucial role in determining molecular conformation, electronic properties, binding energies, etc How to model solvation? explicit treatment: solvent molecules are added to the molecular system implicit treatment: solvent is modeled as a continuum dielectric 13

14 Classical Molecular Dynamics r ( t +! = r( + v(! t v ( t +! = v( + a(! t a ( t ) = F( / F =! m d U (r) dr Maxwell Distribution of Atomic Velocities 14

15 Analysis of E kin, T (free dynamics) The atomic velocities of a protein establish a thermometer, but is it accurate? ubiquitin in water bath! 2 = T 3N

The Molecular Dynamics Method

The Molecular Dynamics Method H-bond energy (kcal/mol) - 4.0 The Molecular Dynamics Method Fibronectin III_1, a mechanical protein that glues cells together in wound healing and in preventing tumor metastasis 0 ATPase, a molecular

More information

The Molecular Dynamics Method

The Molecular Dynamics Method The Molecular Dynamics Method Thermal motion of a lipid bilayer Water permeation through channels Selective sugar transport Potential Energy (hyper)surface What is Force? Energy U(x) F = d dx U(x) Conformation

More information

The Molecular Dynamics Method

The Molecular Dynamics Method H-bond energy (kcal/mol) - 4.0 The Molecular Dynamics Method Fibronectin III_1, a mechanical protein that glues cells together in wound healing and in preventing tumor metastasis 0 ATPase, a molecular

More information

The Molecular Dynamics Simulation Process

The Molecular Dynamics Simulation Process The Molecular Dynamics Simulation Process For textbooks see: M.P. Allen and D.J. Tildesley. Computer Simulation of Liquids.Oxford University Press, New York, 1987. D. Frenkel and B. Smit. Understanding

More information

Principles and Applications of Molecular Dynamics Simulations with NAMD

Principles and Applications of Molecular Dynamics Simulations with NAMD Principles and Applications of Molecular Dynamics Simulations with NAMD Nov. 14, 2016 Computational Microscope NCSA supercomputer JC Gumbart Assistant Professor of Physics Georgia Institute of Technology

More information

Force Fields for Classical Molecular Dynamics simulations of Biomolecules. Emad Tajkhorshid

Force Fields for Classical Molecular Dynamics simulations of Biomolecules. Emad Tajkhorshid Force Fields for Classical Molecular Dynamics simulations of Biomolecules Emad Tajkhorshid Theoretical and Computational Biophysics Group, Beckman Institute Departments of Biochemistry and Pharmacology,

More information

The Computational Microscope

The Computational Microscope The Computational Microscope Computational microscope views at atomic resolution... Rs SER RER C E M RER N GA L... how living cells maintain health and battle disease John Stone Our Microscope is Made

More information

Semi Empirical Force Fields and Their Limitations. Potential Energy Surface (PES)

Semi Empirical Force Fields and Their Limitations. Potential Energy Surface (PES) Semi Empirical Force Fields and Their Limitations Ioan Kosztin Beckman Institute University of Illinois at Urbana-Champaign Potential Energy Surface (PES) Schrödinger equation: H T Ψ( r, = E Ψ( r, H =

More information

Figure 1. Molecules geometries of 5021 and Each neutral group in CHARMM topology was grouped in dash circle.

Figure 1. Molecules geometries of 5021 and Each neutral group in CHARMM topology was grouped in dash circle. Project I Chemistry 8021, Spring 2005/2/23 This document was turned in by a student as a homework paper. 1. Methods First, the cartesian coordinates of 5021 and 8021 molecules (Fig. 1) are generated, in

More information

Force Fields for Classical Molecular Dynamics simulations of Biomolecules. Emad Tajkhorshid

Force Fields for Classical Molecular Dynamics simulations of Biomolecules. Emad Tajkhorshid Force Fields for Classical Molecular Dynamics simulations of Biomolecules Emad Tajkhorshid Beckman Institute Departments of Biochemistry Center for Biophysics and Computational Biology University of Illinois

More information

Molecular Mechanics. I. Quantum mechanical treatment of molecular systems

Molecular Mechanics. I. Quantum mechanical treatment of molecular systems Molecular Mechanics I. Quantum mechanical treatment of molecular systems The first principle approach for describing the properties of molecules, including proteins, involves quantum mechanics. For example,

More information

Force Fields for MD simulations

Force Fields for MD simulations Force Fields for MD simulations Topology/parameter files Where do the numbers an MD code uses come from? ow to make topology files for ligands, cofactors, special amino acids, ow to obtain/develop missing

More information

Why Proteins Fold? (Parts of this presentation are based on work of Ashok Kolaskar) CS490B: Introduction to Bioinformatics Mar.

Why Proteins Fold? (Parts of this presentation are based on work of Ashok Kolaskar) CS490B: Introduction to Bioinformatics Mar. Why Proteins Fold? (Parts of this presentation are based on work of Ashok Kolaskar) CS490B: Introduction to Bioinformatics Mar. 25, 2002 Molecular Dynamics: Introduction At physiological conditions, the

More information

DISCRETE TUTORIAL. Agustí Emperador. Institute for Research in Biomedicine, Barcelona APPLICATION OF DISCRETE TO FLEXIBLE PROTEIN-PROTEIN DOCKING:

DISCRETE TUTORIAL. Agustí Emperador. Institute for Research in Biomedicine, Barcelona APPLICATION OF DISCRETE TO FLEXIBLE PROTEIN-PROTEIN DOCKING: DISCRETE TUTORIAL Agustí Emperador Institute for Research in Biomedicine, Barcelona APPLICATION OF DISCRETE TO FLEXIBLE PROTEIN-PROTEIN DOCKING: STRUCTURAL REFINEMENT OF DOCKING CONFORMATIONS Emperador

More information

Lecture 11: Potential Energy Functions

Lecture 11: Potential Energy Functions Lecture 11: Potential Energy Functions Dr. Ronald M. Levy ronlevy@temple.edu Originally contributed by Lauren Wickstrom (2011) Microscopic/Macroscopic Connection The connection between microscopic interactions

More information

Why study protein dynamics?

Why study protein dynamics? Why study protein dynamics? Protein flexibility is crucial for function. One average structure is not enough. Proteins constantly sample configurational space. Transport - binding and moving molecules

More information

Folding WT villin in silico Three folding simulations reach native state within 5-8 µs

Folding WT villin in silico Three folding simulations reach native state within 5-8 µs Modeling of Cryo-EM Maps Workshop Baylor College of Medicine Klaus Schulten, U. Illinois at Urbana-Champaign Molecular Modeling Flexible Fitting 1: Introduction to Molecular Dynamics MD force field Equation

More information

Bioengineering 215. An Introduction to Molecular Dynamics for Biomolecules

Bioengineering 215. An Introduction to Molecular Dynamics for Biomolecules Bioengineering 215 An Introduction to Molecular Dynamics for Biomolecules David Parker May 18, 2007 ntroduction A principal tool to study biological molecules is molecular dynamics simulations (MD). MD

More information

Don t forget to bring your MD tutorial. Potential Energy (hyper)surface

Don t forget to bring your MD tutorial. Potential Energy (hyper)surface Don t forget to bring your MD tutorial Lab session starts at 1pm You will have to finish an MD/SMD exercise on α-conotoxin in oxidized and reduced forms Potential Energy (hyper)surface What is Force? Energy

More information

Molecular dynamics simulation of Aquaporin-1. 4 nm

Molecular dynamics simulation of Aquaporin-1. 4 nm Molecular dynamics simulation of Aquaporin-1 4 nm Molecular Dynamics Simulations Schrödinger equation i~@ t (r, R) =H (r, R) Born-Oppenheimer approximation H e e(r; R) =E e (R) e(r; R) Nucleic motion described

More information

Homology modeling. Dinesh Gupta ICGEB, New Delhi 1/27/2010 5:59 PM

Homology modeling. Dinesh Gupta ICGEB, New Delhi 1/27/2010 5:59 PM Homology modeling Dinesh Gupta ICGEB, New Delhi Protein structure prediction Methods: Homology (comparative) modelling Threading Ab-initio Protein Homology modeling Homology modeling is an extrapolation

More information

HOMOLOGY MODELING. The sequence alignment and template structure are then used to produce a structural model of the target.

HOMOLOGY MODELING. The sequence alignment and template structure are then used to produce a structural model of the target. HOMOLOGY MODELING Homology modeling, also known as comparative modeling of protein refers to constructing an atomic-resolution model of the "target" protein from its amino acid sequence and an experimental

More information

An introduction to Molecular Dynamics. EMBO, June 2016

An introduction to Molecular Dynamics. EMBO, June 2016 An introduction to Molecular Dynamics EMBO, June 2016 What is MD? everything that living things do can be understood in terms of the jiggling and wiggling of atoms. The Feynman Lectures in Physics vol.

More information

Protein Structure Analysis

Protein Structure Analysis BINF 731 Protein Modeling Methods Protein Structure Analysis Iosif Vaisman Ab initio methods: solution of a protein folding problem search in conformational space Energy-based methods: energy minimization

More information

Applications of Molecular Dynamics

Applications of Molecular Dynamics June 4, 0 Molecular Modeling and Simulation Applications of Molecular Dynamics Agricultural Bioinformatics Research Unit, Graduate School of Agricultural and Life Sciences, The University of Tokyo Tohru

More information

Computational Structural Biology and Molecular Simulation. Introduction to VMD Molecular Visualization and Analysis

Computational Structural Biology and Molecular Simulation. Introduction to VMD Molecular Visualization and Analysis Computational Structural Biology and Molecular Simulation Introduction to VMD Molecular Visualization and Analysis Emad Tajkhorshid Department of Biochemistry, Beckman Institute, Center for Computational

More information

Structural Bioinformatics (C3210) Molecular Mechanics

Structural Bioinformatics (C3210) Molecular Mechanics Structural Bioinformatics (C3210) Molecular Mechanics How to Calculate Energies Calculation of molecular energies is of key importance in protein folding, molecular modelling etc. There are two main computational

More information

Molecular Dynamics Simulations. Dr. Noelia Faginas Lago Dipartimento di Chimica,Biologia e Biotecnologie Università di Perugia

Molecular Dynamics Simulations. Dr. Noelia Faginas Lago Dipartimento di Chimica,Biologia e Biotecnologie Università di Perugia Molecular Dynamics Simulations Dr. Noelia Faginas Lago Dipartimento di Chimica,Biologia e Biotecnologie Università di Perugia 1 An Introduction to Molecular Dynamics Simulations Macroscopic properties

More information

Molecular Mechanics, Dynamics & Docking

Molecular Mechanics, Dynamics & Docking Molecular Mechanics, Dynamics & Docking Lawrence Hunter, Ph.D. Director, Computational Bioscience Program University of Colorado School of Medicine Larry.Hunter@uchsc.edu http://compbio.uchsc.edu/hunter

More information

Dihedral Angles. Homayoun Valafar. Department of Computer Science and Engineering, USC 02/03/10 CSCE 769

Dihedral Angles. Homayoun Valafar. Department of Computer Science and Engineering, USC 02/03/10 CSCE 769 Dihedral Angles Homayoun Valafar Department of Computer Science and Engineering, USC The precise definition of a dihedral or torsion angle can be found in spatial geometry Angle between to planes Dihedral

More information

All-atom Molecular Mechanics. Trent E. Balius AMS 535 / CHE /27/2010

All-atom Molecular Mechanics. Trent E. Balius AMS 535 / CHE /27/2010 All-atom Molecular Mechanics Trent E. Balius AMS 535 / CHE 535 09/27/2010 Outline Molecular models Molecular mechanics Force Fields Potential energy function functional form parameters and parameterization

More information

Molecular Simulation III

Molecular Simulation III Molecular Simulation III Quantum Chemistry Classical Mechanics E = Ψ H Ψ ΨΨ U = E bond +E angle +E torsion +E non-bond Molecular Dynamics Jeffry D. Madura Department of Chemistry & Biochemistry Center

More information

Exercise 2: Solvating the Structure Before you continue, follow these steps: Setting up Periodic Boundary Conditions

Exercise 2: Solvating the Structure Before you continue, follow these steps: Setting up Periodic Boundary Conditions Exercise 2: Solvating the Structure HyperChem lets you place a molecular system in a periodic box of water molecules to simulate behavior in aqueous solution, as in a biological system. In this exercise,

More information

Molecular Dynamics Simulation of a Nanoconfined Water Film

Molecular Dynamics Simulation of a Nanoconfined Water Film Molecular Dynamics Simulation of a Nanoconfined Water Film Kyle Lindquist, Shu-Han Chao May 7, 2013 1 Introduction The behavior of water confined in nano-scale environment is of interest in many applications.

More information

Biochemistry,530:,, Introduc5on,to,Structural,Biology, Autumn,Quarter,2015,

Biochemistry,530:,, Introduc5on,to,Structural,Biology, Autumn,Quarter,2015, Biochemistry,530:,, Introduc5on,to,Structural,Biology, Autumn,Quarter,2015, Course,Informa5on, BIOC%530% GraduateAlevel,discussion,of,the,structure,,func5on,,and,chemistry,of,proteins,and, nucleic,acids,,control,of,enzyma5c,reac5ons.,please,see,the,course,syllabus,and,

More information

Polypeptide Folding Using Monte Carlo Sampling, Concerted Rotation, and Continuum Solvation

Polypeptide Folding Using Monte Carlo Sampling, Concerted Rotation, and Continuum Solvation Polypeptide Folding Using Monte Carlo Sampling, Concerted Rotation, and Continuum Solvation Jakob P. Ulmschneider and William L. Jorgensen J.A.C.S. 2004, 126, 1849-1857 Presented by Laura L. Thomas and

More information

3rd Advanced in silico Drug Design KFC/ADD Molecular mechanics intro Karel Berka, Ph.D. Martin Lepšík, Ph.D. Pavel Polishchuk, Ph.D.

3rd Advanced in silico Drug Design KFC/ADD Molecular mechanics intro Karel Berka, Ph.D. Martin Lepšík, Ph.D. Pavel Polishchuk, Ph.D. 3rd Advanced in silico Drug Design KFC/ADD Molecular mechanics intro Karel Berka, Ph.D. Martin Lepšík, Ph.D. Pavel Polishchuk, Ph.D. Thierry Langer, Ph.D. Jana Vrbková, Ph.D. UP Olomouc, 23.1.-26.1. 2018

More information

Hands-on Course in Computational Structural Biology and Molecular Simulation BIOP590C/MCB590C. Course Details

Hands-on Course in Computational Structural Biology and Molecular Simulation BIOP590C/MCB590C. Course Details Hands-on Course in Computational Structural Biology and Molecular Simulation BIOP590C/MCB590C Emad Tajkhorshid Center for Computational Biology and Biophysics Email: emad@life.uiuc.edu or tajkhors@uiuc.edu

More information

Dominant Paths in Protein Folding

Dominant Paths in Protein Folding Dominant Paths in Protein Folding Henri Orland SPhT, CEA-Saclay France work in collaboration with P. Faccioli, F. Pederiva, M. Sega University of Trento Henri Orland Annecy meeting 2006 Outline Basic notions

More information

Molecular Mechanics. Yohann Moreau. November 26, 2015

Molecular Mechanics. Yohann Moreau. November 26, 2015 Molecular Mechanics Yohann Moreau yohann.moreau@ujf-grenoble.fr November 26, 2015 Yohann Moreau (UJF) Molecular Mechanics, Label RFCT 2015 November 26, 2015 1 / 29 Introduction A so-called Force-Field

More information

Atomistic Modeling of DNA and Protein Structures

Atomistic Modeling of DNA and Protein Structures Atomistic Modeling of DNA and Protein Structures George C. Schatz Introduction In this lecture we introduce one of the most commonly used computational tools for studying protein and DNA structure, the

More information

Biochemistry Prof. S. DasGupta Department of Chemistry Indian Institute of Technology Kharagpur. Lecture - 06 Protein Structure IV

Biochemistry Prof. S. DasGupta Department of Chemistry Indian Institute of Technology Kharagpur. Lecture - 06 Protein Structure IV Biochemistry Prof. S. DasGupta Department of Chemistry Indian Institute of Technology Kharagpur Lecture - 06 Protein Structure IV We complete our discussion on Protein Structures today. And just to recap

More information

TOPOLOGIES AND FORCE FIELD PARAMETERS FOR NITROXIDE SPIN LABELS

TOPOLOGIES AND FORCE FIELD PARAMETERS FOR NITROXIDE SPIN LABELS TOPOLOGIES AND FORCE FIELD PARAMETERS FOR NITROXIDE SPIN LABELS 1. Introduction The force field used in these studies is the CHARMM19 (Chemistry at HARvard Molecular Mechanics) extended atom force field

More information

Peptide folding in non-aqueous environments investigated with molecular dynamics simulations Soto Becerra, Patricia

Peptide folding in non-aqueous environments investigated with molecular dynamics simulations Soto Becerra, Patricia University of Groningen Peptide folding in non-aqueous environments investigated with molecular dynamics simulations Soto Becerra, Patricia IMPORTANT NOTE: You are advised to consult the publisher's version

More information

Computational Biology & Computational Medicine

Computational Biology & Computational Medicine Computational Biology & Computational Medicine Homayoun Valafar Outline Why proteins? What are proteins? How do we compute them? How do we use computational approaches? Why Proteins? Molecular basis of

More information

Hyeyoung Shin a, Tod A. Pascal ab, William A. Goddard III abc*, and Hyungjun Kim a* Korea

Hyeyoung Shin a, Tod A. Pascal ab, William A. Goddard III abc*, and Hyungjun Kim a* Korea The Scaled Effective Solvent Method for Predicting the Equilibrium Ensemble of Structures with Analysis of Thermodynamic Properties of Amorphous Polyethylene Glycol-Water Mixtures Hyeyoung Shin a, Tod

More information

Computational Modeling of Protein Dynamics. Yinghao Wu Department of Systems and Computational Biology Albert Einstein College of Medicine Fall 2014

Computational Modeling of Protein Dynamics. Yinghao Wu Department of Systems and Computational Biology Albert Einstein College of Medicine Fall 2014 Computational Modeling of Protein Dynamics Yinghao Wu Department of Systems and Computational Biology Albert Einstein College of Medicine Fall 2014 Outline Background of protein dynamics Basic computational

More information

Protein Dynamics. The space-filling structures of myoglobin and hemoglobin show that there are no pathways for O 2 to reach the heme iron.

Protein Dynamics. The space-filling structures of myoglobin and hemoglobin show that there are no pathways for O 2 to reach the heme iron. Protein Dynamics The space-filling structures of myoglobin and hemoglobin show that there are no pathways for O 2 to reach the heme iron. Below is myoglobin hydrated with 350 water molecules. Only a small

More information

Problem Set 1

Problem Set 1 2006 7.012 Problem Set 1 Due before 5 PM on FRIDAY, September 15, 2006. Turn answers in to the box outside of 68-120. PLEASE WRITE YOUR ANSWERS ON THIS PRINTOUT. 1. For each of the following parts, pick

More information

Computational Studies of the Photoreceptor Rhodopsin. Scott E. Feller Wabash College

Computational Studies of the Photoreceptor Rhodopsin. Scott E. Feller Wabash College Computational Studies of the Photoreceptor Rhodopsin Scott E. Feller Wabash College Rhodopsin Photocycle Dark-adapted Rhodopsin hn Isomerize retinal Photorhodopsin ~200 fs Bathorhodopsin Meta-II ms timescale

More information

Secondary Structure. Bioch/BIMS 503 Lecture 2. Structure and Function of Proteins. Further Reading. Φ, Ψ angles alone determine protein structure

Secondary Structure. Bioch/BIMS 503 Lecture 2. Structure and Function of Proteins. Further Reading. Φ, Ψ angles alone determine protein structure Bioch/BIMS 503 Lecture 2 Structure and Function of Proteins August 28, 2008 Robert Nakamoto rkn3c@virginia.edu 2-0279 Secondary Structure Φ Ψ angles determine protein structure Φ Ψ angles are restricted

More information

Introduction to Classical Molecular Dynamics. Giovanni Chillemi HPC department, CINECA

Introduction to Classical Molecular Dynamics. Giovanni Chillemi HPC department, CINECA Introduction to Classical Molecular Dynamics Giovanni Chillemi g.chillemi@cineca.it HPC department, CINECA MD ingredients Coordinates Velocities Force field Topology MD Trajectories Input parameters Analysis

More information

Routine access to millisecond timescale events with accelerated molecular dynamics

Routine access to millisecond timescale events with accelerated molecular dynamics Routine access to millisecond timescale events with accelerated molecular dynamics Levi C.T. Pierce, Romelia Salomon-Ferrer, Cesar Augusto F. de Oliveira #, J. Andrew McCammon #, Ross C. Walker * SUPPORTING

More information

Biomolecules: lecture 10

Biomolecules: lecture 10 Biomolecules: lecture 10 - understanding in detail how protein 3D structures form - realize that protein molecules are not static wire models but instead dynamic, where in principle every atom moves (yet

More information

What can be learnt from MD

What can be learnt from MD - 4.0 H-bond energy (kcal/mol) 0 What can be learnt from MD Fibronectin III_1, a mechanical protein that glues cells together in wound healing and in preventing tumor metastasis ATPase, a molecular motor

More information

Supporting Information

Supporting Information Supporting Information Constant ph molecular dynamics reveals ph-modulated binding of two small-molecule BACE1 inhibitors Christopher R. Ellis 1,, Cheng-Chieh Tsai 1,, Xinjun Hou 2, and Jana Shen 1, 1

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

Biomolecular modeling I

Biomolecular modeling I 2015, December 15 Biomolecular simulation Elementary body atom Each atom x, y, z coordinates A protein is a set of coordinates. (Gromacs, A. P. Heiner) Usually one molecule/complex of interest (e.g. protein,

More information

The Force Field Toolkit (fftk)

The Force Field Toolkit (fftk) Parameterizing Small Molecules Using: The Force Field Toolkit (fftk) Christopher G. Mayne, Emad Tajkhorshid Beckman Institute for Advanced Science and Technology University of Illinois, Urbana-Champaign

More information

Protein sidechain conformer prediction: a test of the energy function Robert J Petrella 1, Themis Lazaridis 1 and Martin Karplus 1,2

Protein sidechain conformer prediction: a test of the energy function Robert J Petrella 1, Themis Lazaridis 1 and Martin Karplus 1,2 Research Paper 353 Protein sidechain conformer prediction: a test of the energy function Robert J Petrella 1, Themis Lazaridis 1 and Martin Karplus 1,2 Background: Homology modeling is an important technique

More information

Hands-on : Model Potential Molecular Dynamics

Hands-on : Model Potential Molecular Dynamics Hands-on : Model Potential Molecular Dynamics OUTLINE 0. DL_POLY code introduction 0.a Input files 1. THF solvent molecule 1.a Geometry optimization 1.b NVE/NVT dynamics 2. Liquid THF 2.a Equilibration

More information

Protein Structure Analysis

Protein Structure Analysis BINF 731 Protein Modeling Methods Protein Structure Analysis Iosif Vaisman Ab initio methods: solution of a protein folding problem search in conformational space Energy-based methods: energy minimization

More information

Our Microscope is Made of...

Our Microscope is Made of... The Computational Microscope Computational microscope views at atomic resolution... Rs E M RER SER N RER C GA L... how living cells maintain health and battle disease John%Stone Our Microscope is Made

More information

NMR, X-ray Diffraction, Protein Structure, and RasMol

NMR, X-ray Diffraction, Protein Structure, and RasMol NMR, X-ray Diffraction, Protein Structure, and RasMol Introduction So far we have been mostly concerned with the proteins themselves. The techniques (NMR or X-ray diffraction) used to determine a structure

More information

Solutions and Non-Covalent Binding Forces

Solutions and Non-Covalent Binding Forces Chapter 3 Solutions and Non-Covalent Binding Forces 3.1 Solvent and solution properties Molecules stick together using the following forces: dipole-dipole, dipole-induced dipole, hydrogen bond, van der

More information

Improving Protein Function Prediction with Molecular Dynamics Simulations. Dariya Glazer Russ Altman

Improving Protein Function Prediction with Molecular Dynamics Simulations. Dariya Glazer Russ Altman Improving Protein Function Prediction with Molecular Dynamics Simulations Dariya Glazer Russ Altman Motivation Sometimes the 3D structure doesn t score well for a known function. The experimental structure

More information

Our Microscope is Made of...

Our Microscope is Made of... The Computational Microscope Computational microscope views at atomic resolution... Rs E M RER SER N RER C GA L... how living cells maintain health and battle disease John%Stone Our Microscope is Made

More information

Introduction to Comparative Protein Modeling. Chapter 4 Part I

Introduction to Comparative Protein Modeling. Chapter 4 Part I Introduction to Comparative Protein Modeling Chapter 4 Part I 1 Information on Proteins Each modeling study depends on the quality of the known experimental data. Basis of the model Search in the literature

More information

A generalized Born formalism for heterogeneous dielectric environments: Application to the implicit modeling of biological membranes

A generalized Born formalism for heterogeneous dielectric environments: Application to the implicit modeling of biological membranes THE JOURNAL OF CHEMICAL PHYSICS 122, 124706 2005 A generalized Born formalism for heterogeneous dielectric environments: Application to the implicit modeling of biological membranes Seiichiro Tanizaki

More information

BIOC : Homework 1 Due 10/10

BIOC : Homework 1 Due 10/10 Contact information: Name: Student # BIOC530 2012: Homework 1 Due 10/10 Department Email address The following problems are based on David Baker s lectures of forces and protein folding. When numerical

More information

I690/B680 Structural Bioinformatics Spring Protein Structure Determination by NMR Spectroscopy

I690/B680 Structural Bioinformatics Spring Protein Structure Determination by NMR Spectroscopy I690/B680 Structural Bioinformatics Spring 2006 Protein Structure Determination by NMR Spectroscopy Suggested Reading (1) Van Holde, Johnson, Ho. Principles of Physical Biochemistry, 2 nd Ed., Prentice

More information

4 th Advanced in silico Drug Design KFC/ADD Molecular Modelling Intro. Karel Berka, Ph.D.

4 th Advanced in silico Drug Design KFC/ADD Molecular Modelling Intro. Karel Berka, Ph.D. 4 th Advanced in silico Drug Design KFC/ADD Molecular Modelling Intro Karel Berka, Ph.D. UP Olomouc, 21.1.-25.1. 2019 Motto A theory is something nobody believes, except the person who made it An experiment

More information

Multiscale Materials Modeling

Multiscale Materials Modeling Multiscale Materials Modeling Lecture 09 Quantum Mechanics/Molecular Mechanics (QM/MM) Techniques Fundamentals of Sustainable Technology These notes created by David Keffer, University of Tennessee, Knoxville,

More information

Conformational Geometry of Peptides and Proteins:

Conformational Geometry of Peptides and Proteins: Conformational Geometry of Peptides and Proteins: Before discussing secondary structure, it is important to appreciate the conformational plasticity of proteins. Each residue in a polypeptide has three

More information

Can a continuum solvent model reproduce the free energy landscape of a β-hairpin folding in water?

Can a continuum solvent model reproduce the free energy landscape of a β-hairpin folding in water? Can a continuum solvent model reproduce the free energy landscape of a β-hairpin folding in water? Ruhong Zhou 1 and Bruce J. Berne 2 1 IBM Thomas J. Watson Research Center; and 2 Department of Chemistry,

More information

MULTIDOCK V1.0. Richard M. Jackson Biomolecular Modelling Laboratory Imperial Cancer Research Fund 44 Lincoln s Inn Fields London WC2A 3PX

MULTIDOCK V1.0. Richard M. Jackson Biomolecular Modelling Laboratory Imperial Cancer Research Fund 44 Lincoln s Inn Fields London WC2A 3PX MULTIDOCK V1.0 Richard M. Jackson Biomolecular Modelling Laboratory Imperial Cancer Research Fund 44 Lincoln s Inn Fields London WC2A 3PX 1.0 Description The program MULTIDOCK was developed to provide

More information

Secondary and sidechain structures

Secondary and sidechain structures Lecture 2 Secondary and sidechain structures James Chou BCMP201 Spring 2008 Images from Petsko & Ringe, Protein Structure and Function. Branden & Tooze, Introduction to Protein Structure. Richardson, J.

More information

Molecular Dynamics, Monte Carlo and Docking. Lecture 21. Introduction to Bioinformatics MNW2

Molecular Dynamics, Monte Carlo and Docking. Lecture 21. Introduction to Bioinformatics MNW2 Molecular Dynamics, Monte Carlo and Docking Lecture 21 Introduction to Bioinformatics MNW2 Allowed phi-psi angles Red areas are preferred, yellow areas are allowed, and white is avoided 2.3a Hamiltonian

More information

2008 Biowerkzeug Ltd.

2008 Biowerkzeug Ltd. 2008 Biowerkzeug Ltd. 1 Contents Summary...3 1 Simulation...4 1.1 Setup...4 1.2 Output...4 2 Settings...5 3 Analysis...9 3.1 Setup...9 3.2 Input options...9 3.3 Descriptions...10 Please note that we cannot

More information

Molecular Dynamics Simulation of HIV-1 Reverse. Transcriptase

Molecular Dynamics Simulation of HIV-1 Reverse. Transcriptase Molecular Dynamics Simulation of HIV-1 Reverse Transcriptase Abderrahmane Benghanem 1 Maria Kurnikova 2 1 Rensselaer Polytechnic Institute, Troy, NY 2 Carnegie Mellon University, Pittsburgh, PA June 16,

More information

RESEARCH ARTICLES. Effective Energy Function for Proteins in Solution

RESEARCH ARTICLES. Effective Energy Function for Proteins in Solution PROTEINS: Structure, Function, and Genetics 35:133 152 (1999) RESEARCH ARTICLES Effective Energy Function for Proteins in Solution Themis Lazaridis 1 and Martin Karplus 1,2 * 1 Department of Chemistry

More information

Biomolecules are dynamic no single structure is a perfect model

Biomolecules are dynamic no single structure is a perfect model Molecular Dynamics Simulations of Biomolecules References: A. R. Leach Molecular Modeling Principles and Applications Prentice Hall, 2001. M. P. Allen and D. J. Tildesley "Computer Simulation of Liquids",

More information

Unfolding CspB by means of biased molecular dynamics

Unfolding CspB by means of biased molecular dynamics Chapter 4 Unfolding CspB by means of biased molecular dynamics 4.1 Introduction Understanding the mechanism of protein folding has been a major challenge for the last twenty years, as pointed out in the

More information

Energy functions and their relationship to molecular conformation. CS/CME/BioE/Biophys/BMI 279 Oct. 3 and 5, 2017 Ron Dror

Energy functions and their relationship to molecular conformation. CS/CME/BioE/Biophys/BMI 279 Oct. 3 and 5, 2017 Ron Dror Energy functions and their relationship to molecular conformation CS/CME/BioE/Biophys/BMI 279 Oct. 3 and 5, 2017 Ron Dror Yesterday s Nobel Prize: single-particle cryoelectron microscopy 2 Outline Energy

More information

Enhancing Specificity in the Janus Kinases: A Study on the Thienopyridine. JAK2 Selective Mechanism Combined Molecular Dynamics Simulation

Enhancing Specificity in the Janus Kinases: A Study on the Thienopyridine. JAK2 Selective Mechanism Combined Molecular Dynamics Simulation Electronic Supplementary Material (ESI) for Molecular BioSystems. This journal is The Royal Society of Chemistry 2015 Supporting Information Enhancing Specificity in the Janus Kinases: A Study on the Thienopyridine

More information

CHEM 498Q / CHEM 630Q: Molecular Modeling of Proteins TUTORIAL #3a: Empirical force fields

CHEM 498Q / CHEM 630Q: Molecular Modeling of Proteins TUTORIAL #3a: Empirical force fields Department of Chemistry and Biochemistry, Concordia University! page 1 of 6 CHEM 498Q / CHEM 630Q: Molecular Modeling of Proteins TUTORIAL #3a: Empirical force fields INTRODUCTION The goal of this tutorial

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

Protein Folding & Stability. Lecture 11: Margaret A. Daugherty. Fall How do we go from an unfolded polypeptide chain to a

Protein Folding & Stability. Lecture 11: Margaret A. Daugherty. Fall How do we go from an unfolded polypeptide chain to a Lecture 11: Protein Folding & Stability Margaret A. Daugherty Fall 2004 How do we go from an unfolded polypeptide chain to a compact folded protein? (Folding of thioredoxin, F. Richards) Structure - Function

More information

Supplementary Information

Supplementary Information 1 Supplementary Information Figure S1 The V=0.5 Harker section of an anomalous difference Patterson map calculated using diffraction data from the NNQQNY crystal at 1.3 Å resolution. The position of the

More information

Energy functions and their relationship to molecular conformation. CS/CME/BioE/Biophys/BMI 279 Oct. 3 and 5, 2017 Ron Dror

Energy functions and their relationship to molecular conformation. CS/CME/BioE/Biophys/BMI 279 Oct. 3 and 5, 2017 Ron Dror Energy functions and their relationship to molecular conformation CS/CME/BioE/Biophys/BMI 279 Oct. 3 and 5, 2017 Ron Dror Outline Energy functions for proteins (or biomolecular systems more generally)

More information

6.#Molecular#Mechanics#and# Molecular#Dynamics#Simula5on# MOLECULAR)MECHANICS) Determinant#of#Structure#(or#Lack#of#It)# Water#

6.#Molecular#Mechanics#and# Molecular#Dynamics#Simula5on# MOLECULAR)MECHANICS) Determinant#of#Structure#(or#Lack#of#It)# Water# BIOCH 755: Biochemistry I Fall 2015 6.#Molecular#Mechanics#and# Molecular#Dynamics#Simula5on# Jianhan#Chen# Office#Hour:#M#1:30?2:30PM,#Chalmers#034# Email:#jianhanc@ksu.edu# Office:#785?2518# Determinant#of#Structure#(or#Lack#of#It)#

More information

MARTINI simulation details

MARTINI simulation details S1 Appendix MARTINI simulation details MARTINI simulation initialization and equilibration In this section, we describe the initialization of simulations from Main Text section Residue-based coarsegrained

More information

University of Groningen. Characterization of oil/water interfaces van Buuren, Aldert Roelf

University of Groningen. Characterization of oil/water interfaces van Buuren, Aldert Roelf University of Groningen Characterization of oil/water interfaces van Buuren, Aldert Roelf IMPORTANT NOTE: You are advised to consult the publisher's version (publisher's PDF) if you wish to cite from it.

More information

Scuola di Chimica Computazionale

Scuola di Chimica Computazionale Societa Chimica Italiana Gruppo Interdivisionale di Chimica Computazionale Scuola di Chimica Computazionale Introduzione, per Esercizi, all Uso del Calcolatore in Chimica Organica e Biologica Modellistica

More information

3. An Introduction to Molecular Mechanics

3. An Introduction to Molecular Mechanics 3. An Introduction to Molecular Mechanics Introduction When you use Chem3D to draw molecules, the program assigns bond lengths and bond angles based on experimental data. The program does not contain real

More information

CAP 5510 Lecture 3 Protein Structures

CAP 5510 Lecture 3 Protein Structures CAP 5510 Lecture 3 Protein Structures Su-Shing Chen Bioinformatics CISE 8/19/2005 Su-Shing Chen, CISE 1 Protein Conformation 8/19/2005 Su-Shing Chen, CISE 2 Protein Conformational Structures Hydrophobicity

More information

CHEM 498Q / CHEM 630Q: Molecular Modeling of Proteins TUTORIAL #3a: Empirical force fields

CHEM 498Q / CHEM 630Q: Molecular Modeling of Proteins TUTORIAL #3a: Empirical force fields Department of Chemistry and Biochemistry, Concordia University page 1 of 6 CHEM 498Q / CHEM 630Q: Molecular Modeling of Proteins TUTORIAL #3a: Empirical force fields INTRODUCTION The goal of this tutorial

More information

Gromacs Workshop Spring CSC

Gromacs Workshop Spring CSC Gromacs Workshop Spring 2007 @ CSC Erik Lindahl Center for Biomembrane Research Stockholm University, Sweden David van der Spoel Dept. Cell & Molecular Biology Uppsala University, Sweden Berk Hess Max-Planck-Institut

More information

Structure Investigation of Fam20C, a Golgi Casein Kinase

Structure Investigation of Fam20C, a Golgi Casein Kinase Structure Investigation of Fam20C, a Golgi Casein Kinase Sharon Grubner National Taiwan University, Dr. Jung-Hsin Lin University of California San Diego, Dr. Rommie Amaro Abstract This research project

More information

Aqueous solutions. Solubility of different compounds in water

Aqueous solutions. Solubility of different compounds in water Aqueous solutions Solubility of different compounds in water The dissolution of molecules into water (in any solvent actually) causes a volume change of the solution; the size of this volume change is

More information