Course in Applied Structural Bioinformatics: Amber Tutorial

Size: px
Start display at page:

Download "Course in Applied Structural Bioinformatics: Amber Tutorial"

Transcription

1 Course in Applied Structural Bioinformatics: Amber Tutorial Lars Skjaerven, Yvan Strahm, Kjell Petersen and Ross Walker September 8,

2 Contents 1 Introduction General preparation Building our HNE system Obtain and parse the PDB file Protonate the protein Add crystal waters, disulfide bonds, and solvate the system Visualize the solvated system MD Simulation Relaxing the system prior to MD Running sander for the first time Creating PDB files from the AMBER coordinate files Heating and equilibration Analyzing the results to test the equilibration Analyzing the output files Analyzing the trajectory Viewing the trajectory Re-imaging the trajectory back into the primary box Production Phase Analyzing the trajectory Re-image the trajectory back into the primary box RMSd Fluctuations Distances Structural waters

3 1 Introduction The purpose of this tutorial is to provide an initial introduction to setting up and running simulations using the AMBER software (It is based on AMBER 10 and AmberTools 1.2 but should work reasonably well with AMBER 9 and with newer versions of the AMBER software as they are released). In this tutorial we run a series of simulations of HNE. We will first figure out how to generate a starting structure and then use this structure to construct the necessary input files for running sander, the main molecular dynamics engine supplied with AMBER 10. In order to run a classical molecular dynamics simulation with Sander a number of files are required. These are (using their default filenames): prmtop a file containing a description of the molecular topology and the necessary force field parameters. inpcrd (or a restrt from a previous run) a file containing a description of the atom coordinates and optionally velocities and current periodic box dimensions. mdin the sander input file consisting of a series of namelists and control variables that determine the options and type of simulation to be run. The approximate order of this tutorial will be as follows: Create the prmtop and inpcrd files: This is a description of how to generate the initial structure and set up the molecular topology/parameter and coordinate files necessary for performing minimisation or dynamics with sander. Minimisation and molecular dynamics in explicit solvent: Setting up and running equilibration and production simulations for our HNE model using TIP3P explicit water. 1.1 General preparation Before we run any of the programs provided with AMBER, we need to make sure the Unix shell environment variable that specifies where AMBER is installed is set properly. If you are running bash, csh or tcsh check the AMBERHOME environment variable is set by typing: echo $AMBERHOME If you see: AMBERHOME: Undefined variable. (csh or tcsh) 1

4 or simply a blank line (bash) then the AMBERHOME environment variable was not set properly and you need to initialize it to point to the AMBER installation directory. If AMBER is installed in /usr/local/amber10 then you would type: export AMBERHOME=/usr/local/amber10 (bash) While you are at it, you may want to update your.cshrc (csh), or.bashrc (bash) file to define this variable and add the AMBER binary directory to your path (or list of directories searched for executables) at login. In your.bash login file (or the global /etc/bashrc file) (if using the bash shell), add the following (substituting the correct path to AMBER): export AMBERHOME=/usr/local/amber10 export PATH=\$PATH:\$AMBERHOME/exe 2 Building our HNE system The first stage of this tutorial is to create the necessary input files required by sander for performing minimization and molecular dynamics. There are a number of methods for creating these input files. In this example we will use a program written specifically for this purpose: LEaP. This is a program that reads in force field, topology and coordinate information and produces the files necessary for production calculations (i.e. minimization, molecular dynamics, analysis,...). There are two versions of this program provided with AMBER 10 & AmberTools 1.2. A graphical version called xleap and a terminal interface called tleap. (There are also completely new versions being produced called gleap and sleap respectively that will ultimately replace xleap and tleap but discussion of this is beyond the scope of this tutorial.) The first step in any modeling project is developing the initial model structure. Although in principle, one could use xleap to build a model structure by hand this is only practical for the smallest of systems. The difficulty in both manipulating and predicting the structure of large biomolecular systems means that building a structure by hand is not usually a sensible undertaking. Instead, experimentally determined structures are used. These can be found by searching through databases of crystal or NMR structures such as the Protein Data Bank or the Cambridge Structural Database. With nucleic acids, users can also search the Nucleic Acid Database. In order to perform an MD simulation of HNE, we first need to fetch the PDB file, check the contents of it, parse it, and subsequently build the necesarry Amber files. Understanding the contents of the PDB file is crucial in order to perform a sucessful MD simulation. 2

5 2.1 Obtain and parse the PDB file The HNE structure we are interested in has PDB ID 2z7f. It is crystalized with an inhibitor protein and two covalently bound ligands (NAG and FUC). Moreover, several residues has alternative configuration, denoted A and B along with the residue number in the PDB file. The PDB file also contains several water molecules which might be of structural importance. Finally, we need to investigate the protonation of the residues and identify disulfide bonds in the structure. We wish to perform the simulation without the inhibitor protein, and without the two ligands. We thus have to extract this from the original PDB file. You can do this with several programs, like PyMOL or VMD. Alternatively, the linux command grep will also do the job: grep "ATOM " 2Z7F.pdb egrep -v " I " > 2z7f_chainE.pdb grep "HOH " 2Z7F.pdb egrep -v " I " > 2z7f_chainE_XWAT.pdb 2.2 Protonate the protein These commands produces two new PDB files called 2z7f chaine.pdb (protein only) and 2z7f chaine XWAT.pdb (crystal waters). Secondly, we ll have to add hydrogen atoms to our system. The PDB2PQR webserver can do this for us. Adding hydrogens to amino acids are in most cases trivial for ph 7.0. However, histidines have a pka right around this range and can have either their delta nitrogen or epsilon nitrogen protonated, or they can both be protonated, yielding an amino acid with a +1 charge. This webserver will optimize the hydrogen bonding network within the protein to determine where the hydrogens should go in the optimal case. Go to the pdb2pqr site, and submit the structure. Use the AMBER naming scheme, and ensure that you have checked on these settings: (1) Ensure that new atoms are not rebuilt too close to existing atoms, and (2) Optimize the hydrogen bonding network. Start the job, and await your results. Retrieve the newly generated PQR file and save it in your HNE MD folder. Open this file in a text editor, or by the command less 2z7f_chainE.pqr The histidines are now called HID, HIE, or HIP, in order specify wether they have a hydrogen at the delta or epsilon nitrogen, or both (charged). Results: 2z7f.pqr 2.3 Add crystal waters, disulfide bonds, and solvate the system In the next step we will use Amber in order to finalize our system in order to run the MD simulation. The first step is the building of residues. Many proteins contain coenzymes 3

