Introduction to Molecular Modeling Lab X - Modeling Proteins

Size: px
Start display at page:

Download "Introduction to Molecular Modeling Lab X - Modeling Proteins"

Transcription

1 (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 the Biotin/Steptavidin Complex...5 xleap...5 Building the biotin residue from pdb in Leap...5 Carnal...13 Sander...13 summary...15 Carnal-II...17 Appendices...21 Appendix Appendix Appendix Appendix Appendix Appendix Appendix xx...24 Appendix xx...25

2 2 Biotin Streptavidin Introduction The streptavidin/biotin system is of special interest because it has one of the largest free energies of association as of yet observed for noncovalent binding of a protein and small ligand in aqueous solution (K ass = ). The complexes are also extremely stable over a wide range of temperature and ph. The streptavidin protomer is organized as an 8-stranded beta-barrel. Pairs of the barrels bind together to form symmetric dimers, pairs of which in turn interdigitate with their dyad axes coincident to form the naturally-occurring tetramer. If you are interested in the Biotin/streptavidin system and would like to know more about the system in general then consult the two references given below. However, it is not necessary to do so to understand this laboratory exercise. Miyamoto S, Kollman PA. What determines the strength of noncovalent association of ligands to proteins in aqueous solution. PNAS, (1993), 90: Miyamoto S, Kollman PA. Absolute and relative binding free energy calculations of the interaction of biotin and its analogs with streptavidin using molecular dynamics free energy perturbation approaches. Proteins-Structure Function and Genetics, (1993) 16:

3 3 Objectives In this tutorial, we massage a PDB file of the tetramer so that it can be understood by Amber, solvate the region of interest (i.e. around one of the four complexed biotins), and run some dynamics keeping the rest frozen. The equilibration takes 2.3 hours per picosecond on moderately fast CPU (Convex 3820). Allowing the whole system to move takes 4 hours/psec (the whole system would have to be solvated, thus still longer time, for this to be useful). The frozen part provides a more realistic electrostatic environment for the part that moves. Thus the main objectives are 1) Modifying Protein PDB files to suit specific needs. 2) Partially hydrating proteins to decrease computational time yet obtain meaningful results. 3) Run molecular dynamics on a protein 4) Interpret the results of the molecular dynamics run. The initial biotin/streptavidin tetramer was prepared by Richard Dixon from the momomer. The monitor was obtained from the Brookhaven database, structure 1stp by P.C. Weber, D.H. Ohlendorf, J.J. Mendolowski, and F.R. Salemme (1992). Outline 1) Prepare the required pdb file 2) xleap a) Build biotin residue template. b) Load 'frcmod' file (extra force field params) for biotin. c) Load the streptavidin-biotin pdb. d) Add 'cap' of water. e) Save top and crd files for dynamics. 3) Carnal Figure out residues in biotin 'cap' region. 4) Sander a) Minimize and run dynamics to equilibrate. b) Check equilibration. c) Run more dynamics.

