Fortgeschrittenen Praktikum - WS 2015/16

Size: px
Start display at page:

Download "Fortgeschrittenen Praktikum - WS 2015/16"

Transcription

1 TU München Physik-Department AG Molekulardynamik (T38) Prof. Dr. Martin Zacharias Fortgeschrittenen Praktikum - WS 2015/16 Versuch 74 - Molecular dynamics Betreuung: Christina Frost (christina.frost@mytum.de) Physik-Department - Physik I - Raum / Isaure debeauchene (isaure@debeauchene.fr) Physik-Department - Physik I - Raum /

2 1 General information During this experiment of the Blockpraktikum Biophysik, you will learn the basic theory and application of Molecular Dynamics Simulations. Using this method, you will create different small peptide/protein systems, simulate them, and analyze the simulation output. In a first part, from approx. 9.00h to 10.00h, the tutors will present the general concept of Molecular Dynamics Simulations, the theory behind it, and some details about programs that are used throughout this course. The second part (approx. from 10.00h to 12.00h), will take place at workstations of the lab and you will be introduced to the AMBER simulation package [1] by working through a short tutorial. After this tutorial is finished, every student will set up a small peptide folding simulation (as advised in the manual) which will finish simulating during lunch time (12.00h to 14.00h). After lunch break, the results of the peptide simulation will be analyzed and a second simulation (investigating protein-ligand dissociation) will be set up and analyzed. During the whole lab course, the tutors will be present to assist with problems. Please be at room PH ( at 9.30 s.t. 2

3 2 Molecular Dynamics Simulations In the last decades, the Molecular Dynamics technique has evolved to a versatile method to study molecules in an implicit and explicit water environment at atomic level under the influence of external forces. It allows insight into dynamical processes at the picosecond to nanosecond timescale and is thereby complementary to structural data obtained from X-ray, NMR spectroscopy, or atomic force microscopy experiments. In the following, the methodology, approximations and limitations of this versatile method will be pointed out. Approximation 1 Born Oppenheimer Approximation: In 1925, Erwin Schrödinger postulated the equation that describes the time-dependence of any quantum mechanical system: Hψ = i h δψ δt, (0.1) with the Hamiltonian H (total energy of the system), the wave function ψ (the probability density of all particles in a system), and h = h (h is Plank s constant). Due to their much 2π lower mass (approx. 1:1836) as compared to the nuclei and thereby higher velocities, electrons are assumed to follow the nuclear motion instantaneously. Hence, it is possible to separate the variables associated with the nuclei wavefunction from those of the electrons (Born-Oppenheimer approximation): ψ tot (R, r) = ψ nucl (R)ψ el (R; r). (0.2) where R is the vector containing the coordinates and momenta of the nuclei and r those of the electrons, respectively. Insertion into the Schrödinger equation yields a timedependent equation for the nuclei and a time-independent Schrödinger equation for the electrons. Approximation 2 Force Fields: In the second approximation, the electronic potential is approximated by a force field 3

4 (or potential function) V. Typical force fields treat bio-molecules as extended spheres (atoms) and sticks (bonds) between atoms: They are composed of non-bonded interactions (Coulomb interactions and Lennard-Jones potentials) and bonded interactions. The latter typically include harmonic terms for covalent bonds between atoms and for angles as well as a contribution for rotations around a bond (dihedral terms). A typical force field is given by: q i q j V = + 4π ɛ i<j 0 r ij i<j kb ij(r ij b 0 ij) 2 bonds ( Aij r 12 ij B ) ij rij kθ ijk(θ ijk θijk) 0 2 angles + k φ (1 + cos(n(φ φ 0 ))) (0.3) dihedrals where q i is the partial charge of atom i, r ij denotes the distance between two atoms i and j, A ij and B ij are Lennard-Jones parameters, k b, k θ, and k φ are bond/angle/dihedral force constants, n the dihedral multiplicity and b 0, θ 0, and φ 0 are equilibrium values for bond lengths, angles, and dihedral angles. During the MD simulation setup, a force field may be chosen from the different versions that have been developed, e.g. AMBER [2], CHARMM [3], OPLS[4], or GROMOS[5]. Approximation 3 Newton s second law: The time-dependent Schrödinger equation for the nuclei positions is approximated by Newton s equation of motion (second law of Newton (1687)), F i = m i a i (0.4) where the force F i acting on atom i equals the product of the mass of atom i and its respective acceleration i. An efficient numerical double-integration of this equation can be achieved by using the Verlet algorithm [6] or the Leap-Frog algorithm [7]. The time step size for integration has to be chosen small as compared to the fastest motions in the system e.g. bond vibrations involving hydrogen atoms and is thereby restricted to less than 1 femtosecond (= s). Using algorithms as LINCS [8] or SHAKE [9] allows to enlarge the time step to 2 fs by constraining the bond lengths. 4

5 Often, one applies periodic boundary conditions within the simulations. Hence, the simulation box is duplicated infinitely in all three dimensions and by this, e.g. a simulation of a lipid bilayer resembles the experimental situation of multilamellar lipid bilayers. Because the non-bonded interactions (first two sums in equation 0.3) between atoms are the computationally most expensive part for the force calculation, a cutoff of usually 1.0 to 1.4 nm is applied for the Lennard-Jones interactions, as these decrease quickly with increasing distance between two atoms ( 1 r 6 ). Long range electrostatic interactions are treated by the grid-based Ewald summation which calculates the electrostatic contributions within a cutoff explicitly and the contributions outside of this cutoff in the reciprocal space. The Particle Mesh Ewald (PME) method yields another way to enhance the efficiency of Ewald summation by using fast Fourier transformations from N 2 for the explicit calculation of coulombic interactions to N log(n), N being the number of atoms in the system. Constant temperature during the simulation can be assured by coupling the system to an external temperature bath with given temperature T 0. This can be achieved e.g. by the Berendsen thermostat [10]: dt dt = T 0 T, (0.5) τ where a deviation of the system temperature T from T 0 decays exponentially with the a time constant τ (typical value 1 ps). The Berendsen coupling scheme was also used to keep the system s pressure to a constant value of 1 bar. However, there are also regulations and limitations for MD-Simulations: Firstly, not all molecules have yet been adequately parameterized. The second limitation is connected to the computational effort that is necessary for only one nanosecond of simulation as mentioned before. Hence, the simulation length is practically restricted to 50 to 100 nanoseconds, dependent on the system size. It is further not possible to describe chemical reactions by the simulation of a system, as the classical force field approximation cannot describe breakage or formation of covalent bonds. Also, processes at low temperature (less than 10 K) and the dynamics of hydrogen atoms are poorly described due to the increasing importance of quantum dynamical behaviour at low temperatures or small masses. 5

6 3 Introduction to AMBER Setup of a molecular dynamics simulation of a peptide This part of the course will make you familiar with the AMBER 9 Simulation suite [1]. Step by step, we will go through a full simulation setup and execution. Open a terminal and change to the lab tutorial folder named Blockpraktikum cd Blockpraktikum Typing the command ls should show the 3 subfolders needed for this lab tutorial. Change to the folder amber cd amber In this tutorial we will attempt to setup and run an MD simulation of an oligo-alanine peptide in implicit solvent using the Amber9 simulation package (Case et al., 2003, UCSF). Before we can start the simulation we need to create the following files: 1. Initial coordinates 2. Topology file (describes the molecular mechanics force field of the peptide) 3. Input files for energy minimization and MD run. Stage 1 - Building the initial coordinates and topology Initial coordinates can be generated either from a database of experimental structures or we can generate the initial structures using the Leap module available in the Amber package. Here we use the Leap module to generate the start structure of oligo-alanine. The sequence is ALA-ALA-ALA-ALA-ALA-ALA (6 alanine amino acid). To protect the terminal ends we use capped poly alanine peptide, so the sequence is ACE-ALA-ALA- ALA-ALA-ALA-ALA-NME. Start the leap program and generate the structure, in the 6

7 command prompt type xleap Here, be sure that Caps Lock on your keyboard is disabled. Now we have to load the force field parameters source leaprc.ff03.r1 Use the command sequence to create the structure, type: protein = sequence {ACE ALA ALA ALA ALA ALA ALA NME} We have created the structure, now save the coordinates and topology file using the command saveamberparm saveamberparm protein ala.top ala.crd quit xleap by typing: quit Now in your working directory you will find the two files (ala.top, ala.crd) we generated from xleap. From this topology and coordinate file we can generate a pdb file which can be used to visualize the peptide structure. The amber package contains a module called ambpdb to do this job. In the command prompt type ambpdb -p ala.top < ala.crd> ala.pdb Use VMD to visualize the structure vmd ala.pdb Stage 2 - Minimising the structure Before we start running MD we need to perform a short minimization of our starting structure. The energy minimization removes the steric clashes, if any, and will move the structure to the nearest local minimum. For this purpose, we need an input file which you can find in the folder (filename min.in) Look at the file (e.g. using more min.in), the different settings for the minimzation run are commented. 7

8 Run the minimization with the MD-executable of AMBER called sander: sander -O -i min.in -p ala.top -c ala.crd -o alamin.out -r alamin.crd -O - to overwrite the output files if it exist -p - flag for topology file -c - flag for input coordinate file -o - flag for output file -r - flag for output coordinate file -i - flag for the input command file If the simulation was successful, we have two more files alamin.out and alamin.crd in the working directory. Look at the output files alamin.out and alamin.crd. In the command prompt type more alamin.out or more alamin.crd Now convert the output coordinate file into pdb, so that we can visualize the structure ambpdb -p ala.top < alamin.crd> alamin.pdb vmd alamin.pdb Compare the minimized structure to the initial starting structure. What has changed? Stage 3 - Heating up the system The next stage is to do the MD run. As we normally do the MD simulations at 300K (room temperature) we should heat up the system to 300k in a step by step manner. The heating in stages will equilibrate the system at each temperature. We do it in three steps like 100K, 200K and 300K and for 5ps in each step. In your folder, you can find three input files named md1.in, md2.in, and md3.in. Open and compare these files. What are the differences? Now run the MD runs subsequently: MD at 100K sander -O -i md1.in -p ala.top -c alamin.crd -o alamd1.out -r alamd1.crd -x alamd1.trj 8

9 MD at 200K sander -O -i md2.in -p ala.top -c alamd1.crd -o alamd2.out -r alamd2.crd -x alamd2.trj MD at 300K sander -O -i md3.in -p ala.top -c alamd2.crd -o alamd3.out -r alamd3.crd -x alamd3.trj Note that these simulations and the following production run are done in vacuum with distance dependent dielectric constant. Stage 4 - Production run Now we run a production MD simulation. Usually one needs to run it for several nanoseconds, but due to time constraints (of this lab course) we run it for only 1 ns. The inputfile for the production run is called mdpr.in. The machine you are working on has a 4- core processor, to use all 4 efficiently and to decrease the real simulation time, we will use MPI. Run the simulation using: mpiexec -n 4 sander.mpi -O -i mdpr.in -p ala.top -c alamd3.crd -o alamdpr.out -r alamdpr.crd -x alamdpr.trj This will take around 3 minutes... Stage 5 - Visualize the trajectory in VMD vmd -parm7 ala.top -crd alamdpr.trj If every thing went fine, now you can see the trajectories in the display window. Choose graphics in the VMD panel The peptide can be represented in the several drawing methods ( as lines, as ribbons, as cartoon) Choose from the list box under drawing method, for example choose cartoon representation, you can see the cartoon representation of the peptide model in the display window. Describe what is happening throughout the trajectory and which conformational changes you can observe. 9

10 Stage 6 - RMSD vs. time plot Now we calculate the root mean square deviation (RMSD) of the start structure over the trajectory. We use a module ptraj that is available in Amber 9 package. The contents of the input file rmsd.in are: trajin alamdpr.trj rms out rmsd.dat time 1.0 Run the ptraj program: ptraj ala.top < rmsd.in> rmsd.out Now plot the rmsd data using xmgrace xmgrace rmsd.dat The popup window shows the plot of Rmsd vs. time. Summary of the steps 1. Generate a start structure using the leap module 2. Generate coordinates and topology files 3. Perform energy minimization 4. Run MD simulations 5. Visualize the trajectory in VMD 6. Calculate the RMSD values using ptraj and plot rmsd vs. time using xmgrace. Additional tasks: record the hydrogen bond formation. create a Ramachandran plot record the end-to-end distance of the peptide 10

11 4 Folding simulation of Chignolin The 10 residue chignolin peptide[11] is an example of a small peptide that forms a stable hairpin type three-dimensional (3D) structure in solution (at 300 K, see Figure 1). Aim of the MD simulation studies is to simulate the structure formation process starting from a fully extended unfolded peptide conformation. Note that the outcome can strongly depend on the starting structure (traps in energy landscapes,...). The simulations are performed employing an implicit solvent model (Generalized Born model) as implemented in the Amber simulation package (input parameter igb=1). During the simulations a Langevin type equation of motion is solved numerically in small steps. Change to the chignolin-folder by cd../chignolin Like previously learned, use xleap to create the following sequence: source leaprc.ff03.r1 protein = sequence {NGLY TYR ASP PRO GLU THR GLY THR TRP CGLY} Here, we will use a slightly different born radii from default to enhance the performance: set default pbradii mbondi2 Again we save the Topology and the coordinates and quit xleap. saveamberparm protein chi.top chi.crd Minimize it using the following input file: mpiexec -n 4 sander.mpi -O -i min.in -p chi.top -c chi.crd -o chimin.out -r chimin.crd Now, we run the short production simulation mpiexec -n 4 sander.mpi -O -i mdpr.in -p chi.top -c chimin.crd -o chimdpr-short.out -r chimdpr-short.crd -x chimdpr-short.trj This is a shorter simulation than the one we will analyse later. But it can still give us a good first impression. As this simulation will run for approx. 1h, you can now go to Lunch-Break. 11

12 5 Analysis of the chignolin results It is useful to take a look at the generated trajectory using VMD and compare the sampled conformations with the starting structure and the reference conformation (folded experimental Chigolin conformation). Prepare a Figure showing the superposition of one of the final structures and the start structure with the experimental peptide structure. Prepare an Rmsd plot with respect to the start structure and with respect to the experimental folded structure. Estimate the fraction of folded conformations during the last 5 ns simulation time. Prepare Rmsd plots for the central parts of the structure and for the stem part of the hairpin. Monitor the formation of key H-bonds in VMD and generate plots with the help of ptraj. Which part forms first? Which part is the most flexible? Make a Ramachandran plot of residue 2 to 9 (all residues besides the caps). 12

13 6 Potential of mean force for ligand-receptor dissociation The WW-domain (shown in cartoon and ribbon representation) in complex with a proline-rich ligand peptide (stick representation on top) WW domains are small protein structures of 40 amino acids that are subdomains of many larger proteins. WW domains can fold as isolated units and bind proline rich peptides at a specific binding cleft. Aim of the simulation experiment is to induce dissociation of a pro-rich peptide from the WW domain and to calculate the free energy change along a dissociation pathway. The simulations are performed including solvent and surrounding ions explicitly. Dissociation is achieved along a reaction coordinate (d) defined as the distance between centers of mass of the WW-domain and a bound peptide. The dissociation is induced in a series of simulations by adding a penalty potential along the reaction coordinate of the following form (umbrella potential): V penalty (d) = k penalty (d d 0 ) 2 (0.6) 13

14 The distance d 0 corresponds to a reference distance that can be varied between 9 Å (complexed state) and 22 Å (dissociated state). The force constant k penalty is set to 1 kcal mol-1 Å -1. This allows for fluctuations of the actual distance d around d 0 of 1 Å. Dissociation is induced by running a set of simulations starting with a d 0 =9 Å followed by a stepwise (1 Å ) increase of d 0 to 22 Å. During the simulations the actually sampled distance d is recorded. From the distance distributions it is finally possible to calculate a free energy change along the reaction coordinate using the Weighted Histogram Analysis Method (WHAM)[12]. Setup of the simulations using the xleap program Open the pdb file of the WW-domain in complex with a pro-rich ligand in xleap. source leaprc.ff03.r1 ww = loadpdb ww2.pdb Using the command charge ww we see that the WW-domain is still charged. This would be problematic and thus we will add one Natrium ion to counter the charge addions ww Na+ 1 For this small waterbox we only need two Na, and two Cl ions to reach the intracellular ion concentration (in vitro). addions ww Na+ 2 Cl- 2 Create a box of 9 Å radius around the protein and solvate it with TIP3P water solvateoct ww TIP3PBOX 9.0 We will use pregenerated files for the later simlation and analysis and will thus only produce a pdb file. saveamberparm ww ww-water.top ww-water.crd savepdb ww ww-water.pdb The stored protein topology file and structure contain not only parameters and coordinates of the protein and peptide but also of the surrounding water and ions. Now, an energy minimization and a series of short MD simulations to equilibrate the system are performed. 14

15 Use the input file mini.in for the minimization. mpiexec -n 4 sander.mpi -O -i mini.in -p ww-water.top -c ww-water.crd -o ww-watermin.out -r ww-watermin.crd During equilibration the system is heated to 300 K with the protein coordinates restraint to the initial experimental structure. In a second set of simulations the restraints are gradually removed. We use for the next steps an already pre-equilibrated system (wws0.crd) and will continue directly with the induced dissociation. Before we can start the induced peptide dissociation the centers of mass for the WWdomain and for the bound peptide need to be defined in a restraint definition file. For this purpose, the MD-program needs the atom numbers of those atoms that form each center of mass. It is best to use the Cα atom of each peptide residue to define one center and the Cα atom of the protein to define the second center of mass. The format of the restraint definition file will be provided. For the peptide dissociation, a series of 14 MD simulations is performed with 14 different reference distances (d 0 ). Each simulation will be run for 2000 steps (4 ps) and the resulting trajectories will be used to visualize the dissociation process. For the quantitative evaluation of the results, a much longer (already pre-calculated) trajectory will be used. The md-input files for the distance restraining runs are mdrs1.in to mdrs14.in and can be started running the script prs.script by giving the following command to the terminal:./prs.script The file disn.in contains the group definition and the distance restraining information: &rest iat=-1, -1, iresid=0, irstyp=0,ifvari=1,ninc=0, imult=0,ir6=0,ifntyp=0, r1= 0.000,r2=11.000,r3=11.000,r4=99.000,rk1=1.000,rk2=1.000, igr1= 150,166,...,0, igr2= 567,581,...,0, 15

16 Simulation analysis and potential of mean force for peptide dissociation Use the VMD program to visualize the dissociation trajectory and to prepare a movie of the process. Which parts of the contacts between peptide and protein are first disrupted? Has the conformation of peptide and protein changed during dissociation? Prepare distance distribution curves for each of the 14 MD simulations. Compare the distributions with the reference distance d 0 for each simulation. Perform a WHAM analysis of the dissociation process to calculate the potential of mean force or free energy profile along the reaction coordinate. The WHAM program by A. Grossfield [12] can be used for this purpose with the following command line arguments: wham input.txt pmf.out begin end steps toler. temp a.e.p. infile outfile The output file first has to be cleaned of invalid lines and columns to analyse it. Do this with your editor of choice. Tip: Vi/Vim/Emacs/Kate etc. have a column selection mode. Kate: Ctrl+Shift+B Vi/Vim: Ctrl+Alt+V It is useful to check the Rmsd of the protein and the complex as a function of simulation stage. Can we relate the calculated free energy curve to specific dissociation events during the simulation? 16

17 Important commands Generate and setup the structures xleap load forcefield parameters source leaprc.ff03.r1 create a sequence protein = sequence {...} load a pdb structure protein = loadpdb xyz.pdb use different set of born radii set default pbradii mbondi2 check the charge of the structure charge protein add ions to neutralize or simulate a cellular environment addions protein ion amount create a box and solvate with water solvateoct protein TIP3PBOX 9.0 save the topology and coordinates saveamberparm protein xyz.top xyz.crd save as pdb savepdb protein xyz.pdb close the program xleap quit Visualize a strucutre normal pdb vmd -pdb xyz.pdb implicit solvent simulation vmd -parm7 xyz.top -crd xyz.crd/.trj explicit solvent simulation vmd -parm7 xyz.top -crdbox xyz.trj 17

18 Generate pdbfile from.top and.crd ambpdb -p xyz.top <xyz.crd> xyz.pdb Run a simulation Minimisation sander -O -i simulation parameter -p topology -c coordinates -o output log -r new coordinates Other sander -O -i simulation parameter -p topology -c coordinates -o output log -r new coordinates -x new trajectory for long simulations use mpiexec -n 4 sander.mpi... Analysis create different infiles and read in the trajectory trajin trajectory calculate distances / hbonds distance dist :residue@atom :residue@atom out filename.dat time x.y calculate RMSD rms reference structure :residue@atom out filename.dat time x.y use ptraj to perform the calculations ptraj xyz.top <infile> output log Generate plots of the calculated data xmgrace file1 file

19 Bibliography [1] T.E. Cheatham III C.L. Simmerling J. Wang R.E. Duke R. Luo M. Crowley Ross C. Walker W. Zhang K.M. Merz B.Wang S. Hayik A. Roitberg G. Seabra I. Kolossvry K.F.Wong F. Paesani J. Vanicek X.Wu S.R. Brozell T. Steinbrecher H. Gohlke L. Yang C. Tan J. Mongan V. Hornak G. Cui D.H. Mathews M.G. Seetin C. Sagui V. Babin D.A. Case, T.A. Darden and P.A. Kollman. Amber 9. University of California, San Francisco, (16), Dec. [2] S. J. Weiner, P. A. Kollman, D. A. Case, U. Singh, C. Ghio, G. Alagona, Jr. S. Profeta, and P. Weiner. A new force field for molecular mechanical simulation of nucleic acids and proteins. JACS, 106: , [3] B. R. Brooks, R. E. Bruccoleri, B. D. Olafson, D. J. States, S. Swaminathan, and M. Karplus. CHARMM: A program for macromolecular energy, minimization, and dynamics calculations. J Comp Chem, 4(2): , [4] W. L. Jorgensen, D. S. Maxwell, and J. Tirado-Rives. Development and testing of the OPLS all-atom force field on conformational energetics and properties of organic liquids. JACS, 118: , [5] W. F. van Gunsteren, S. R. Billeter, A. A. Eising, P. H. Hünenberger, P. Krüger, A. E. Mark, W. R. P. Scott, and I. G. Tironi. Biomolecular Simulation: The GROMOS96 Manual and User Guide. Vdf Hochschulverlag AG an der ETH Zürich, Zürich, Switzerland, [6] R. E. Gillian and K. R. William. Shading, rare events and rubber bands a variational verlet algorithm for molecular dynamics. JCP, 97: , [7] W. F. van Gunsteren and H. J. C. Berendsen. A leap-frog algorithm for stochastic dynamics. Mol. Sim., 1:173185, [8] B. Hess, H. Bekker, H. J. C. Berendsen, and J. G. E. M. Fraaije. LINCS: A linear constraint solver for molecular simulations. J. Comp. Chemistry, 18: , [9] Philippe H. Hnenberger Vincent Krutler, Wilfred F. van Gunsteren. A fast shake algorithm to solve distance constraint equations for small molecules in molecular dynamics simulations. Journal of Computational Chemistry, 22: , [10] H. J. C. Berendsen, J. P. M. Postma, W. F. Van Gunsteren, and J. Hermans. Interaction model for water in relation to protein hydration., pages D. Reidel Publishing Company, Dordrecht, The Netherlands, [11] Shinya Honda, Kazuhiko Yamasaki, Yoshito Sawada, and Hisayuki Morii. 10 residue folded peptide designed by segment statistics. Structure, 12(8): , Aug [12] 19

Estimating Convergence Probability for the Hartree-Fock Algorithm for Calculating Electronic Wavefunctions for Molecules

Estimating Convergence Probability for the Hartree-Fock Algorithm for Calculating Electronic Wavefunctions for Molecules Estimating Convergence Probability for the Hartree-Fock Algorithm for Calculating Electronic Wavefunctions for Molecules Sofia Izmailov, Fang Liu December 14, 2012 1 Introduction In quantum mechanics,

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

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

Molecular Dynamics. Coherency of Molecular Motions. Local Minima & Global Minimum. Theoretical Basis of Molecular Dynamic Calculations

Molecular Dynamics. Coherency of Molecular Motions. Local Minima & Global Minimum. Theoretical Basis of Molecular Dynamic Calculations Molecular Dynamics Molecular Dynamics provide a good approach to determine the preferred conformers and global minimum of a molecule Theoretical Basis of Molecular Dynamic Calculations Molecular dynamics

More information

Applications of the Spring. Force: molecules

Applications of the Spring. Force: molecules Applications of the Spring Atoms interact via the coulomb force Force: molecules When atoms are far apart, they are attractive When atoms are too close, they are repulsive Atoms in a molecule display relative

More information

Towards fast and accurate binding affinity. prediction with pmemdgti: an efficient. implementation of GPU-accelerated. Thermodynamic Integration

Towards fast and accurate binding affinity. prediction with pmemdgti: an efficient. implementation of GPU-accelerated. Thermodynamic Integration Towards fast and accurate binding affinity prediction with pmemdgti: an efficient implementation of GPU-accelerated Thermodynamic Integration Tai-Sung Lee,, Yuan Hu, Brad Sherborne, Zhuyan Guo, and Darrin

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

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

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

Medical Research, Medicinal Chemistry, University of Leuven, Leuven, Belgium.

Medical Research, Medicinal Chemistry, University of Leuven, Leuven, Belgium. Supporting Information Towards peptide vaccines against Zika virus: Immunoinformatics combined with molecular dynamics simulations to predict antigenic epitopes of Zika viral proteins Muhammad Usman Mirza

More information

Molecular dynamics simulation. CS/CME/BioE/Biophys/BMI 279 Oct. 5 and 10, 2017 Ron Dror

Molecular dynamics simulation. CS/CME/BioE/Biophys/BMI 279 Oct. 5 and 10, 2017 Ron Dror Molecular dynamics simulation CS/CME/BioE/Biophys/BMI 279 Oct. 5 and 10, 2017 Ron Dror 1 Outline Molecular dynamics (MD): The basic idea Equations of motion Key properties of MD simulations Sample applications

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

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

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

Density Functional Theory: from theory to Applications

Density Functional Theory: from theory to Applications Density Functional Theory: from theory to Applications Uni Mainz January 17, 2011 CP-PAW/COSMO Interface Mixed quantum/ classical molecular dynamics (QM/MM) Quantum mechanics is computationally expensive

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

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

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

Protein structure sampling based on molecular dynamics and improvement of docking prediction

Protein structure sampling based on molecular dynamics and improvement of docking prediction 1 1 1, 2 1 NMR X Protein structure sampling based on molecular dynamics and improvement of docking prediction Yusuke Matsuzaki, 1 Yuri Matsuzaki, 1 Masakazu Sekijima 1, 2 and Yutaka Akiyama 1 When a protein

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

k θ (θ θ 0 ) 2 angles r i j r i j

k θ (θ θ 0 ) 2 angles r i j r i j 1 Force fields 1.1 Introduction The term force field is slightly misleading, since it refers to the parameters of the potential used to calculate the forces (via gradient) in molecular dynamics simulations.

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

Supplemental Material for Global Langevin model of multidimensional biomolecular dynamics

Supplemental Material for Global Langevin model of multidimensional biomolecular dynamics Supplemental Material for Global Langevin model of multidimensional biomolecular dynamics Norbert Schaudinnus, Benjamin Lickert, Mithun Biswas and Gerhard Stock Biomolecular Dynamics, Institute of Physics,

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

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

Time-dependence of key H-bond/electrostatic interaction distances in the sirna5-hago2 complexes... Page S14

Time-dependence of key H-bond/electrostatic interaction distances in the sirna5-hago2 complexes... Page S14 Supporting Information Probing the Binding Interactions between Chemically Modified sirnas and Human Argonaute 2 Using Microsecond Molecular Dynamics Simulations S. Harikrishna* and P. I. Pradeepkumar*

More information

Tailoring the Properties of Quadruplex Nucleobases for Biological and Nanomaterial Applications

Tailoring the Properties of Quadruplex Nucleobases for Biological and Nanomaterial Applications Electronic Supplementary Material (ESI) for Physical Chemistry Chemical Physics. This journal is the Owner Societies 2014 Supporting Information for: Tailoring the Properties of Quadruplex Nucleobases

More information

The Dominant Interaction Between Peptide and Urea is Electrostatic in Nature: A Molecular Dynamics Simulation Study

The Dominant Interaction Between Peptide and Urea is Electrostatic in Nature: A Molecular Dynamics Simulation Study Dror Tobi 1 Ron Elber 1,2 Devarajan Thirumalai 3 1 Department of Biological Chemistry, The Hebrew University, Jerusalem 91904, Israel 2 Department of Computer Science, Cornell University, Ithaca, NY 14853

More information

Molecular modeling. A fragment sequence of 24 residues encompassing the region of interest of WT-

Molecular modeling. A fragment sequence of 24 residues encompassing the region of interest of WT- SUPPLEMENTARY DATA Molecular dynamics Molecular modeling. A fragment sequence of 24 residues encompassing the region of interest of WT- KISS1R, i.e. the last intracellular domain (Figure S1a), has been

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

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

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

Molecular Dynamics Studies of Human β-glucuronidase

Molecular Dynamics Studies of Human β-glucuronidase American Journal of Applied Sciences 7 (6): 83-88, 010 ISSN 1546-939 010Science Publications Molecular Dynamics Studies of Human β-lucuronidase Ibrahim Ali Noorbatcha, Ayesha Masrur Khan and Hamzah Mohd

More information

Advanced Molecular Molecular Dynamics

Advanced Molecular Molecular Dynamics Advanced Molecular Molecular Dynamics Technical details May 12, 2014 Integration of harmonic oscillator r m period = 2 k k and the temperature T determine the sampling of x (here T is related with v 0

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

Advanced Molecular Dynamics

Advanced Molecular Dynamics Advanced Molecular Dynamics Introduction May 2, 2017 Who am I? I am an associate professor at Theoretical Physics Topics I work on: Algorithms for (parallel) molecular simulations including GPU acceleration

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

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

Potential Energy (hyper)surface

Potential Energy (hyper)surface 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

Development of Molecular Dynamics Simulation System for Large-Scale Supra-Biomolecules, PABIOS (PArallel BIOmolecular Simulator)

Development of Molecular Dynamics Simulation System for Large-Scale Supra-Biomolecules, PABIOS (PArallel BIOmolecular Simulator) Development of Molecular Dynamics Simulation System for Large-Scale Supra-Biomolecules, PABIOS (PArallel BIOmolecular Simulator) Group Representative Hisashi Ishida Japan Atomic Energy Research Institute

More information

MD Thermodynamics. Lecture 12 3/26/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky

MD Thermodynamics. Lecture 12 3/26/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky MD Thermodynamics Lecture 1 3/6/18 1 Molecular dynamics The force depends on positions only (not velocities) Total energy is conserved (micro canonical evolution) Newton s equations of motion (second order

More information

Computational Chemistry - MD Simulations

Computational Chemistry - MD Simulations Computational Chemistry - MD Simulations P. Ojeda-May pedro.ojeda-may@umu.se Department of Chemistry/HPC2N, Umeå University, 901 87, Sweden. May 2, 2017 Table of contents 1 Basics on MD simulations Accelerated

More information

What is Classical Molecular Dynamics?

What is Classical Molecular Dynamics? What is Classical Molecular Dynamics? Simulation of explicit particles (atoms, ions,... ) Particles interact via relatively simple analytical potential functions Newton s equations of motion are integrated

More information

Supporting Information: Improved Parametrization. of Lithium, Sodium, Potassium, and Magnesium ions. for All-Atom Molecular Dynamics Simulations of

Supporting Information: Improved Parametrization. of Lithium, Sodium, Potassium, and Magnesium ions. for All-Atom Molecular Dynamics Simulations of Supporting Information: Improved Parametrization of Lithium, Sodium, Potassium, and Magnesium ions for All-Atom Molecular Dynamics Simulations of Nucleic Acid Systems. Jejoong Yoo and Aleksei Aksimentiev,,

More information

User Guide for LeDock

User Guide for LeDock User Guide for LeDock Hongtao Zhao, PhD Email: htzhao@lephar.com Website: www.lephar.com Copyright 2017 Hongtao Zhao. All rights reserved. Introduction LeDock is flexible small-molecule docking software,

More information

A DFT and ONIOM study of C H hydroxylation catalyzed. by nitrobenzene 1,2-dioxygenase

A DFT and ONIOM study of C H hydroxylation catalyzed. by nitrobenzene 1,2-dioxygenase Electronic Supplementary Material (ESI) for Physical Chemistry Chemical Physics. This journal is the Owner Societies 2014 A DFT and ONIOM study of C H hydroxylation catalyzed by nitrobenzene 1,2-dioxygenase

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

Amino Acids and Proteins at ZnO-water Interfaces in Molecular Dynamics Simulations: Electronic Supplementary Information

Amino Acids and Proteins at ZnO-water Interfaces in Molecular Dynamics Simulations: Electronic Supplementary Information Amino Acids and Proteins at ZnO-water Interfaces in Molecular Dynamics Simulations: Electronic Supplementary Information Grzegorz Nawrocki and Marek Cieplak Institute of Physics, Polish Academy of Sciences,

More information

How is molecular dynamics being used in life sciences? Davide Branduardi

How is molecular dynamics being used in life sciences? Davide Branduardi How is molecular dynamics being used in life sciences? Davide Branduardi davide.branduardi@schrodinger.com Exploring molecular processes with MD Drug discovery and design Protein-protein interactions Protein-DNA

More information

Water models in classical simulations

Water models in classical simulations Water models in classical simulations Maria Fyta Institut für Computerphysik, Universität Stuttgart Stuttgart, Germany Water transparent, odorless, tasteless and ubiquitous really simple: two H atoms attached

More information

Course in Applied Structural Bioinformatics: Amber Tutorial

Course in Applied Structural Bioinformatics: Amber Tutorial Course in Applied Structural Bioinformatics: Amber Tutorial Lars Skjaerven, Yvan Strahm, Kjell Petersen and Ross Walker September 8, 2010 http://www.bccs.uni.no/ http://www.bioinfo.no/ Contents 1 Introduction

More information

Supplementary Information

Supplementary Information Supplementary Information Resveratrol Serves as a Protein-Substrate Interaction Stabilizer in Human SIRT1 Activation Xuben Hou,, David Rooklin, Hao Fang *,,, Yingkai Zhang Department of Medicinal Chemistry

More information

Universal Repulsive Contribution to the. Solvent-Induced Interaction Between Sizable, Curved Hydrophobes: Supporting Information

Universal Repulsive Contribution to the. Solvent-Induced Interaction Between Sizable, Curved Hydrophobes: Supporting Information Universal Repulsive Contribution to the Solvent-Induced Interaction Between Sizable, Curved Hydrophobes: Supporting Information B. Shadrack Jabes, Dusan Bratko, and Alenka Luzar Department of Chemistry,

More information

Towards accurate calculations of Zn 2+ binding free energies in zinc finger proteins

Towards accurate calculations of Zn 2+ binding free energies in zinc finger proteins Towards accurate calculations of Zn 2+ binding free energies in zinc finger proteins UNDERGRADUATE HONORS RESEARCH THESIS Presented in Partial Fulfillment of the Requirements for the Bachelor of Science

More information

Supporting Information

Supporting Information Supporting Information ph-responsive self-assembly of polysaccharide through a rugged energy landscape Brian H. Morrow, Gregory F. Payne, and Jana Shen Department of Pharmaceutical Sciences, School of

More information

Computational Modeling of Protein Kinase A and Comparison with Nuclear Magnetic Resonance Data

Computational Modeling of Protein Kinase A and Comparison with Nuclear Magnetic Resonance Data Computational Modeling of Protein Kinase A and Comparison with Nuclear Magnetic Resonance Data ABSTRACT Keyword Lei Shi 1 Advisor: Gianluigi Veglia 1,2 Department of Chemistry 1, & Biochemistry, Molecular

More information

April, The energy functions include:

April, The energy functions include: REDUX A collection of Python scripts for torsion angle Monte Carlo protein molecular simulations and analysis The program is based on unified residue peptide model and is designed for more efficient exploration

More information

APBS electrostatics in VMD - Software. APBS! >!Examples! >!Visualization! >! Contents

APBS electrostatics in VMD - Software. APBS! >!Examples! >!Visualization! >! Contents Software Search this site Home Announcements An update on mailing lists APBS 1.2.0 released APBS 1.2.1 released APBS 1.3 released New APBS 1.3 Windows Installer PDB2PQR 1.7.1 released PDB2PQR 1.8 released

More information

Overview. For this we will use the Q program ( for carrying out EVB calculations.

Overview. For this we will use the Q program (  for carrying out EVB calculations. EVB Tutorial: S N 2 Reaction in Gas Phase and Solution Overview The objective of this tutorial is to give a glimpse into the main features of the Empirical Valence Bond (EVB) method. We will study a simple

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

Electro-Mechanical Conductance Modulation of a Nanopore Using a Removable Gate

Electro-Mechanical Conductance Modulation of a Nanopore Using a Removable Gate Electro-Mechanical Conductance Modulation of a Nanopore Using a Removable Gate Shidi Zhao a, Laura Restrepo-Pérez b, Misha Soskine c, Giovanni Maglia c, Chirlmin Joo b, Cees Dekker b and Aleksei Aksimentiev

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

Journal of Pharmacology and Experimental Therapy-JPET#172536

Journal of Pharmacology and Experimental Therapy-JPET#172536 A NEW NON-PEPTIDIC INHIBITOR OF THE 14-3-3 DOCKING SITE INDUCES APOPTOTIC CELL DEATH IN CHRONIC MYELOID LEUKEMIA SENSITIVE OR RESISTANT TO IMATINIB Manuela Mancini, Valentina Corradi, Sara Petta, Enza

More information

LysinebasedTrypsinActSite. A computer application for modeling Chymotrypsin

LysinebasedTrypsinActSite. A computer application for modeling Chymotrypsin LysinebasedTrypsinActSite A computer application for modeling Chymotrypsin Version.2 May 2006 LysTAS A computer application for modeling chymotrypsin Version.2 May 2006 Table of Contents Page. Introduction

More information

Molecular Dynamics in practice with GROMACS

Molecular Dynamics in practice with GROMACS Molecular Dynamics in practice with GROMACS GROMACS is one of the wold s fastest software package for molecular dynamics simulations. One can find many helpful materials, manual as well as to download

More information

A Brief Guide to All Atom/Coarse Grain Simulations 1.1

A Brief Guide to All Atom/Coarse Grain Simulations 1.1 A Brief Guide to All Atom/Coarse Grain Simulations 1.1 Contents 1. Introduction 2. AACG simulations 2.1. Capabilities and limitations 2.2. AACG commands 2.3. Visualization and analysis 2.4. AACG simulation

More information

Molecular Dynamics. A very brief introduction

Molecular Dynamics. A very brief introduction Molecular Dynamics A very brief introduction Sander Pronk Dept. of Theoretical Physics KTH Royal Institute of Technology & Science For Life Laboratory Stockholm, Sweden Why computer simulations? Two primary

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

Molecular Dynamics Simulation of Methanol-Water Mixture

Molecular Dynamics Simulation of Methanol-Water Mixture Molecular Dynamics Simulation of Methanol-Water Mixture Palazzo Mancini, Mara Cantoni University of Urbino Carlo Bo Abstract In this study some properties of the methanol-water mixture such as diffusivity,

More information

Supporting Material for. Microscopic origin of gating current fluctuations in a potassium channel voltage sensor

Supporting Material for. Microscopic origin of gating current fluctuations in a potassium channel voltage sensor Supporting Material for Microscopic origin of gating current fluctuations in a potassium channel voltage sensor J. Alfredo Freites, * Eric V. Schow, * Stephen H. White, and Douglas J. Tobias * * Department

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

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

Choosing weights for simulated tempering

Choosing weights for simulated tempering PHYSICAL REVIEW E 7, 173 7 Choosing weights for simulated tempering Sanghyun Park 1 and Vijay S. Pande 1, 1 Department of Chemistry, Stanford University, Stanford, California 935, USA Department of Structural

More information

Supplementary Information Intrinsic Localized Modes in Proteins

Supplementary Information Intrinsic Localized Modes in Proteins Supplementary Information Intrinsic Localized Modes in Proteins Adrien Nicolaï 1,, Patrice Delarue and Patrick Senet, 1 Department of Physics, Applied Physics and Astronomy, Rensselaer Polytechnic Institute,

More information

Lecture 12: Solvation Models: Molecular Mechanics Modeling of Hydration Effects

Lecture 12: Solvation Models: Molecular Mechanics Modeling of Hydration Effects Statistical Thermodynamics Lecture 12: Solvation Models: Molecular Mechanics Modeling of Hydration Effects Dr. Ronald M. Levy ronlevy@temple.edu Bare Molecular Mechanics Atomistic Force Fields: torsion

More information

ONETEP PB/SA: Application to G-Quadruplex DNA Stability. Danny Cole

ONETEP PB/SA: Application to G-Quadruplex DNA Stability. Danny Cole ONETEP PB/SA: Application to G-Quadruplex DNA Stability Danny Cole Introduction Historical overview of structure and free energy calculation of complex molecules using molecular mechanics and continuum

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

Supporting Information

Supporting Information pk a values of titrable amino acids at the water/membrane interface Vitor H. Teixeira, Diogo Vila-Viçosa, Pedro B. P. S. Reis, and Miguel Machuqueiro Centro de Química e Bioquímica, Departamento de Química

More information

Oxygen Binding in Hemocyanin

Oxygen Binding in Hemocyanin Supporting Information for Quantum Mechanics/Molecular Mechanics Study of Oxygen Binding in Hemocyanin Toru Saito and Walter Thiel* Max-Planck-Institut für Kohlenforschung, Kaiser-Wilhelm-Platz 1, D-45470

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

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

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

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

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

Atomistic Modeling of Small-Angle Scattering Data Using SASSIE-web

Atomistic Modeling of Small-Angle Scattering Data Using SASSIE-web Course Introduction Atomistic Modeling of Small-Angle Scattering Data Using SASSIE-web September 21-23, 2016 Advanced Photon Source Argonne National Laboratory, Argonne, IL ccpsas.org Scatters & Simulators

More information

Research Article Conformational Search on the Lewis X Structure by Molecular Dynamic: Study of Tri- and Pentasaccharide

Research Article Conformational Search on the Lewis X Structure by Molecular Dynamic: Study of Tri- and Pentasaccharide Hindawi Publishing Corporation International Journal of Carbohydrate Chemistry Volume 212, Article ID 725271, 7 pages doi:1.1155/212/725271 Research Article Conformational Search on the Lewis X Structure

More information

Computer simulations of protein folding and energetics in hydrogen bonding

Computer simulations of protein folding and energetics in hydrogen bonding UPTEC X 04 041 ISSN 1401-2138 OCT 2004 PER LARSSON Computer simulations of protein folding and energetics in hydrogen bonding Master s degree project Molecular Biotechnology Programme Uppsala University

More information

Supporting Information

Supporting Information Supporting Information A Streptavidin Binding Site Mutation Yields an Unexpected Result: An Ionized Asp128 Residue is Not Essential for Strong Biotin Binding. Loren Baugh, Isolde Le Trong, Patrick S. Stayton,

More information

Developing Monovalent Ion Parameters for the Optimal Point Charge (OPC) Water Model. John Dood Hope College

Developing Monovalent Ion Parameters for the Optimal Point Charge (OPC) Water Model. John Dood Hope College Developing Monovalent Ion Parameters for the Optimal Point Charge (OPC) Water Model John Dood Hope College What are MD simulations? Model and predict the structure and dynamics of large macromolecules.

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 modeling with InsightII

Molecular modeling with InsightII Molecular modeling with InsightII Yuk Sham Computational Biology/Biochemistry Consultant Phone: (612) 624 7427 (Walter Library) Phone: (612) 624 0783 (VWL) Email: shamy@msi.umn.edu How to run InsightII

More information

Assignment 2 Atomic-Level Molecular Modeling

Assignment 2 Atomic-Level Molecular Modeling Assignment 2 Atomic-Level Molecular Modeling CS/BIOE/CME/BIOPHYS/BIOMEDIN 279 Due: November 3, 2016 at 3:00 PM The goal of this assignment is to understand the biological and computational aspects of macromolecular

More information

Molecular dynamics (MD) simulations are widely used in the

Molecular dynamics (MD) simulations are widely used in the Comparative study of generalized Born models: Protein dynamics Hao Fan*, Alan E. Mark*, Jiang Zhu, and Barry Honig *Groningen Biomolecular Sciences and Biotechnology Institute, Department of Biophysical

More information

PROTEIN-PROTEIN DOCKING REFINEMENT USING RESTRAINT MOLECULAR DYNAMICS SIMULATIONS

PROTEIN-PROTEIN DOCKING REFINEMENT USING RESTRAINT MOLECULAR DYNAMICS SIMULATIONS TASKQUARTERLYvol.20,No4,2016,pp.353 360 PROTEIN-PROTEIN DOCKING REFINEMENT USING RESTRAINT MOLECULAR DYNAMICS SIMULATIONS MARTIN ZACHARIAS Physics Department T38, Technical University of Munich James-Franck-Str.

More information

Examples of Protein Modeling. Protein Modeling. Primary Structure. Protein Structure Description. Protein Sequence Sources. Importing Sequences to MOE

Examples of Protein Modeling. Protein Modeling. Primary Structure. Protein Structure Description. Protein Sequence Sources. Importing Sequences to MOE Examples of Protein Modeling Protein Modeling Visualization Examination of an experimental structure to gain insight about a research question Dynamics To examine the dynamics of protein structures To

More information

Unit Cell-Level Thickness Control of Single-Crystalline Zinc Oxide Nanosheets Enabled by Electrical Double Layer Confinement

Unit Cell-Level Thickness Control of Single-Crystalline Zinc Oxide Nanosheets Enabled by Electrical Double Layer Confinement Unit Cell-Level Thickness Control of Single-Crystalline Zinc Oxide Nanosheets Enabled by Electrical Double Layer Confinement Xin Yin, Yeqi Shi, Yanbing Wei, Yongho Joo, Padma Gopalan, Izabela Szlufarska,

More information

ProteinMolecularDynamicsWithElectrostaticForce EntirelyDeterminedbyaSinglePoisson-Boltzmann Calculation

ProteinMolecularDynamicsWithElectrostaticForce EntirelyDeterminedbyaSinglePoisson-Boltzmann Calculation PROTEINS: Structure, Function, and Genetics 48:497 504 (2002) ProteinMolecularDynamicsWithElectrostaticForce EntirelyDeterminedbyaSinglePoisson-Boltzmann Calculation BenZhuoLu, 1,2 WeiZuChen, 2 CunXinWang,

More information

Enhancing Amber for Use on the Blue Waters High- Performance Computing Resource

Enhancing Amber for Use on the Blue Waters High- Performance Computing Resource Enhancing Amber for Use on the Blue Waters High- Performance Computing Resource Daniel R. Roe a, Jason M. Swails b, Romelia Salomon-Ferrer c, Adrian E. Roitberg b, and Thomas E. Cheatham III a * a. Department

More information

Viewing and Analyzing Proteins, Ligands and their Complexes 2

Viewing and Analyzing Proteins, Ligands and their Complexes 2 2 Viewing and Analyzing Proteins, Ligands and their Complexes 2 Overview Viewing the accessible surface Analyzing the properties of proteins containing thousands of atoms is best accomplished by representing

More information