6 as well as standard amino acids. These coenzymes are not normally pre-defined in the AMBER database and so are considered to be non-standard residues. It is necessary to provide structural information and force field parameters for all of the non-standard residues that will be present in your simulation before you can create the sander input files. Fortunately, if you are using standard nucleic acid or amino acid residues, as we will be in this tutorial, this step is not necessary since all of the residues are pre-built in the AMBER database. Later tutorials will cover what to do if you have non-standard residues. For this, we will use the Amber program called Leap (there exists two versions: tleap and sleap). Leap takes as input a set of commands which dictates how you want to build your system. We can gather these commands in a file which we will call build. We will use sleap, which is newer and create disulfide bridges automatically. Open a text editor and type in the following: # Load the forcefield > source leaprc.ff99sb # Set settings for this Leap session > set default disulfide auto # load the protein prot = loadpdb 2z7f_E.pqr # load the crystal waters xwat = loadpdb 2z7f_chainE_XWAT.pdb # combine the protein and waters complex = combine {prot xwat} # save amber topology and coordinate files saveamberparm prot HNE_noWAT.prmtop HNE_noWAT.inpcrd # solvate the protein solvateoct complex TIP3PBOX # save solvated complex saveamberparm complex HNE_sol.prmtop HNE_sol.incprd # save a pdb of the built system savepdb complex complex.pdb 4

7 Download the leap input file here. The first lines loads the forcefield we will use. The next command specifies that we want to build the disulfide bonds automatically. Then we load the protein structure, and the crystal waters into leap, and combine these two. saveamberparm will generate the parameter and topology (.prmtop) and the coordinate file (.inpcrd). These files are not needed to run the MD simulation, but they will come in handy in the subsequent analysis of the MD simulations. solvateoct is the command to solvate our protein in an truncated octahedron. We ll use the TIP3 water model, and we want at least 12 Å of water between our protein surface and the edge of the water box. The last term specifies that no water molecules should come closer to the solute than 0.78 Å. Finally, we build the parameter, topology, and coordinate files for the solvated system in which we will use for the MD simulation. Run Leap with the command: sleap -f build_hne then exit This creates the following files: HNE sol.prmtop HNE sol.inpcrd To remind you about these files: prmtop The parameter/topology file. This defines the connectivity and parameters for our current model. This information is static, or in other words, it doesn t change during the simulation. The prmtop we created above is called HNE sol.prmtop inpcrd The coordinates (and optionally box coordinates and velocities). This is data is not static and changes during the simulations (although the file is unaltered). Above we created an initial set of coordinates called HNE sol.inpcrd. 2.4 Visualize the solvated system To open the structure in VMD type the following command: vmd HNE_sol.prmtop When the three windows of VMD opens, left click on the HNE sol.prmtop name in the VMD Main window. When the name turns yellow, right click it, Load data into molecule. Browse to find HNE sol.inpcrd. Select Amber7 Restart in the Determine file type box. Investigate the structure and observe e.g. the disulfide bonds in the residues named CYX. 5

8 3 MD Simulation This section will introduce sander and show how it can be used for minimization and molecular dynamics of our previously created HNE model. This section of the tutorial will consist of 3 stages: Relaxing the system prior to MD Heating and equilibration MD run for 5 ns 6

9 Analyzing the results 3.1 Relaxing the system prior to MD Prior to the MD simulation we need to relax the system by performing a energy minimization as our current geometry may not correspond to the actual minima in the force field we are using and may also result in conflicts and overlaps with atoms in other residues. It is always a good idea to minimize the structure before commencing molecular dynamics. Failure to successfully minimize the structure may lead to instabilities when we run MD. So, given the in vacuo prmtop (HNE sol.prmtop) and inpcrd (HNE sol.inpcrd) files we created, we will now use sander to conduct a short minimization run. This will take us towards the closest local minima. Minimization with sander will only ever take you to the nearest minima, it cannot cross transition states to reach lower minima. This is fine for our purposes, however, since all we want to do is remove the largest strains in the system. The basic usage for sander is as follows: 7

10 sander [-O] -i mdin -o mdout -p prmtop -c inpcrd -r restrt [-ref refc] [-x mdcrd] [-v mdvel] [-e mden] [-inf mdinfo] Arguments in [] s are optional. If an argument is not specified, the default name will be used. -O overwrite all output files (the default behavior is to quit if any output files already exist) -i the name of the input file (which describes the simulation options), mdin by default. -o the name of the output file, mdout by default. -p the parameter/topology file, prmtop by default. -c the set of initial coordinates for this run, inpcrd by default. -r the final set of coordinates from this MD or minimization run, restrt by default. -ref reference coordinates for positional restraints, if this option is specified in the input file, refc by default. -x the molecular dynamics trajectory file (if running MD), mdcrd by default. -v the molecular dynamics velocities file (if running MD), mdvel by default. -e a summary file of the energies (if running MD), mden by default. -inf a summary file written every time energy information is printed in the output file for the current step of the minimization of MD, useful for checking on the progress of a simulation, mdinfo by default. We will do our minimization in two steps. The first step involves the relaxation of the water molecules only. In this part, we will hold the protein fixed by adding a restraint to the protein residues (1-218). Such restraints work by specifying a reference structure, in this case our starting structure, and then restraining the selected atoms to conform to this structure via the use of a harmonic potential. This can be visualized as attaching a spring to each of the solute atoms that connects it to its initial position. Moving the atom from this position results in a force which acts to restore it to the initial position. By varying the magnitude of the force constant so the effect can be increased or decreased. This can be especially useful with structures based on homology models which may be a long way from equilibrium and so require a number of stages of minimization / MD with the force constant being reduced each time. The second step involves the minimization of the whole system. In order to perform the energy minimization we need to build a so-called MD input file (mdin). This file specifies the myriad of possible options for this run. An example is given below, which is the one we will use for our system. 8

11 minimization of waters &cntrl imin = 1, # perform energy minimization maxcyc=5000, # 5000 steps in total ncyc=3000,# 3000 of these are steepest descent ntb=1, # Constant volume cut=10, # Non-bonded cut-off ntpr=5,# Write energy information every 5th step ntr=1, restraintmask= :1-218, restraint_wt=2.0, / minimization of the whole system &cntrl imin = 1, maxcyc=10000, ncyc=7000, ntb=1, ntr=1, cut=10, ntpr=5, / Download the mdin files: min sol.in min all.in Running sander for the first time You can run the minimization with the commands below. This will start sander and the minimization jobs specified in the input files (assuming a multi core CPU): mpirun -np 2 sander.mpi -O -i min_sol.in -o min_sol.out -p HNE_sol.prmtop -c HNE_sol.incprd -r min_sol.rst -ref HNE_sol.incprd mpirun -np 2 sander.mpi -O -i min_all.in -o min_all.out -p HNE_sol.prmtop -c min_sol.rst -r min_all.rst Download the results here: min sol.out min sol.rst min all.out min all.rst 9