4 4 5) Carnal Analyze the trajectory. Setup 1) Create a subdirectory in your home directory call biotin mkdir ~/biotin 2) Copy all the files from /usr/people/amberlab11 into the ~/biotin directory cp /usr/people/amberlab4/* ~/biotin/ The files that should be copied are: biotin.pdb btn.frcmod carnal_grp.in carnal_rms.in carnal_dist.in carnal_hbond.in min.in md0.in md1.in process_md.perl Preparation of the pdb File Hydrogen naming conventions in the given.pdb file are wrong - a not uncommon experience. One option is to try to correct all the hydrogen atoms (about 4000). However, it is much quicker to simply delete all the hydrogren atoms and then let xleap add them back when you load up the pdb file. This can be achieved by using 'egrep -v' to exclude lines matching a pattern with H in either of the 1 st or 2 nd columns of the atom name. egrep -v '^...H' given.pdb > x egrep -v '^...H' x > start.pdb where the '^ starts the pattern at the beginning of the line and the.'s are wild-card single characters Note that there are 13. in the first line and 12. in the second.

5 5 Using Leap to build the Biotin/Steptavidin Complex xleap Building the biotin residue from pdb in Leap The amber force field lacks parameters for biotin. Therefore to get Amber to understand biotin will require you to load a coordinate file for biotin, then make bonds between the connected atoms, and then input parameters for each atom of biotin. While this is a bit tedious, we will not have to actually determine what the parameters are, which is really the hard part. Start xleap and load the residue: > BTN = loadpdb bioti n.pdb > edit BTN When you molecule in you will see atoms of diamonds. colored atom type but lack any look at the biotin the Unit editor each of the biotin appear as They will be according to the structure will bonds.

6 6 To add the atoms, select all of the atoms by snapping a box that encloses all of the atoms. Then, in the World editor, type the following command: > bondbydistance BTN If you now view the biotin molecule you will see bonds have been added.

7 7 Now, select all of the atoms by dragging a box about the structure with the left mouse button, they will turn purple. Select all atoms by dragging a box with left mouse button and pull down 'Edit selected atoms': Note: Editing the table that appears can be frustrating. The program driving it is not very stable and tends to hang. When it hangs, you lose all of your work. If this crashes more than once on you, let me know and I will provide you with what you need to by-pass this step. Also, if it does crash, try to note exactly what you were doing when it crashed. I am trying to collect this information to help the programmers discover the problem and then, hopefully, fix it.

8 8 ust input an atom type, charge, Pert.name and Pert.type for each atom as shown on the next table. T hi s ta bl e lis ts al l th e at o m s p re s e nt in B io ti n. Y o u m

9 9 Note that for most of the atoms the Name/PERT.name and the Type/PERT.type entries are identical. The exceptions are H71, H81, H91 and H92. When you have finished entering the data, pull down 'Operations / Check table' to make sure all is ok, and 'Save and quit' the table.

10 In the Unit Editor, deselect the atoms by holding down the Shift key and clicking in the background (i.e. not on any atom). This is mainly cosmetic, so that the saved state will not have selection on. Finally, save the residue in xleap format at the command line. The.lib file contains a description of each atom - atom name, type, charge, coordinates, and connectivity information. However, it does not contain force field information. > saveoff BTN btn.lib 10 The residue can be loaded in later sessions by > loadoff btn.lib Load the premade 'frcmod' file for biotin. This file is shown in Appendix 1. It contains the force field parameters which were missing from the Amber force field. When this file is loaded, the parameters in this file are merged with the Amber force field. If there is duplication, the.frcmod file parameters take precedence. > fmod = loadamberparams btn.frcmod Load prepared pdb of streptavidin/biotin complex: > stbt = loadpdb start.pdb > edit stbt

11 11 To manipulate the structure, hold down the two right buttons and push forward/back to zoom in/out. The middle button alone rotates, the right button translates, and the space bar recenters the molecule. Add a 'cap' of waters around the site of the 1 st biotin. This is done by estimating a median x, y, z coordinate by eyeballing the coordinates of the BTN at the beginning of start.pdb, which can be viewed by jot start.pdb: > solvatecap stbt WATBOX216 { } 20

12 12 The number of waters in the cap varies slightly, depending on machine; about 265 is to be expected on SGI. Save system in xleap and pdb formats for future reference: > saveoff stbt built.lib > savepdb stbt stbtcap.pdb Save top and prm files for dynamics & perturbation: > saveamberparm stbt stbtcap.top stbtcap.crd

13 13 Carnal For dynamics, we only want the region of interest to move - the rest is there to provide a more lifelike environment. Use a carnal feature to figure out the residues around the biotin molecule that the water cap is on: carnal < carnal_grp.in > carnal_grp.out Appendix 2 contains a listing of the carnal_grp.in. If you take a look at the input file you will see that first the stbtcap.top and stbtcap.crd files are read. Next the file says to find all of the residues that are within 15 A of group 479. Group 479 is the biotin residue. The output then contains the list of groups found with these constraints and it would be a good idea to examine this file. GROUP format is described in Appendix B of the Amber manual. Sander Introduction When the biotin/stretavidin complex was built, the hydrogens were deleted and then xleap added them back. They may have not all been added back in a way that was sterically favorable. In addition, a water cap was subsequently added. This is a pre-equilibrated volume of water and unfavorable steric interactions between the waters and the biotin/streptavidin complex may exist. Therefore, we first need to do a quick molecular mechanics minimization to remove any particularly bad steric interactions. Molecular Mechanics minimization The command line for this is given below. sander -O -i min.in -o min.out -p stbtcap.top -c stbtcap.crd \ -r min.rst & The file called min.in is the control file for the run and it is listed in the Appendix (3). The key parameters in this file are

14 14 IMIN=1, IMIN determines whether the run is a molecular mechanics (=1) or molecular dynamics run (=0). MAXYCY=100, we will let the minimizer run for 100 cycles. NTPR=20 SCEE=1.2. This is the 1,4-VDW scaling term. When using the all_nuc94.dat data base it should be set to this value. NSNB= NTMIN=2 Look at the output from this run (located in min.out). Note that the first part of this file lists what all the input parameters were, files used, date, etc., which can be very helpful once you start to accumulate a lot of minimization runs. After that, for each cycle, is listed various values such as total energy and each of its components. If a run blows up on you, this can help you diagnose where the problem may lie. Finally, there is some information about the length of the run. Molecular Dynamics Next we are going to gradually warm, using 'belly' option to restrict motion to region of interest as determined by carnal, above. (The group defined by carnal is modified in md0.in to include all the waters.) sander -O -i md0.in -o md0.out -p stbtcap.top -c min.rst \ -x md0.crd -r md0.rst & The input file for this run is given in the Appendix 4. Some of the key parameters are: IBELLY=1, NRUN=1, NTT=1, IREST=0 NTX=1, NTB=0 TEMPI=0, TEMPO=300, TAUTP=0.1, DTEMP=2.0, NTP=0 NSTLIM=1000, DT=0.002, NTC=2, NTF=2 IDIEL=0, SCEE=1.2, CUT=999, NSNB=9999, NTPR=20, NTWX=20 This equilibration immediately warms to 300K; this may be ok in this case since a major part of the system is frozen - if this were not the case, too-rapid warming could disrupt the structure. Similarly, if this was a constant pressure simulation in a periodic box of solvent, too-rapid warming could lead to excessive pressure fluctuations. Although no such critical problems can happen here, we still need to see if the system has truly equilibrated. To determine this we need to take a look at the variantion in temperature energy and its components. This

15 15 information is numerically present in the md0.out file and the relevant numbers can be sorted into files for plotting with a perl script called process_md_perl and then the plots can be viewed with xmgr. process_md_perl < md0.out This script will create a bunch of files called summary_xxx where xxx is temperature (TEMP), total energy (ETOT), kinetic energy (KETOT), etc To plot these files use xmgr. Equilibration: Temperature The temperature seems fairly equilibrated, but this does not necessarily mean the system is fully equilibrated, especially because the temperature coupling we use in AMBER forces the temperature to the desired value. (Note: since this setup uses an effectively infinite cutoff, once it is equilibrated the temperature scaling could be turned off; see NTT in the Sander manual.) Equilibration: Energy Looking at the total energy of the system we see a definite trend to lower energy that presumably has not completed. The total energy of the system can be subdivided into its main components, kinetic and potential energies and are shown below.

16 16 Equilibration: Kinetic Energy Component Equilibration: Potential Energy Component Thus after the initial warming period, kinetic energy is relatively constant (it scales with temperature so is not really worth checking, in fact), but the system is gradually relaxing to a lower-energy conformation. Further equilibration is called for. Note: in a periodic system, we would also want to check pressure fluctuations and density. We restart from the saved coordinates of the previous run, using the same conditions but setting the appropriate variables to use the saved final velocities (IREST=1, NTX=5) and letting it run twice as long (NTSLIM=2000) (see Appendix 5 for a listing of the control file md1.in): sander -O -i md1.in -o md1.out -p stbtcap.top -c md0.rst \ -x md1.traj -r md1.rst & Looking at the potential energy for the combined runs leads to the plots shown below. These were generated are for the first run. You should generate these plots following the procedure given above using the perl script and xmgr. Equilibration 2: Potential Energy Component

17 17 The potential energy clearly has still not fully equilibrated. At this point, it appears that the assumption that fast warming was ok could have been wrong, and a gradual warming protocol or use of cartesian restraints in the initial warmup may have been in order (this more conservative approach is recommended in general). On the other hand, 6-10 psec of equilibration is not an excessive requirement. In effect, we have performed a mild form of simulated annealing on the initial structure, and in any case need to know how far the solute has moved from the crystallographic starting position. For this analysis, we turn to carnal. Carnal-II To get a rough measure of how far the structure has drifted from the crystal form during the equilibration, we perform a root-mean-square (RMS) comparison of the solute atoms that were allowed to move, using the first set as a reference. (If this system were not held in place by the stationary atoms, we would want to get the best fit of each coordinate set to the first using carnal's RMS FIT option.) Three types of RMS are measured: the entire moving part of the system; the moving biotin to get a rough idea of the changes that it experiences in its pocket; and the biotin using the FIT option to see how much of its variation is due to internal (vs. orientational) changes (See appendix 6 for a listing of carnal_rms.in). carnal < carnal_rms.in > carnal_rms.out As might be expected, the average RMS decreases in each successive case:0.9, 0.7 and 0.2 Angstroms respectively. The time results: Equilibration: RMS Deviation from Initial Structure

18 18 Equilibration: RMS Deviation of Backbone from Initial Structure Although the equilibration is not quite complete based on the potential energy above, the overall RMS indicates that the structure is not drifting progressively (as virtually guaranteed by the frozen part). The overall RMS of ca. 1 Angstrom is well within the norm for simulations; beyond 2 Angstroms would be alarming. The backbone RMS is also reasonable: NMR-derived structures tend to differ from X-ray by about 0.8 Angstroms. (Different X-ray structures vary by about 0.4 Angstroms.) Turning to Initial the biotin: Equilibration: RMS Deviation of Biotin from Structure Equilibration: Internal RMS Deviation of Biotin

19 19 The first graph indicates a quasi-periodic motion relative to the initial structure that may be interesting to explore once the trajectory has equilibrated. The internal variations are faster and smaller, as one would expect. Since the solute RMS is not drifting appreciably, a progressive change in water structure presumably is the cause of the progressive dropping of potential energy. This stands to reason, since we simply superimposed a sphere cut from a periodic system of pure water onto the solute and trimmed away any waters that overlapped, then warmed the local system rapidly to 300K, with nothing to prevent the sphere of waters from expanding. Therefore one would expect the drop in potential energy to correlate with the waters settling in toward the solute. Measuring the distance between the geometric centers of two groups of atoms, the biotin and the water oxygens, illustrates: carnal < carnal_dist.in > carnal_dist.out resulting in md01.dist. Treating the trajectory as if it were at equilibrium for didactic purposes, we run carnal again to analyse hydrogen bonding between the ligand and its receptor: carnal < carnal_hbond.in > carnal_hbond.out The summary data from the.out file shows that 6 hbonds persist throughout the trajectory ('grep 100 carnal_hbond.out'). They are: # 63 (SER 13 OG )_(SER 13 HG )..(BTN 479 O3 ) % occupied: # 107 (TYR 29 OH )_(TYR 29 HH )..(BTN 479 O3 ) % occupied: # 146 (ASN 35 N )_(ASN 35 H )..(BTN 479 O2 ) % occupied: # 353 (SER 74 OG )_(SER 74 HG )..(BTN 479 O1 ) % occupied: # 118 (BTN 479 N2 )_(BTN 479 HN2 )..(ASP 114 OD2 ) % occupied: # 244 (BTN 479 N1 )_(BTN 479 HN1 )..(SER 31 OG ) % occupied: Thus all of the potential hbonding atoms of the biotin except for the sulfur are 100% engaged with the acceptor. As one might expect, these hbonds are not weak; e.g. the first in detail: 63 (SER 13 OG )_(SER 13 HG )..(BTN 479 O3 ) % occupied: distance avg dev max min N 150

20 angle(deg) avg dev max min N

21 21 Appendices Appendix 1-btn.frcmod file BTNMOD Modified paramaters for Biotin (RWD) MASS SD DH DC DN BOND SD-C HC-DC DC-DH DC-DN DN-DH DC-DC DH-HC DH-H ANGL N -C -N SD-C -N HC-CT-S HC-CT-N DH-HC-CT DH-H -N DH-HC-DH DH-H -DH CT-HC-DC HC-DC-DH HC-DC-DN HC-DC-DC DC-DN-DH DC-DN-DC DC-HC-DC DH-DC-DN DN-DC-DC DC-DC-DH DC-DC-DC DIHE SD-C -N -X X -CT-HC-X X -N -H -X X -DC-HC-X X -DC-DN-X X -DC-DC-X

22 22 IMPR SD-C -N -N X -X -HC-CT X -X -DC-DH X -X -DN-DH NONB SD DH DC DN Appendix 2 carnal_grp.in # CUTRES: list residues within cutoff of group FILES_IN PARM p1 stbtcap.top; STREAM s1 stbtcap.crd; FILES_OUT DECLARE GROUP g1 (RES 479); CUTRES c1 g1 15.0; OUTPUT END Appendix 3 - min.in &cntrl imin=1, maxcyc=100, ntpr=20, scee=1.2, nsnb=999999, ntmin=2, &end Appendix 4 - md0.in cold start belly equil &cntrl IREST = 0, ibelly= 1, NTX = 1, TEMPI = 0.0, NTB = 0, NRUN = 1, NTT = 1, TEMP0 = 298.0, TAUTP =.1, DTEMP = 2.0, NTP = 0, NSTLIM= 1000, DT =.002, NTC = 2, NTF = 2, IDIEL = 0, SCEE = 1.2, CUT =999.0, NSNB = 9999,

23 23 NTPR = 20, NTWX = 20, &end -- belly = residues 15A from BTN res 479 plus all H2O RES 5 17 RES RES RES RES RES RES RES RES RES RES RES RES RES RES RES RES RES RES RES RES RES RES RES END END Appendix 5 - md1.in cold start belly equil &cntrl IREST = 1, ibelly= 1, NTX = 5, TEMPI = 0.0, NTB = 0, NRUN = 1, NTT = 1, TEMP0 = 298.0, TAUTP =.1, DTEMP = 2.0, NTP = 0, NSTLIM= 2000, DT =.002, NTC = 2, NTF = 2, IDIEL = 0, SCEE = 1.2, CUT =999.0, NSNB = 9999, NTPR = 20, NTWX = 20, &end -- belly = residues 15A from BTN res 479 plus all H2O RES 5 17 RES RES RES RES

24 24 RES RES RES RES RES RES RES RES RES RES RES RES RES RES RES RES RES RES RES END END Appendix 6 - carnal_rms.in # RMS deviation of moving part of solute FILES_IN PARM p1 stbtcap.top; STREAM s1 traj/md01.crd; FILES_OUT TABLE t1 md01.rms; DECLARE GROUP g1 (RES 5-17,25,27-44,59-81,89-101,104,105, , 142, ,172, , , , 216,228,230, , ,438, , ,472,479); RMS r1 g1; GROUP g2 ((GROUP g1) & (ATOM NAME C CA N)); RMS r2 g2; GROUP g3 (RES 479); RMS r3 g3; RMS r4 FIT g3; OUTPUT TABLE t1 r1 r2 r3 r4; END Appendix xx - carnal_dist.in # distance between centers of geometry of 'central' biotin and waters FILES_IN PARM p1 stbtcap.top;

25 25 STREAM s1 traj/md01.crd; FILES_OUT TABLE t1 md01.dist; DECLARE GROUP g1 (RES 479); GROUP g2 (ATOM TYPE OW); DIST d1 g1 g2; OUTPUT TABLE t1 d1; END Appendix xx - carnal_hbond.in # HBOND analysis of ligand-receptor interaction FILES_IN PARM p1 stbtcap.top; STREAM s1 traj/md01.crd; FILES_OUT HBOND h1 md01_hb1 TABLE LIST; HBOND h2 md01_hb2 TABLE LIST; DECLARE GROUP g1 (RES 5-17,25,27-44,59-81,89-101,104,105, , 142, ,172, , , , 216,228,230, , ,438, , ,472); GROUP g2 (RES 479); OUTPUT HBOND h2 DONOR g2 ACCEPTOR g1 STATS; HBOND h1 DONOR g1 ACCEPTOR g2 STATS; END

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

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

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

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

ICM-Chemist-Pro How-To Guide. Version 3.6-1h Last Updated 12/29/2009

ICM-Chemist-Pro How-To Guide. Version 3.6-1h Last Updated 12/29/2009 ICM-Chemist-Pro How-To Guide Version 3.6-1h Last Updated 12/29/2009 ICM-Chemist-Pro ICM 3D LIGAND EDITOR: SETUP 1. Read in a ligand molecule or PDB file. How to setup the ligand in the ICM 3D Ligand Editor.

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

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

Exercises for Windows

Exercises for Windows Exercises for Windows CAChe User Interface for Windows Select tool Application window Document window (workspace) Style bar Tool palette Select entire molecule Select Similar Group Select Atom tool Rotate

More information

Practical Manual. General outline to use the structural information obtained from molecular alignment

Practical Manual. General outline to use the structural information obtained from molecular alignment Practical Manual General outline to use the structural information obtained from molecular alignment 1. In order to use the information one needs to know the direction and the size of the tensor (susceptibility,

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

Physical Chemistry Final Take Home Fall 2003

Physical Chemistry Final Take Home Fall 2003 Physical Chemistry Final Take Home Fall 2003 Do one of the following questions. These projects are worth 30 points (i.e. equivalent to about two problems on the final). Each of the computational problems

More information

Calculating NMR Chemical Shifts for beta-ionone O

Calculating NMR Chemical Shifts for beta-ionone O Calculating NMR Chemical Shifts for beta-ionone O Molecular orbital calculations can be used to get good estimates for chemical shifts. In this exercise we will calculate the chemical shifts for beta-ionone.

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

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

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

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

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

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

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

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

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

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

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

Version 1.2 October 2017 CSD v5.39

Version 1.2 October 2017 CSD v5.39 Mogul Geometry Check Table of Contents Introduction... 2 Example 1. Using Mogul to assess intramolecular geometry... 3 Example 2. Using Mogul to explain activity data... 5 Conclusions... 8 Further Exercises...

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

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

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

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

Two problems to be solved. Example Use of SITATION. Here is the main menu. First step. Now. To load the data.

Two problems to be solved. Example Use of SITATION. Here is the main menu. First step. Now. To load the data. Two problems to be solved Example Use of SITATION Mark S. Daskin Department of IE/MS Northwestern U. Evanston, IL 1. Minimize the demand weighted total distance (or average distance) Using 10 facilities

More information

Molecular Modeling and Conformational Analysis with PC Spartan

Molecular Modeling and Conformational Analysis with PC Spartan Molecular Modeling and Conformational Analysis with PC Spartan Introduction Molecular modeling can be done in a variety of ways, from using simple hand-held models to doing sophisticated calculations on

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

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

CPMD Tutorial Atosim/RFCT 2009/10

CPMD Tutorial Atosim/RFCT 2009/10 These exercices were inspired by the CPMD Tutorial of Axel Kohlmeyer http://www.theochem.ruhruni-bochum.de/ axel.kohlmeyer/cpmd-tutor/index.html and by other tutorials. Here is a summary of what we will

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

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

SeeSAR 7.1 Beginners Guide. June 2017

SeeSAR 7.1 Beginners Guide. June 2017 SeeSAR 7.1 Beginners Guide June 2017 Part 1: Basics 1 Type a pdb code and press return or Load your own protein or already existing project, or Just load molecules To begin, let s type 2zff and download

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

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

Lab 12.1 Calorimetry. Name School Date

Lab 12.1 Calorimetry. Name School Date Name School Date Lab 12.1 Calorimetry Purpose To investigate the flow of heat between two bodies due to a difference in their temperatures. To investigate the flow of heat involved in changes in phase.

More information

Dock Ligands from a 2D Molecule Sketch

Dock Ligands from a 2D Molecule Sketch Dock Ligands from a 2D Molecule Sketch 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

More information

Computer simulation of radioactive decay

Computer simulation of radioactive decay Computer simulation of radioactive decay y now you should have worked your way through the introduction to Maple, as well as the introduction to data analysis using Excel Now we will explore radioactive

More information

POC via CHEMnetBASE for Identifying Unknowns

POC via CHEMnetBASE for Identifying Unknowns Table of Contents A red arrow was used to identify where buttons and functions are located in CHEMnetBASE. Figure Description Page Entering the Properties of Organic Compounds (POC) Database 1 Swain Home

More information

The OptiSage module. Use the OptiSage module for the assessment of Gibbs energy data. Table of contents

The OptiSage module. Use the OptiSage module for the assessment of Gibbs energy data. Table of contents The module Use the module for the assessment of Gibbs energy data. Various types of experimental data can be utilized in order to generate optimized parameters for the Gibbs energies of stoichiometric

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

Autodock tutorial VINA with UCSF Chimera

Autodock tutorial VINA with UCSF Chimera Autodock tutorial VINA with UCSF Chimera José R. Valverde CNB/CSIC jrvalverde@cnb.csic.es José R. Valverde, 2014 CC-BY-NC-SA Loading the receptor Open UCSF Chimera and then load the protein: File Open

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

Flexibility and Constraints in GOLD

Flexibility and Constraints in GOLD Flexibility and Constraints in GOLD Version 2.1 August 2018 GOLD v5.6.3 Table of Contents Purpose of Docking... 3 GOLD s Evolutionary Algorithm... 4 GOLD and Hermes... 4 Handling Flexibility and Constraints

More information

Identifying Interaction Hot Spots with SuperStar

Identifying Interaction Hot Spots with SuperStar Identifying Interaction Hot Spots with SuperStar Version 1.0 November 2017 Table of Contents Identifying Interaction Hot Spots with SuperStar... 2 Case Study... 3 Introduction... 3 Generate SuperStar Maps

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

----- Ver October 24, 2014 Bug about reading MOPAC2012 Ver.14 calculations of 1 atom and 2 atoms molecule was fixed.

----- Ver October 24, 2014 Bug about reading MOPAC2012 Ver.14 calculations of 1 atom and 2 atoms molecule was fixed. ***** Facio's Release History ***** ----- Ver.18.8.2 ----- October 24, 2014 Bug about reading MOPAC2012 Ver.14 calculations of 1 atom and 2 atoms molecule was fixed. ----- Ver.18.8.1 ----- August 14, 2014

More information

Chemistry 5021/8021 Computational Chemistry 3/4 Credits Spring Semester 2000 ( Due 4 / 3 / 00 )

Chemistry 5021/8021 Computational Chemistry 3/4 Credits Spring Semester 2000 ( Due 4 / 3 / 00 ) Chemistry 5021/8021 Computational Chemistry 3/4 Credits Spring Semester 2000 ( Due 4 / 3 / 00 ) This problem set will take longer than the last one in the sense that you may need to submit some jobs, leave,

More information

Theoretical UV/VIS Spectroscopy

Theoretical UV/VIS Spectroscopy Theoretical UV/VIS Spectroscopy Why is a Ruby Red When Chromium Oxide is Green? How Does a Ruby Laser Work? Goals of this Exercise: - Calculation of the energy of electronically excited states - Understanding

More information

Molecular Modeling Lecture 11 side chain modeling rotamers rotamer explorer buried cavities.

Molecular Modeling Lecture 11 side chain modeling rotamers rotamer explorer buried cavities. Molecular Modeling 218 Lecture 11 side chain modeling rotamers rotamer explorer buried cavities. Sidechain Rotamers Discrete approximation of the continuous space of backbone angles. Sidechain conformations

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

Become a Microprobe Power User Part 2: Qualitative & Quantitative Analysis

Become a Microprobe Power User Part 2: Qualitative & Quantitative Analysis Become a Microprobe Power User Part 2: Qualitative & Quantitative Analysis Mike Spilde Spring IOM Seminar February 5, 2008 Qualitative Analysis Why use qualitative scans? Elemental ID (especially trace

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

Harmonic Motion. Mass on a Spring. Physics 231: General Physics I Lab 6 Mar. 11, Goals:

Harmonic Motion. Mass on a Spring. Physics 231: General Physics I Lab 6 Mar. 11, Goals: Physics 231: General Physics I Lab 6 Mar. 11, 2004 Names: Harmonic Motion Goals: 1. To learn about the basic characteristics of periodic motion period, frequency, and amplitude 2. To study what affects

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

Introduction to Hartree-Fock calculations in Spartan

Introduction to Hartree-Fock calculations in Spartan EE5 in 2008 Hannes Jónsson Introduction to Hartree-Fock calculations in Spartan In this exercise, you will get to use state of the art software for carrying out calculations of wavefunctions for molecues,

More information

ICM-Chemist How-To Guide. Version 3.6-1g Last Updated 12/01/2009

ICM-Chemist How-To Guide. Version 3.6-1g Last Updated 12/01/2009 ICM-Chemist How-To Guide Version 3.6-1g Last Updated 12/01/2009 ICM-Chemist HOW TO IMPORT, SKETCH AND EDIT CHEMICALS How to access the ICM Molecular Editor. 1. Click here 2. Start sketching How to sketch

More information

Name. Chem Organic Chemistry II Laboratory Exercise Molecular Modeling Part 2

Name. Chem Organic Chemistry II Laboratory Exercise Molecular Modeling Part 2 Name Chem 322 - Organic Chemistry II Laboratory Exercise Molecular Modeling Part 2 Click on Titan in the Start menu. When it boots, click on the right corner to make the window full-screen. icon in the

More information

Unfolding CspB by means of biased molecular dynamics

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

More information

schematic diagram; EGF binding, dimerization, phosphorylation, Grb2 binding, etc.

schematic diagram; EGF binding, dimerization, phosphorylation, Grb2 binding, etc. Lecture 1: Noncovalent Biomolecular Interactions Bioengineering and Modeling of biological processes -e.g. tissue engineering, cancer, autoimmune disease Example: RTK signaling, e.g. EGFR Growth responses

More information

Protein Bioinformatics Computer lab #1 Friday, April 11, 2008 Sean Prigge and Ingo Ruczinski

Protein Bioinformatics Computer lab #1 Friday, April 11, 2008 Sean Prigge and Ingo Ruczinski Protein Bioinformatics 260.655 Computer lab #1 Friday, April 11, 2008 Sean Prigge and Ingo Ruczinski Goals: Approx. Time [1] Use the Protein Data Bank PDB website. 10 minutes [2] Use the WebMol Viewer.

More information

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

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

More information

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

Other Cells. Hormones. Viruses. Toxins. Cell. Bacteria

Other Cells. Hormones. Viruses. Toxins. Cell. Bacteria Other Cells Hormones Viruses Toxins Cell Bacteria ΔH < 0 reaction is exothermic, tells us nothing about the spontaneity of the reaction Δ H > 0 reaction is endothermic, tells us nothing about the spontaneity

More information

General Chemistry Lab Molecular Modeling

General Chemistry Lab Molecular Modeling PURPOSE The objectives of this experiment are PROCEDURE General Chemistry Lab Molecular Modeling To learn how to use molecular modeling software, a commonly used tool in chemical research and industry.

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

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

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

Goldilocks I: Bronsted Acids and Bases p.1

Goldilocks I: Bronsted Acids and Bases p.1 Goldilocks I: Bronsted Acids and Bases p.1 The story of Goldilocks is familiar to many children and remembered by many adults. In that story, Goldilocks visits the house of the Three Bears while the Bears

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

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

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

3D Molecule Viewer of MOGADOC (JavaScript)

3D Molecule Viewer of MOGADOC (JavaScript) 3D Molecule Viewer of MOGADOC (JavaScript) Movement of the Molecule Rotation of the molecule: Use left mouse button to drag. Translation of the molecule: Use right mouse button to drag. Resize the molecule:

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

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

LAB 2 - ONE DIMENSIONAL MOTION

LAB 2 - ONE DIMENSIONAL MOTION Name Date Partners L02-1 LAB 2 - ONE DIMENSIONAL MOTION OBJECTIVES Slow and steady wins the race. Aesop s fable: The Hare and the Tortoise To learn how to use a motion detector and gain more familiarity

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

FlexPepDock In a nutshell

FlexPepDock In a nutshell FlexPepDock In a nutshell All Tutorial files are located in http://bit.ly/mxtakv FlexPepdock refinement Step 1 Step 3 - Refinement Step 4 - Selection of models Measure of fit FlexPepdock Ab-initio Step

More information

Senior astrophysics Lab 2: Evolution of a 1 M star

Senior astrophysics Lab 2: Evolution of a 1 M star Senior astrophysics Lab 2: Evolution of a 1 M star Name: Checkpoints due: Friday 13 April 2018 1 Introduction This is the rst of two computer labs using existing software to investigate the internal structure

More information

Calculating Bond Enthalpies of the Hydrides

Calculating Bond Enthalpies of the Hydrides Proposed Exercise for the General Chemistry Section of the Teaching with Cache Workbook: Calculating Bond Enthalpies of the Hydrides Contributed by James Foresman, Rachel Fogle, and Jeremy Beck, York College

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

Quantification of JEOL XPS Spectra from SpecSurf

Quantification of JEOL XPS Spectra from SpecSurf Quantification of JEOL XPS Spectra from SpecSurf The quantification procedure used by the JEOL SpecSurf software involves modifying the Scofield cross-sections to account for both an energy dependency

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

Watershed Modeling Orange County Hydrology Using GIS Data

Watershed Modeling Orange County Hydrology Using GIS Data v. 10.0 WMS 10.0 Tutorial Watershed Modeling Orange County Hydrology Using GIS Data Learn how to delineate sub-basins and compute soil losses for Orange County (California) hydrologic modeling Objectives

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

Dynamics. Newton s First Two Laws of Motion. A Core Learning Goals Activity for Science and Mathematics

Dynamics. Newton s First Two Laws of Motion. A Core Learning Goals Activity for Science and Mathematics CoreModels Dynamics Newton s First Two Laws of Motion A Core Learning Goals Activity for Science and Mathematics Summary: Students will investigate the first and second laws of motion in laboratory activities.

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

Using Microsoft Excel

Using Microsoft Excel Using Microsoft Excel Objective: Students will gain familiarity with using Excel to record data, display data properly, use built-in formulae to do calculations, and plot and fit data with linear functions.

More information

Table 1. Crystallographic data collection, phasing and refinement statistics. Native Hg soaked Mn soaked 1 Mn soaked 2

Table 1. Crystallographic data collection, phasing and refinement statistics. Native Hg soaked Mn soaked 1 Mn soaked 2 Table 1. Crystallographic data collection, phasing and refinement statistics Native Hg soaked Mn soaked 1 Mn soaked 2 Data collection Space group P2 1 2 1 2 1 P2 1 2 1 2 1 P2 1 2 1 2 1 P2 1 2 1 2 1 Cell

More information

BCB410 Protein-Ligand Docking Exercise Set Shirin Shahsavand December 11, 2011

BCB410 Protein-Ligand Docking Exercise Set Shirin Shahsavand December 11, 2011 BCB410 Protein-Ligand Docking Exercise Set Shirin Shahsavand December 11, 2011 1. Describe the search algorithm(s) AutoDock uses for solving protein-ligand docking problems. AutoDock uses 3 different approaches

More information

Introduc)on to IQmol: Part I.!!! Shirin Faraji, Ilya Kaliman, and Anna Krylov

Introduc)on to IQmol: Part I.!!! Shirin Faraji, Ilya Kaliman, and Anna Krylov Introduc)on to IQmol: Part I!!! Shirin Faraji, Ilya Kaliman, and Anna Krylov! 1 Resources! Written by Dr. Andrew Gilbert Keep yourself up to date with IQmol website: http://iqmol.org! IQmol Youtube channel:

More information

Pose Prediction with GOLD

Pose Prediction with GOLD Pose Prediction with GOLD Version 3.0 November 2018 GOLD v5.7.0 Table of Contents The Purpose of Docking... 2 GOLD s Evolutionary Algorithm... 3 A Checklist for Docking... 3 GOLD and Hermes... 3 Redocking

More information

Introduction to Computer Tools and Uncertainties

Introduction to Computer Tools and Uncertainties Experiment 1 Introduction to Computer Tools and Uncertainties 1.1 Objectives To become familiar with the computer programs and utilities that will be used throughout the semester. To become familiar with

More information

Structural and mechanistic insight into the substrate. binding from the conformational dynamics in apo. and substrate-bound DapE enzyme

Structural and mechanistic insight into the substrate. binding from the conformational dynamics in apo. and substrate-bound DapE enzyme Electronic Supplementary Material (ESI) for Physical Chemistry Chemical Physics. This journal is the Owner Societies 215 Structural and mechanistic insight into the substrate binding from the conformational

More information

POC via CHEMnetBASE for Identifying Unknowns

POC via CHEMnetBASE for Identifying Unknowns Table of Contents A red arrow is used to identify where buttons and functions are located in CHEMnetBASE. Figure Description Page Entering the Properties of Organic Compounds (POC) Database 1 CHEMnetBASE

More information

Introduction to AutoDock and AutoDock Tools

Introduction to AutoDock and AutoDock Tools Introduction to AutoDock and AutoDock Tools Alexander B. Pacheco User Services Consultant LSU HPC & LONI sys-help@loni.org HPC Training Series Louisiana State University Baton Rouge Mar. 28, 2012 HPC@LSU

More information