12 Take a look at the output file produced during the minimization (min all.out). You will see that the energy dropped considerably between the first and last steps: NSTEP ENERGY RMS GMAX NAME NUMBER E E E+06 O NSTEP ENERGY RMS GMAX NAME NUMBER E E E+00 OD1 670 In spite of this, however, the structure did not change very much. This is because, as already mentioned, minimization will only find the nearest local minima. If you create PDB files for the start (HNE sol.inpcrd) and final structures (min all.rst) and compare the root-mean-squared deviations (RMSd), you will see that the two structures differ by only about 0.4 Å (all atom) Creating PDB files from the AMBER coordinate files You may want to generate a new pdb file so you can look at the structure using the minimized coordinates from min all.rst. A pdb file can be created from the parm topology and coordinates (inpcrd or restrt) using the program ambpdb. ambpdb -p HNE_sol.prmtop < min_all.rst > min_all.pdb This will take the prmtop and inpcrd file specified (in this case the final structure from the minimization, the.rst file) and create (on stdout) a pdb file. In this case we redirected stdout to the file min all.pdb. In general, users should carefully inspect any starting structures and minimized structures; specifically check to make sure the hydrogens were placed where you thought they 10

13 should be, histidines are in the correct protonation state, the terminal residues are properly terminated, stereochemistry is reasonable, etc. There is nothing worse than finding out after you ve run the simulation that something was wrong. 3.2 Heating and equilibration Now that we have successfully minimized our system the next stage in our equilibration protocol is allow Our final aim is to run production dynamics at constant temperature and pressure since this more closely resembles laboratory conditions. However, at low temperatures, as our system will be for the first few ps the calculation of pressure is very inaccurate and so using constant pressure periodic boundaries in this situation can lead to problems. Using constant pressure with restraints can also cause problems so initially we will run 20 ps of MD at constant volume. Once our system has equilibrated over approximately 20 ps we will then switch off the restraints and change to constant pressure before running a further 100 ps of equilibration at 300 K. To this system we then added a truncated octahedral box of pre-equilibrated TIP3P water. This water has not felt the influence of the solute or charges and moreover there may be gaps between the solvent and solute and solvent and box edges. If we are not careful such holes can lead to vacuum bubbles forming and subsequently an instability in our molecular dynamics simulation. Thus we need to run careful minimization before slowly heating our system to 300 K. It is also a good idea to allow the water box to relax during a MD equilibration stage prior to running production MD. In this phase it is a good idea, since we will be using periodic boundaries, to keep the pressure constant and so allow the volume of the box to change. This approach will allow the water to equilibrate around the solute and come to an equilibrium density. It is essential that we monitor this equilibrium phase in order to be certain our solvated system has reached equilibrium before we start obtaining results (production data) from our MD simulation. In this section will be presented one possible path towards equilibrating the solvated HNE structure such that it is ready for use in production MD. For this we will use periodic boundary simulations based on the particle mesh Ewald (PME) method. After equilibration has been demonstrated and deemed to have been successful, we will set up a production MD run. Please note, there are many differing opinions on how one should equilibrate a simulation, herein is presented only one, based on my experience with performing molecular dynamics simulations on biological systems. Note: some of the calculations, particularly the equilibration phase, may take a very long time (several days) to run unless you have access to a computer cluster for parallel simulation. For the purposes of this simulation I will provide copies of all of the input files along with example output files run on four 1.3GHz CPUs of a SGI Altix. I will make it clear where the simulations are likely to take a long time such that you can just use the provided output files. 11

14 The second step in the MD simulation is the heating of the system from 0K to 300K. During this step we need constant volume since pressure calculation is inaccurate at low temperatures. We also want to keep our protein restrained to avoid wild fluctuations during this process. Heating of protein from 0K to 300K with weak restraints &cntrl imin = 0, # no energy minimization irest = 0, # no restart ntx = 1,# no initial velocities will be read ig = -1, # random initial velocities nstlim = 25000, # run for 0.05 ns dt = 0.002, # step length (fs) ntc = 2,# bonds involving H are constrained ntf = 2, cut = 8.0, ntb = 1, ntpr = 500, ntwx = 500,# write the structure every 500th step ntt = 3, # Langevin temperature control gamma_ln = 2.0, tempi = 0.0, # initial temperature temp0 = 300.0,# reference temperature ntr = 1, # Cartesian restraints on residue restraintmask = :1-218, restraint_wt = 2.0, # restraint weight nmropt = 1,# flag for restraints set below ioutfm = 1,# netcdf trajectory / &wt TYPE= TEMP0, istep1=0, istep2=25000, value1=0.1, value2=300.0, / &wt TYPE= END / Equlibrate the density &cntrl imin=0, irest=1, # restart the simulation from last run ntx=5, nstlim=25000, dt=0.002, ntc=2,ntf=2, cut=8.0, ntb=2, 12

15 ntp=1, taup=1.0,# constant pressure ntpr=500, ntwx=500, ntt=3, gamma_ln=2.0, temp0=300.0, ntr=1, restraintmask= :1-218, restraint_wt=2.0, ioutfm = 1, / Equilibrate &cntrl imin = 0, irest = 1,ntx = 5, nstlim = , dt = 0.002, ntc = 2, ntf = 2, cut = 10.0, ntb = 2, ntp = 1, taup=2.0, ntpr = 1000, ntwx = 1000, ntt = 3, gamma_ln = 2.0, temp0 = 300.0, ntr = 1, restraintmask = :1-218, restraint_wt = 0.5, ioutfm = 1, / Download the mdin files: heat.in density.in equil.in Start the simulations with: mpirun -np 2 sander.mpi -O -i heat.in -o heat.out -p HNE_sol.prmtop -c min_all.rst -r heat.rst -x heat.nc -ref min_all.rst mpirun -np 2 sander.mpi -O -i density.in -o density.out -p HNE_sol.prmtop -c heat.rst -r density.rst -x density.nc -ref min_all.rst mpirun -np 2 sander.mpi -O -i equil.in -o equil.out -p HNE_sol.prmtop -c density.rst -r equil.rst -x equil.nc -ref min_all.rst Download the results: equilibration.tar.gz Unpack them with the command tar xzvf equilibration.tar.gz 13

16 3.3 Analyzing the results to test the equilibration Now that we have equilibrated our system it is essential that we check that equilibrium has successfully been achieved before moving on to running any production MD simulations in which we would hope to learn something new about our molecule. There are a number of system properties that we should monitor to check the quality of our equilibrium. These include: Potential, Kinetic and Total energy Temperature Pressure Volume Density RMSd The following steps will illustrate how to extract this data and plot it and also discuss what we expect to see for a successful equilibration Analyzing the output files In this section we will look at the system properties that can be extracted from the data written to the mdout files during our 120ps of MD simulation (md2.out). This includes the potential, kinetic and total energies, the temperature, pressure, volume and density. Lets start by extracting the various properties from our two output files. For this we will use the process mdout Perl script that was introduced earlier. This script can be given any number of files to process and it will append the results to single summary files: We ll use a perl script for this analysis. Download it here. mkdir analysis cd analysis perl../process_mdout.perl../heat.out../density.out../equil.out This should give us a series of summary files in our analysis directory (summary output files here). Lets plot some of these to see if we have successfully reached an equilibrium. First of all the energies, potential, kinetic and total (= potential + kinetic): xmgrace summary.eptot summary.ektot summary.etot 14

17 Here the red line, which is positive, is our kinetic energy, the black line is the potential energy (negative) and the green line is our total energy. The important points to note with this plot is that all of the energies increased during the first few ps, corresponding to our heating from 0 K to 300 K. The kinetic energy then remained constant for the remainder of the simulation implying that our temperature thermostat, which acts on the kinetic energy, was working correctly. The potential energy, and consequently the total energy since total energy = potential energy + kinetic energy, initially increased and then plateaued during the constant volume stage (0 to 20 ps) before decreasing as our system relaxed when we switched off the DNA restraints and moved to constant pressure (20 to 40 ps). The potential energy then leveled off and remained constant for the remainder of our simulation (40 to 120 ps) indicating that the relaxation was completed and that we reached an equilibrium. Next we plot the temperature: xmgrace summary.temp Here we see the expected behavior, our system temperature started at 0 K and then increased to 300 K over a period of about 5 ps. The temperature then remained more or less constant for the remainder of the simulation indicating the use of Langevin dynamics for temperature regulation was successful. Next the pressure: xmgrace summary.pres The pressure plot is slightly different than the previous plots. For the first 20 ps the pressure is zero. This is to be expected since we were running a constant volume simulation 15

18 in which the pressure wasn t evaluated. At 20 ps we switched to constant pressure, allowing the volume of our box to change, at which point the pressure drops sharply becoming negative. The negative pressures correspond to a force acting to decrease the box size and the positive pressures to a force acting to increase the box size. The important point here is that while the pressure graph seems to show that the pressure fluctuated wildly during the simulation the mean pressure stabilized around 1 atm after about 50 ps of simulation. This is sufficient to indicate successful equilibration. Next we will consider the volume. Unfortunately we cannot simply plot the summary.volume file since the first 20 ps do not contain any volume information since 16

19 during constant volume simulations the volume of the box is not written to the output file. So, we need to remove the first 101 lines of the file. You can use your favorite text editor to do this - I like vi: xmgrace summary.volume Notice how the volume of our system (in angstroms3) initially decreases as our water box relaxes and reaches and equilibrated density, and thus volume. The smooth transitions in this plot followed by the oscillations about a mean value suggest our equilibration has been successful. Finally, lets take a look at the density, we expect this to mirror the volume. We have the same problem with this summary file as we did with the volume since the density is not written to the output during constant volume simulations. xmgrace summary.volume This is as expected. Our system has equilibrated at a density of approximately 1.04 g cm-3. This seems reasonable. The density of pure liquid water at 300 K is approximately 1.00 g cm-3 so adding a 10-mer of DNA and the associated charges has increased the density by around 4 % Analyzing the trajectory Now we have analyzed our output files and seen that the main system properties suggest that our equilibration has been successful the next step is to consider the structures. Have 17

20 they remained reasonable? One useful measure to consider is the root mean square deviation (RMSd) from the starting structure. We can use ptraj to calculate this for us as a function of time. In this situation we are interested in the backbone of our HNE protein so we shall consider just the main backbone atoms, N, CA, C. We will conduct a standard (not mass weighted) RMS fit to the first structure of our MD (the final structure from the minimization). Note, the time is set to 0.2 this time around since although we wrote to the trajectory file every 100 steps the time step was 2 fs - hence 100 steps = 0.2 ps. Here is the input file for ptraj: trajin heat.mdcrd trajin density.mdcrd trajin equil.nc rms first out time 0.2 Download this ptraj input file: initial rmsd.ptraj Run ptraj to calculate the RMSd: ptraj../hne_sol.prmtop initial_rmsd.ptraj xmgrace HNE_equilibration_rms.dat Viewing the trajectory Next we can take a look at the trajectory using VMD. First of all we will do this without re-imaging back to the primary box. We will then use ptraj to re-image our trajectory and then look at it again. So, first of all lets load both trajectory files into vmd: 18

21 It appears like the water box is breaking down and the waters are boiling off into space. This would indeed be true if we were not using periodic boundaries. However, as mentioned above the atom coordinates written to the trajectory files are those of the original atom, even if it migrates outside of the original box and is replaced by one of its images. We can fix this by re-imaging our trajectory as we will now do Re-imaging the trajectory back into the primary box Lets use ptraj to re-image our trajectory files so that only the atoms in the primary box are shown. Here is the ptraj input file: trajin trajin trajin center heat.mdcrd density.mdcrd equil.nc :

22 image familiar rms trajout equilibration_reimaged.nc netcdf Download this ptraj input file: reimage.ptraj Run ptraj to perform the re-imaging: ptraj../hne_sol.prmtop reimage.ptraj... and visulaize the trajectory again. 3.4 Production Phase After equilibrating the system we are ready to remove the artificial constraints, and let the system move freely in the water box. This is commonly the phase in which you perform the analysis of the MD simulation. Besides from removing the restraints we will also remove the temperature control (ntt=0). In order to do so we should lower the SHAKE tolerance ( ) and increase the accuracy of the PME by reducing DSUM TOL by an order of magnitude ( ). A time step of 1 fs is also needed in order to avoid a large drift in temperature. Moreover, we will run 5 ns at a time ( steps), and save coordinates to the trajectory file every 1000 step. Our mdin file thus looks like this: MD simulation NVE &cntrl imin= 0, irest= 1, ntx = 5, ntb = 1, cut = 10, ntc = 2, ntf = 2, tol = , ntt = 0, nstlim = , dt = 0.001, ntpr = 1000, ntwx = 1000, ntwr = 10000, ioutfm = 1, &ewald dsum_tol = , / Download the mdin file: prod nve.in In order to obtain 10 ns of simulation we need to do this twice. The first time we continue our simulation of the equil.rst file, and the second time we continue from the prod1.rst file. Start the simulations with the following commands: 20

23 mpirun -np 2 pmemd.mpi -O -i prod_nve.in -o prod1.out -p HNE_sol.prmtop -c equil.rst -r prod1.rst -x prod1.nc mpirun -np 2 pmemd.mpi -O -i prod_nve.in -o prod1.out -p HNE_sol.prmtop -c prod1.rst -r prod2.rst -x prod2.nc This takes about 50 hrs on 32 CPUs, so it s gonna take some more time on your local desktop computer. Thus, feel free to download the results, and unpack it: production.tar.gz tar xzvf production.tar.gz As you may notice the files called prod1.nc and prod2.nc are quite big. They contain frames, or coordinates, of the atoms in our system. These frames constitute the trajectory of the MD simulation in which we will base our subsequent analysis on. 3.5 Analyzing the trajectory Similar to the equilibration phase we should now plot the energies and particular temperature as a function of time. This will involve the same process as described above, and thus we will not repeat it here. We will rather spend some time on performing simple analysis on the MD trajectory. Calculating the RMSD and RMSF is perhaps the two most common analysis applied to MD simulations. We ll demonstrate the use of these in the next sections Re-image the trajectory back into the primary box However, we first have to perform a simple re-imaging in order to put all our atoms into the primary box (recall from the equilibration phase that the waters, and the solute, will diffuse from the primary box). By doing so, we will be able to study the waters interacting with the solute. Moreover, we told sander (or pmemd.mpi) to save frames. To speed up our analysis, we will only process 1/10th of these. Let s use ptraj to read in the trajectory files (prod1.nc and prod2.nc), re-image, superpose all frames onto the first frame, and save a new trajectory. By performing the RMS fit we will avoid seeing rotational and translational motion of the protein. Our ptraj input file will look like this: trajin../prod1.nc trajin../prod2.nc center :1-218 image familiar rms trajout prod_10ns.nc netcdf 21

24 You can download it from here: short prod.ptraj And start it with the following command: ptraj HNE_sol.prmtop short_prod.ptraj This will create our new trajectory file which is shorter (1000 frames) and where the the atoms are placed in the primary box. Open the trajectory in VMD and take a look a the results: vmd../hne_sol.prmtop prod_10ns.nc RMSd Calculating the RMSd for each frame gives us means to interpret the stability of our simulation. Use ptraj to calculate it: trajin prod_10ns.nc rms first mass out Run it: ptraj HNE_sol.prmtop prod_rmsd.ptraj And plot the resulting values in xmgrace: xmgrace prod_rmsd.out As we can see by the plot the RMSd values seems stable around a little less than 1 Å. 3.6 Fluctuations In the previous section we calculated the RMSd values along the simulation time and thus got an impression of the stability of our 10 ns simulation. By calculating the RMSf (or beta factors) will give us information about individual residue fluctuations. For kicks we ll compare our computed beta factors with the experimental beta factors. Ptraj will compute the bfactors for us: trajin prod_10ns.nc rms first atomicfluct out fluctuations.out :1-218@N,CA,C bfactor byres Run it: 22

25 ptraj HNE_sol.prmtop prod_fluct.ptraj This will calculate the beta factors from our MD simulation. In order to compare this to the experimental values, we have to extract the values from the PDB file. You can download this from here: betafact.dat Now we are ready to plot the values with xmgrace: xmgrace fluctuations.out betafact.dat 3.7 Distances In MD simulations you can follow individual particle motions and measure the interaction with other particles. The following script provides an example on how to measure distances between atoms during the simulation: trajin prod_10ns.nc distance d1 out dist1.out distance d2 out dist2.out distance d3 out dist3.out Run it: ptraj HNE_sol.prmtop dists.ptraj 23

26 xmgrace dist1.out xmgrace dist2.out xmgrace dist3.out 3.8 Structural waters Finally we will investigate the interaction between individual water molecules and the solute. More specifically, we will search for structural water molecules which potentially provides and h-bond bridge between two residues. What will be shown below is that HNE has a few of these structural water molecules. We ll start by calculating the bfactors of all the waters in our system. Run the ptraj script below, and plot the resulting bfactors in xmgrace. trajin prod_10ns.nc rms first atomicfluct out wat_flucts.out * &!:1-218 bfactor byres xmgrace wat_flucts.out As expected most water molecules have a high bfactor (little lass than ), but not all. The plot reveals a few water molecules with low bfactor. As expected most of these are water molecules from the crystal structure (they have low residue numbers). However, we also see a few peaks with high residue numbers. The following table are the 20 water molecules with lowest bfactor: 24

27 Res. index Bfactor

28 We will now focus on a few of these water molecules. Open VMD and load in the trajectory. Choose the new cartoon representation, and color it Structure. Create another representation which is called residue 220 and represent it with CPK. Play the trajectory and zoom into the water molecule. If you want to take a look on the residues surrounding this trapped water molecule create another representation and write all within 5 of residue 220. Delete or hide the two latter representations. Create a new representation of residue 1841 and represent it with CPK. Play the trajectory from the beginning and follow this water molecule. 26

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

Introduction to Molecular Modeling Lab X - Modeling Proteins

Introduction to Molecular Modeling Lab X - Modeling Proteins (Rev 12/2/99, Beta Version) Introduction to Molecular Modeling Lab X - Modeling Proteins Table of Contents Introduction...2 Objectives...3 Outline...3 Preparation of the pdb File...4 Using Leap to build

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

Amber: Building DNAs and Minimizing their Energy Lab 4

Amber: Building DNAs and Minimizing their Energy Lab 4 (Rev 9/8/08) Amber: Building DNAs and Minimizing their Energy Lab 4 Table of Contents Objectives...2 Purpose...2 Outline...2 Definitions...3 Setup...3 Building the initial canonical DNA structure...4 Introduction...4

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

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

Lysozyme pka example - Software. APBS! >!Examples! >!pka calculations! >! Lysozyme pka example. Background

Lysozyme pka example - Software. APBS! >!Examples! >!pka calculations! >! Lysozyme pka example. Background 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

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

1 Introduction. command intended for command prompt

1 Introduction. command intended for command prompt Guest Lecture, Smith College, CS 334, BioInformatics 21 October 2008 GROMACS, Position Restrained MD, Protein Catalytic Activity Filip Jagodzinski 1 Introduction GROMACS (GROningen MAchine for Chemistry

More information

Amber 10 Users Manual

Amber 10 Users Manual Amber 10 Users Manual Principal contributors to the current codes: David A. Case (The Scripps Research Institute) Tom Darden (NIEHS) Thomas E. Cheatham III (Utah) Carlos Simmerling (Stony Brook) Junmei

More information

Chem 253. Tutorial for Materials Studio

Chem 253. Tutorial for Materials Studio Chem 253 Tutorial for Materials Studio This tutorial is designed to introduce Materials Studio 7.0, which is a program used for modeling and simulating materials for predicting and rationalizing structure

More information

Preparing a PDB File

Preparing a PDB File Figure 1: Schematic view of the ligand-binding domain from the vitamin D receptor (PDB file 1IE9). The crystallographic waters are shown as small spheres and the bound ligand is shown as a CPK model. HO

More information

Amber 12 Reference Manual

Amber 12 Reference Manual Amber 12 Reference Manual 2 Amber 12 Reference Manual Principal contributors to the current codes: David A. Case (Rutgers University) Tom Darden (OpenEye) Thomas E. Cheatham III (Utah) Carlos Simmerling

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

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

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

Using the MMTSB Tool Set

Using the MMTSB Tool Set Using the MMTSB Tool Set MMTSB NIH Research Resource PSC Workshop 2003 Architecture of MMTSB Tool Set MMTSB Tool Set Package o Available from: (free for academic use) http://mmtsb.scripps.edu/software/mmtsbtoolset.html

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

Pymol Practial Guide

Pymol Practial Guide Pymol Practial Guide Pymol is a powerful visualizor very convenient to work with protein molecules. Its interface may seem complex at first, but you will see that with a little practice is simple and powerful

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

Section III - Designing Models for 3D Printing

Section III - Designing Models for 3D Printing Section III - Designing Models for 3D Printing In this section of the Jmol Training Guide, you will become familiar with the commands needed to design a model that will be built on a 3D Printer. As you

More information

Amber 11 Users Manual

Amber 11 Users Manual Amber 11 Users Manual Amber 11 Users Manual Principal contributors to the current codes: David A. Case (Rutgers University) Tom Darden (OpenEye) Thomas E. Cheatham III (Utah) Carlos Simmerling (Stony

More information

Bonds and Structural Supports

Bonds and Structural Supports Bonds and Structural Supports Part of the Jmol Training Guide from the MSOE Center for BioMolecular Modeling Interactive version available at http://cbm.msoe.edu/teachingresources/jmol/jmoltraining/struts.html

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

Part 7 Bonds and Structural Supports

Part 7 Bonds and Structural Supports Part 7 Bonds and Structural Supports http://cbm.msoe.edu/newwebsite/learntomodel Introduction In addition to covalent bonds between atoms in a molecule, Jmol has the ability to render Hydrogen Bonds and

More information

Build_model v User Guide

Build_model v User Guide Build_model v.2.0.1 User Guide MolTech Build_model User Guide 2008-2011 Molecular Technologies Ltd. www.moltech.ru Please send your comments and suggestions to contact@moltech.ru. Table of Contents Input

More information

Lysozyme pka example. Background

Lysozyme pka example. Background Lysozyme pka example Background Hen egg white lysozyme (HEWL) is a very popular system for pka as it has a number of interesting values for its titratable residues. Early pka work on this enzyme is presented

More information

Tutorial: Structural Analysis of a Protein-Protein Complex

Tutorial: Structural Analysis of a Protein-Protein Complex Molecular Modeling Section (MMS) Department of Pharmaceutical and Pharmacological Sciences University of Padova Via Marzolo 5-35131 Padova (IT) @contact: stefano.moro@unipd.it Tutorial: Structural Analysis

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

Let s continue our discussion on the interaction between Fe(III) and 6,7-dihydroxynaphthalene-2- sulfonate.

Let s continue our discussion on the interaction between Fe(III) and 6,7-dihydroxynaphthalene-2- sulfonate. Chemistry 5995(133)-8990(013) Bioinorganic Chemistry: The Good, the Bad, and the Potential of Metals Assignment 2- Aqueous Speciation, Magnetism, Redox, UV-Vis Spectroscopy, and Pymol Let s continue our

More information

HANDBOOK IN MOLECULAR MODELING

HANDBOOK IN MOLECULAR MODELING HANDBOOK IN MOLECULAR MODELING Developed by and based on the work igem Stockholm 2018, this handbook serves the simple purpose of providing future igem teams with the possibility to perform molecular modelling

More information

Introduction to Spark

Introduction to Spark 1 As you become familiar or continue to explore the Cresset technology and software applications, we encourage you to look through the user manual. This is accessible from the Help menu. However, don t

More information

IFM Chemistry Computational Chemistry 2010, 7.5 hp LAB2. Computer laboratory exercise 1 (LAB2): Quantum chemical calculations

IFM Chemistry Computational Chemistry 2010, 7.5 hp LAB2. Computer laboratory exercise 1 (LAB2): Quantum chemical calculations Computer laboratory exercise 1 (LAB2): Quantum chemical calculations Introduction: The objective of the second computer laboratory exercise is to get acquainted with a program for performing quantum chemical

More information

Generate topology (Gromacs)

Generate topology (Gromacs) Running MD code What for...? 1. Minimizzation 2. Molecular Dynamics (classic, brownian, Langevin) 3. Normal Mode Analysis 4. Essential Dynamics and Sampling 5. Free Energy calculations (FEP, Umbrella sampling,

More information

Assessing the current state of AMBER force field modifications for DNA.

Assessing the current state of AMBER force field modifications for DNA. Assessing the current state of AMBER force field modifications for DNA. Supporting Information. Table S1 Average structural parameters for the DDD system with the ε/ζ OL1 +χ OL4 force field modification.

More information

Molecular Visualization. Introduction

Molecular Visualization. Introduction Molecular Visualization Jeffry D. Madura Department of Chemistry & Biochemistry Center for Computational Sciences Duquesne University Introduction Assessments of change, dynamics, and cause and effect

More information

XYZ file format Protein Data Bank (pdb) file format Z - matrix

XYZ file format Protein Data Bank (pdb) file format Z - matrix Chemistry block (exercise 1) In this exercise, students will be introduced how to preform simple quantum chemical calculations. Input files for Gaussian09. Output file structure. Geometry optimization,

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

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

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

CSD Conformer Generator User Guide

CSD Conformer Generator User Guide CSD Conformer Generator User Guide 2018 CSD Release Copyright 2017 Cambridge Crystallographic Data Centre Registered Charity No 800579 Conditions of Use The CSD Conformer Generator is copyright work belonging

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

Introduction to Structure Preparation and Visualization

Introduction to Structure Preparation and Visualization Introduction to Structure Preparation and Visualization Created with: Release 2018-4 Prerequisites: Release 2018-2 or higher Access to the internet Categories: Molecular Visualization, Structure-Based

More information

Silica surface - Materials Studio tutorial. CREATING SiO 2 SURFACE

Silica surface - Materials Studio tutorial. CREATING SiO 2 SURFACE Silica surface - Materials Studio tutorial CREATING SiO 2 SURFACE Our goal surface of SiO2 6.948 Ǻ Import structure The XRD experiment gives us such parameters as: lattice parameters, symmetry group and

More information

VCell Tutorial. Building a Rule-Based Model

VCell Tutorial. Building a Rule-Based Model VCell Tutorial Building a Rule-Based Model We will demonstrate how to create a rule-based model of EGFR receptor interaction with two adapter proteins Grb2 and Shc. A Receptor-monomer reversibly binds

More information

A tutorial for molecular dynamics simulations using Amber package

A tutorial for molecular dynamics simulations using Amber package ISSN 1984-6428 ONLINE www.orbital.ufms.br Vol 4 No. 3 July-September 2012 A tutorial for molecular dynamics simulations using Amber package Marcos Vinícius R. Garcia* a, Wivirkins N. Marciela a, Roberto

More information

Laboratory 3: Steered molecular dynamics

Laboratory 3: Steered molecular dynamics Laboratory 3: Steered molecular dynamics Nathan Hammond nhammond@mit.edu Issued: Friday, February 20, 2009 Due: Friday, February 27, 2009 In this lab you will: 1. Do some basic analysis of the molecular

More information

Assignment A02: Geometry Definition: File Formats, Redundant Coordinates, PES Scans

Assignment A02: Geometry Definition: File Formats, Redundant Coordinates, PES Scans Assignment A02: Geometry Definition: File Formats, Redundant Coordinates, PES Scans In Assignments A00 and A01, you familiarized yourself with GaussView and G09W, you learned the basics about input (GJF)

More information

Part 8 Working with Nucleic Acids

Part 8 Working with Nucleic Acids Part 8 Working with Nucleic Acids http://cbm.msoe.edu/newwebsite/learntomodel Introduction Most Protein Databank files loaded into the CBM's Jmol Design Environment include protein structures and small

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

NMR-Structure determination with the program CNS

NMR-Structure determination with the program CNS NMR-Structure determination with the program CNS Blockkurs 2013 Exercise 11.10.2013, room Mango? 1 NMR-Structure determination - Overview Amino acid sequence Topology file nef_seq.mtf loop cns_mtf_atom.id

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

Avogadro with YAeHMOP Manual

Avogadro with YAeHMOP Manual Avogadro with YAeHMOP Manual Patrick Avery, Herbert Ludowieg, Jochen Autschbach, and Eva Zurek Department of Chemistry University at Buffalo Buffalo, NY 14260-3000, USA September 11, 2017 Contents 1 Installation

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

Assignment 2: Conformation Searching (50 points)

Assignment 2: Conformation Searching (50 points) Chemistry 380.37 Fall 2015 Dr. Jean M. Standard September 16, 2015 Assignment 2: Conformation Searching (50 points) In this assignment, you will use the Spartan software package to investigate some conformation

More information

CSD Conformer Generator User Guide

CSD Conformer Generator User Guide CSD Conformer Generator User Guide 2017 CSD Release Copyright 2016 Cambridge Crystallographic Data Centre Registered Charity No 800579 Conditions of Use The CSD Conformer Generator is copyright work belonging

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

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

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

Molecular Modeling Lecture 7. Homology modeling insertions/deletions manual realignment

Molecular Modeling Lecture 7. Homology modeling insertions/deletions manual realignment Molecular Modeling 2018-- Lecture 7 Homology modeling insertions/deletions manual realignment Homology modeling also called comparative modeling Sequences that have similar sequence have similar structure.

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

BIOINF527: STRUCTURAL BIOINFORMATICS LAB SESSION

BIOINF527: STRUCTURAL BIOINFORMATICS LAB SESSION BIOINF527: STRUCTURAL BIOINFORMATICS LAB SESSION Introduction to Protein Structure Visualization and Small Molecule Docking Drs. Barry Grant & Guido Scarabelli Nov 2013 Exercise 1: Introduction to the

More information

Christine M. Isborn, Andreas W. Götz, Matthew A. Clark, Ross C. Walker, and Todd J. Martínez

Christine M. Isborn, Andreas W. Götz, Matthew A. Clark, Ross C. Walker, and Todd J. Martínez Supporting Information for Electronic Absorption Spectra from MM and ab initio QM/MM Molecular Dynamics: Environmental Effects on the Absorption Spectrum of Photoactive Yellow Protein Christine M. Isborn,

More information

Chemistry 14CL. Worksheet for the Molecular Modeling Workshop. (Revised FULL Version 2012 J.W. Pang) (Modified A. A. Russell)

Chemistry 14CL. Worksheet for the Molecular Modeling Workshop. (Revised FULL Version 2012 J.W. Pang) (Modified A. A. Russell) Chemistry 14CL Worksheet for the Molecular Modeling Workshop (Revised FULL Version 2012 J.W. Pang) (Modified A. A. Russell) Structure of the Molecular Modeling Assignment The molecular modeling assignment

More information

PDBe TUTORIAL. PDBePISA (Protein Interfaces, Surfaces and Assemblies)

PDBe TUTORIAL. PDBePISA (Protein Interfaces, Surfaces and Assemblies) PDBe TUTORIAL PDBePISA (Protein Interfaces, Surfaces and Assemblies) http://pdbe.org/pisa/ This tutorial introduces the PDBePISA (PISA for short) service, which is a webbased interactive tool offered by

More information

Comparing whole genomes

Comparing whole genomes BioNumerics Tutorial: Comparing whole genomes 1 Aim The Chromosome Comparison window in BioNumerics has been designed for large-scale comparison of sequences of unlimited length. In this tutorial you will

More information

Performing a Pharmacophore Search using CSD-CrossMiner

Performing a Pharmacophore Search using CSD-CrossMiner Table of Contents Introduction... 2 CSD-CrossMiner Terminology... 2 Overview of CSD-CrossMiner... 3 Searching with a Pharmacophore... 4 Performing a Pharmacophore Search using CSD-CrossMiner Version 2.0

More information

Ranking of HIV-protease inhibitors using AutoDock

Ranking of HIV-protease inhibitors using AutoDock Ranking of HIV-protease inhibitors using AutoDock 1. Task Calculate possible binding modes and estimate the binding free energies for 1 3 inhibitors of HIV-protease. You will learn: Some of the theory

More information

Tutorial. Getting started. Sample to Insight. March 31, 2016

Tutorial. Getting started. Sample to Insight. March 31, 2016 Getting started March 31, 2016 Sample to Insight CLC bio, a QIAGEN Company Silkeborgvej 2 Prismet 8000 Aarhus C Denmark Telephone: +45 70 22 32 44 www.clcbio.com support-clcbio@qiagen.com Getting started

More information

Building small molecules

Building small molecules Building small molecules Use the Builder (right panel) to build up molecules. Start building clicking a fragment/atom in the builder and it will appear to the workspace. Continue modifying the molecule

More information

Implementing MD Simulations and Principal Component Analysis to Calculate Protein Motions

Implementing MD Simulations and Principal Component Analysis to Calculate Protein Motions Implementing MD Simulations and Principal Component Analysis to Calculate Protein Motions Myrna I. Merced Serrano Computational and Systems Biology Summer Institute Iowa State University Ames, IA 50010

More information

VPython Class 2: Functions, Fields, and the dreaded ˆr

VPython Class 2: Functions, Fields, and the dreaded ˆr Physics 212E Classical and Modern Physics Spring 2016 1. Introduction VPython Class 2: Functions, Fields, and the dreaded ˆr In our study of electric fields, we start with a single point charge source

More information

Athena Visual Software, Inc. 1

Athena Visual Software, Inc. 1 Athena Visual Studio Visual Kinetics Tutorial VisualKinetics is an integrated tool within the Athena Visual Studio software environment, which allows scientists and engineers to simulate the dynamic behavior

More information

Mnova Software for Analyzing Reaction Monitoring NMR Spectra

Mnova Software for Analyzing Reaction Monitoring NMR Spectra Mnova Software for Analyzing Reaction Monitoring NMR Spectra Version 10 Chen Peng, PhD, VP of Business Development, US & China Mestrelab Research SL San Diego, CA, USA chen.peng@mestrelab.com 858.736.4563

More information

Application Note. U. Heat of Formation of Ethyl Alcohol and Dimethyl Ether. Introduction

Application Note. U. Heat of Formation of Ethyl Alcohol and Dimethyl Ether. Introduction Application Note U. Introduction The molecular builder (Molecular Builder) is part of the MEDEA standard suite of building tools. This tutorial provides an overview of the Molecular Builder s basic functionality.

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

Creating a Pharmacophore Query from a Reference Molecule & Scaffold Hopping in CSD-CrossMiner

Creating a Pharmacophore Query from a Reference Molecule & Scaffold Hopping in CSD-CrossMiner Table of Contents Creating a Pharmacophore Query from a Reference Molecule & Scaffold Hopping in CSD-CrossMiner Introduction... 2 CSD-CrossMiner Terminology... 2 Overview of CSD-CrossMiner... 3 Features

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

Lab 1: Handout GULP: an Empirical energy code

Lab 1: Handout GULP: an Empirical energy code Lab 1: Handout GULP: an Empirical energy code We will be using the GULP code as our energy code. GULP is a program for performing a variety of types of simulations on 3D periodic solids, gas phase clusters,

More information

Docking with Water in the Binding Site using GOLD

Docking with Water in the Binding Site using GOLD Docking with Water in the Binding Site using GOLD Version 2.0 November 2017 GOLD v5.6 Table of Contents Docking with Water in the Binding Site... 2 Case Study... 3 Introduction... 3 Provided Input Files...

More information

Introduction Molecular Structure Script Console External resources Advanced topics. JMol tutorial. Giovanni Morelli.

Introduction Molecular Structure Script Console External resources Advanced topics. JMol tutorial. Giovanni Morelli. Gen 19th, 2017 1 2 Create and edit Display and view Mesurament and labelling Surface and Orbitals 3 4 from Database Protein Enzyme Crystal Structure and Unit Cell 5 Symmetry Animation General information

More information

Supporting Information for. Forcefield_PTM: Ab Initio Charge and AMBER. Forcefield Parameters for Frequently Occurring

Supporting Information for. Forcefield_PTM: Ab Initio Charge and AMBER. Forcefield Parameters for Frequently Occurring Supporting Information for Forcefield_PTM: Ab Initio Charge and AMBER Forcefield Parameters for Frequently Occurring Post-Translational Modifications George A. Khoury, Jeff P. Thompson, James Smadbeck,

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

Analysis of the simulation

Analysis of the simulation Analysis of the simulation Marcus Elstner and Tomáš Kubař January 7, 2014 Thermodynamic properties time averages of thermodynamic quantites correspond to ensemble averages (ergodic theorem) some quantities

More information

Ligand Scout Tutorials

Ligand Scout Tutorials Ligand Scout Tutorials Step : Creating a pharmacophore from a protein-ligand complex. Type ke6 in the upper right area of the screen and press the button Download *+. The protein will be downloaded and

More information

Run free energy calculations with YANK. MSM Novartis, Boston - 5/27/2016 Andrea Rizzi

Run free energy calculations with YANK. MSM Novartis, Boston - 5/27/2016 Andrea Rizzi Run free energy calculations with YANK MSM workshop @ Novartis, Boston - 5/27/2016 Andrea Rizzi What does YANK do? 0) Install YANK 1.Install miniconda (or anaconda) http://conda.pydata.org/miniconda.html

More information

freely available at

freely available at freely available at www.gromacs.org Generally 3 to 10 times faster than other Molecular Dynamics programs Very user-friendly: issues clear error messages, no scripting language is required to run the programs,

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

Assignment 1: Molecular Mechanics (PART 1 25 points)

Assignment 1: Molecular Mechanics (PART 1 25 points) Chemistry 380.37 Fall 2015 Dr. Jean M. Standard August 19, 2015 Assignment 1: Molecular Mechanics (PART 1 25 points) In this assignment, you will perform some molecular mechanics calculations using the

More information

ANALYZE. A Program for Cluster Analysis and Characterization of Conformational Ensembles of Polypeptides

ANALYZE. A Program for Cluster Analysis and Characterization of Conformational Ensembles of Polypeptides ANALYZE A Program for Cluster Analysis and Characterization of Conformational Ensembles of Polypeptides Calculations of conformational characteristics, such as hydrogen bonds, turn position and types,

More information

Chem 310, Organic Chemistry Lab Molecular Modeling Using Macromodel

Chem 310, Organic Chemistry Lab Molecular Modeling Using Macromodel Chem 310, Organic Chemistry Lab Molecular Modeling Using Macromodel This is a molecular modeling experiment, and should be written up in your lab notebook just as if it were a normal "wet-chemistry" experiment.

More information

Dynamical properties of the calcium pump of sarcoplasmic reticulum: a normal mode analysis. Russell Hanson BIOL 8804b April 29, 2004

Dynamical properties of the calcium pump of sarcoplasmic reticulum: a normal mode analysis. Russell Hanson BIOL 8804b April 29, 2004 Dynamical properties of the calcium pump of sarcoplasmic reticulum: a normal mode analysis Russell Hanson BIOL 8804b April 29, 2004 Structures 1) Bound Ca 2+ 2) Dissociated Ca 2+ $ wc -l *.pdb 8534 1IWO-A-domain.pdb

More information

NAMD TUTORIAL. Unix/MacOSX Version. NAMD Developers: James Phillips, David Hardy

NAMD TUTORIAL. Unix/MacOSX Version. NAMD Developers: James Phillips, David Hardy University of Illinois at Urbana Champaign NIH Center for Macromolecular Modeling and Bioinformatics Beckman Institute Computational Biophysics Workshop NAMD TUTORIAL Unix/MacOSX Version NAMD Developers:

More information

Part 4 The Select Command and Boolean Operators

Part 4 The Select Command and Boolean Operators Part 4 The Select Command and Boolean Operators http://cbm.msoe.edu/newwebsite/learntomodel Introduction By default, every command you enter into the Console affects the entire molecular structure. However,

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

Maestro 8.5. Tutorial. Schrödinger Press

Maestro 8.5. Tutorial. Schrödinger Press Maestro Tutorial Maestro 8.5 Tutorial Schrödinger Press Maestro Tutorial Copyright 2008 Schrödinger, LLC. All rights reserved. While care has been taken in the preparation of this publication, Schrödinger

More information

v Prerequisite Tutorials GSSHA WMS Basics Watershed Delineation using DEMs and 2D Grid Generation Time minutes

v Prerequisite Tutorials GSSHA WMS Basics Watershed Delineation using DEMs and 2D Grid Generation Time minutes v. 10.1 WMS 10.1 Tutorial GSSHA WMS Basics Creating Feature Objects and Mapping Attributes to the 2D Grid Populate hydrologic parameters in a GSSHA model using land use and soil data Objectives This tutorial

More information

Online Protein Structure Analysis with the Bio3D WebApp

Online Protein Structure Analysis with the Bio3D WebApp Online Protein Structure Analysis with the Bio3D WebApp Lars Skjærven, Shashank Jariwala & Barry J. Grant August 13, 2015 (updated November 17, 2016) Bio3D1 is an established R package for structural bioinformatics

More information

QUANTUM CHEMISTRY WITH GAUSSIAN : A VERY BRIEF INTRODUCTION (PART 2)

QUANTUM CHEMISTRY WITH GAUSSIAN : A VERY BRIEF INTRODUCTION (PART 2) QUANTUM CHEMISTRY WITH GAUSSIAN : A VERY BRIEF INTRODUCTION (PART 2) TARAS V. POGORELOV AND MIKE HALLOCK SCHOOL OF CHEMICAL SCIENCES, UIUC This tutorial continues introduction to Gaussian [2]. Here we

More information

Pipelining Ligands in PHENIX: elbow and REEL

Pipelining Ligands in PHENIX: elbow and REEL Pipelining Ligands in PHENIX: elbow and REEL Nigel W. Moriarty Lawrence Berkeley National Laboratory Physical Biosciences Division Ligands in Crystallography Drug design Biological function studies Generate

More information