Parallel Utility for Modeling of Molecular Aggregation

Size: px
Start display at page:

Download "Parallel Utility for Modeling of Molecular Aggregation"

Transcription

1 Parallel Utility for Modeling of Molecular Aggregation Peter Spijker, Bart Markvoort and Peter Hilbers BioModeling and bioinformatics Eindhoven University of Technology Eindhoven,The Netherlands City of Hope, 8-13 March 2007

2 Overview Background History, current applications, and developers Features Potential functions Constraints Integrator Design Neighbor searching method Parallel implementation File format PumMa Toolkit Future release (major upgrade) Examples 2/41

3 History (1) Origins date back to late 1980s Initialized at University of Groningen by Peter Hilbers (Turbo Pascal) Further developed at Koninklijke Shell in early 1990s Designed as efficient parallel implementation of MD program on a torodial transputer network (ANSI C) Esselink et al., J. Comp. Phys, 106: (1993) Esselink et al., J. Comp. Phys, 106: (1993) Used to study oil surfactants solutions Smit et al., Nature, 348: (1990) Smit et al., J. Phys. Chem., 95: (1991) Smit et al., Langmuir, 9:9-11 (1993) Karaborni et al., Langmuir, 9: (1993) Karaborni et al., Science, 266: (1994) 3/41

4 History (2) In the late 1990s parallelization through MPI Group of Peter Hilbers moved to the department of Biomedical Engineering in Eindhoven in 2001 Development of PumMa reinitialized Code extended beyond its original design purposes However, original parallel design has remained Specifically designed for coarse grained simulations Initially PumMa has been used in biological simulations Markvoort et al., J. Phys. Chem. B, 109: (2005) Smeijers et al., J. Phys. Chem. B, 110: (2006) Smeijers et al., J. Phys. Chem. B, 110: (2006) Markvoort et al., J. Phys. Chem. B, 110: (2006) 4/41

5 Current applications PumMa is used in many different applications: Coarse grained simulations of biological membranes, including formation, fusion and fission. Coarse grained simulations of membrane bound proteins With City of Hope, USA (Nagarajan Vaidehi) Coarse grained simulations of dendrimer complexes With Laboratory of Macromolecular and Organic Chemistry (Bert Meijer) Simulations of flow in nanochannels used in cooling devices With Energy Technology, Thermofluids Engineering (Anton van Steenhoven) Temperature Density 5/41

6 Current developers ir. Peter Spijker dr.ir. Bart Markvoort prof.dr. Peter Hilbers 6/41

7 Overview Background History, current applications, and developers Features Potential functions Constraints Integrator Design Neighbor searching method Parallel implementation File format PumMa Toolkit Future release (major upgrade) Examples 7/41

8 Features Several potential functions Non-bonded: Lennard-Jones, Coulomb Bonded: Harmonic, cosine-harmonic, cosine series expansion Constraints Berendsen temperature and pressure coupling Simulated annealing Periodic boundary conditions Fixed atoms Integrator Verlet Leap-frog scheme Energy minimization Force fields PumMa (native) CHARMM / GROMOS 8/41

9 Potentials Van der Waals Van der Waals interactions are modeled through the well known Lennard-Jones potential: where in PumMa: Interaction strength is given pair-wise, while the collision diameter is determined from the Van der Waals radii Potential is truncated at a certain cut-off distance and shifted to remain continuous 9/41

10 Potentials - Electrostatic Electrostatic interactions are modeled through the Coulomb relation Interaction is truncated and shifted beyond a certain cut-off distance No Ewald or Multipole method is incorporated q i q j = +1 q i q j = 1 How to deal with coarse grained electrostatics? r ij 10/41

11 Potentials - Bonds Bonds are modeled by the harmonic potential Force constant can be derived from the approximation of Morse potential around its minimum harmonic Morse r ij r 0 11/41

12 Potentials Angles Angles can are modeled in two ways in PumMa, either harmonic or cosine harmonic Besides the functional form difference of the potentials, their implementation in the force calculating routine is equal Urey-Bradley potential is also incorporated Angle potential routine easily extendible with new functional forms 12/41

13 Potentials - Dihedrals Dihedral angles are modeled by either a cosine series expansion or a harmonic function 4 The cosine expansion is used in atomistic simulations; however, in coarse grained simulations this form might not be valid any more, hence the harmonic form θijkl [ ] /41

14 Potentials - Impropers Improper torsions are modeled with a harmonic potential only They are used to planarize structures aromatic rings R H N R' R H N + R' O amides O N + vs. N 14/41

15 Constraints Temperature coupling To control temperature PumMa is equipped with the Berendsen thermostat Instantaneous temperature is given by For coupling target temperature T 0 and coupling constant λ c need to be known Every time step velocities are scaled with λ If λ c =0 no temperature coupling is employed, while λ c =1 is a direct coupling. Normally a loose coupling is desired 15/41

16 Constraints Pressure coupling Similar to temperature coupling, the pressure in PumMa is also coupled through the Berendsen method The instantaneous pressure is given by with the rightmost term being the virial The pressure coupling constant is subsequently given by Every so often the positions are scaled with µ 16/41

17 Constraints Periodic Bound. Cond. PumMa is equiped with different boundary conditions, but the most common to use are periodic boundary conditions Each simulation box is surrounded by exact replicas (images) The smallest distance between is calculated (minimum image conv.) Only orthorhombic cells are possible Be aware of long range interactions across periodic boundaries 17/41

18 Constraints Other Simulated Annealing: Besides the option to keep the system at a desired temperature, it is also possible to gradually heat or cool the system Fixed atoms: It is also possible to specify a set of atoms which are not allowed to move However, all nonbonded interactions with these atoms are still evaluated Non-bonded exclusion: When using bond angles or dihedrals it can be desirable to exclude the 1-3 or 1-4 Van der Waals or Coulombic interactions However, its merits can be doubted when using coarse-grained systems 18/41

19 Integrator Verlet leapfrog (1) Position of particle around time t+ t which reduces to and similar for t- t Summing and neglecting higher order terms gives Verlet 19/41

20 Integrator Verlet leapfrog (2) Difference with the Verlet integrator is that the leapfrog integrator uses velocities at half integer time steps and From Verlets algorithm we obtain and Thus, the algorithm is 1. Calculate F(t). 2. Calculate new velocities v(t+δt/2) using v(t Δt/2) and F(t). 3. Calculate new positions r(t Δt/2) using r(t) and v(t Δt/2). 4. Repeat these steps until a certain stop criterium. 20/41

21 Integrator Verlet leapfrog (3) Although velocities and positions are separated by half a time step, they are internally treated as being at the same time step. The Verlet and Leapfrog scheme are algebraically identical. However, the leapfrog scheme is numerically more stable. Still caution is be taken when choosing the size of the time step The choice of an appropriate time step is important to prevent motions that develop too slow (left) or motions leading to instabilities (middle). With the appropriate time step collisions occur smoothly (right). 21/41

22 Overview Background History, current applications, and developers Features Potential functions Constraints Integrator Design Neighbor searching method Parallel implementation File format PumMa Toolkit Future release (major upgrade) Examples 22/41

23 Design Neighbor searching meth. Divide simulation box in multiple cells Cell z y x Simulation box Minimum number of cells in one simulation box is 27 By default, size of one cell equals the maximal Verlet radius 23/41

24 Design Neighbor searching meth. Divide simulation box in multiple cells Cell Stretched cell Number of cells can be increased by applying a cell stretch Search box becomes more spherical, hence, searching for neighbors is less time consuming There is a trade-off betweenn the number of stretched cells and speed-up 24/41

25 Design Parallel implementation Design of parallel implementation is based upon a toroidial transputer network Geometrical data decomposition Slab building through projection on x-y surface On two processes: Each process gets copies of the particles reciding on its right neighbor, this is the remote area Remote area Size of remote area depends on the number of stretched cells z y x Proc. 0 Proc. 1 25/41

26 Design File format PumMa uses a set of different files as its input or output All units are reduced* Reduced units are all chosen such that they are close to one Results in less inaccuracy during the computations Default values of reduced units are: Length: 1 σ* = 0.45 nm Energy: 1 ε* = 0.47 kcal/mol Mass: 1 m* = amu Charge: 1 q* = 1.0 e All others are derived from these (see Positions and topology are decoupled Every iteration has its own set of files (except for topology and parameters) 26/41

27 Input file (1) Default file name of the input file is inp.dat Its syntax is the option followed by its value White lines and lines starting with # are treated as comments # Integrator IT 0 max_it Dt # Temperature & Pressure T 1.3 lambdac P muc Prep 25 anisopress on # File dumping Erep 25 Crep 1000 sysfile sys outpfile outp.dat 27/41

28 Input file (2) Options for the Verlet list and cut-offs Rc 2.5 # Van der Waals cutoff radius factor Rl 0.9 # Factor specifying size of additional radius for pairlist RcCB 0.0 # Cutoff radius for Coulomb interactions (in reduced units) fixedrc -1 # Cutoff radius for all particle types (in reduced units) fixedrl -1 # Pairlist radius for all particle types (in reduced units) noshifts off # Disable shift function for nonbonded interactions vlrep 0 # Frequency of building pairlist again EpsR 1.0 # Dielectric constant Excl # Exclude Van der Waals 1-3 interactions Excl # Exclude Van der Waals 1-4 interactions Simulated annealing Thold Trate Annrep 0.0 # Final temperature (in reduced units) 0.0 # Change in temperature per scaling 1000 # Temperature scaling every Annrep'th iteration And many more (see 28/41

29 Parameter file The parameter file is called pumma_parm Each parameter is identified by a letter Thereafter all specifications for that type of parameter follow A G A T A W B G G B G T B T T T G G G T G G T T G T G T G T T T T G T T T T T N G G L N G T T N G W L N T T L N T W T N W W L C G C T C W A = atom B = bond T = angle F = double angle D = dihedral I = improper N = non-bonded C = color 29/41

30 System configuration The system configuration file contains all information of the size of the system, the number of molecules and so on It is typically named sysit123.cfg The numbers are of course the current iteration number Every time an iteration is written to file a.cfg file is created DPPC 128 W /41

31 Topology file (1) For each molecule there exist a topology file The name of the topology file is X.mol Where X is the name of the molecule The topology file lists the sequence of atoms in a molecule, which atoms form bonds, angles, double angles, dihedrals, impropers. Also the charges of the atoms are in the topology file The first line is the most important line, since it tells PumMa how many lines to expect for parsing all the information 31/41

32 Topology file (2) A1 G 0.0 A2 G 0.0 A3 G 0.0 A4 G 0.0 A5 T 0.0 A6 T 0.0 A7 T 0.0 A8 T 0.0 A9 T 0.0 A10 T 0.0 A11 T 0.0 A12 T T ++ T ++ T ++ T - G T ++ T ++ T ++ T - G - G - G /41

33 Coordinates & Velocities The coordinates and velocities of all particles are stored in a separate file for each molecule (.pcb) The order of the lines corresponds to the order given in the topology file (for that molecule) Information is supplied per molecule (so first molecule 1, than molecule 2, and so on) The first three columns are the positions, the last three colums the velocities /41

34 Output files Depending on options set in simulation input file, multiple configuration files (both system and coordinates) are written to file (eg. sysit100.cfg, DPPCIT100.pcb, etc.) Energies are reported to the file specified by outpfile, by default outp.dat Iteration; energies (Lennard-Jones, bonded, angle, dihedral, impropers, Coulomb, kinetic, tota); density; pressure; target temperature (annealing only) 34/41

35 File format - Overview So, for a lipid bilayer (water and DPPC) system one typically has One input option file: inp.dat One parameter file: pumma_parm Two topology files: W.mol and DPPC.mol Two coordinate files: WIT0.pcb and DPPCIT0.pcb One system configuration file: sysit0.cfg A more extensive overview of the input file format and all the options can be found at the webpage 35/41

36 Overview Background History, current applications, and developers Features Potential functions Constraints Integrator Design Neighbor searching method Parallel implementation File format PumMa Toolkit Future release (major upgrade) Examples 36/41

37 PumMa Toolkit PumMaTK Next to the MD code a toolkit has been developed Written in Python, with modules in ANSI C Has both graphical front-end and command line interfaces Purpose of graphical front-end is: Easy method to construct initial configuration from scratch Adapt (merge, crop, etc.) current configurations Assign parameters Analyze current configuration (eg. velocity distribution) Purpose of command line interface: Convert PumMa files to VMD-readable DCD/PSF files Some basic analysis (eg. volume, surface area) Create POVray files for nice pictures 37/41

38 PumMaTK Graphical front-end 38/41

39 Overview Background History, current applications, and developers Features Potential functions Constraints Integrator Design Neighbor searching method Parallel implementation File format PumMa Toolkit Future release (major upgrade) Examples 39/41

40 Future release PumMa is still changing at a rapid speed Many options are now decided upon compiling the code In the next version these options will be available through the input files rather than compiling a new binary File format will probably be updated to suit the current complex topology files Possibly the format will be XML-like PumMa is currently used by three other groups than ours Energy Technology (van Steenhoven, Eindhoven) Macromolecular Chemistry (Meijer, Eindhoven) Immunology (Vaidehi, City of Hope) 40/41

41 Questions? 41/41

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

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

More information

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

The Molecular Dynamics Method

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

More information

Lecture 11: Potential Energy Functions

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

More information

Introduction to molecular dynamics

Introduction to molecular dynamics 1 Introduction to molecular dynamics Yves Lansac Université François Rabelais, Tours, France Visiting MSE, GIST for the summer Molecular Simulation 2 Molecular simulation is a computational experiment.

More information

What is Classical Molecular Dynamics?

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

More information

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

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

More information

Molecular 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

A Nobel Prize for Molecular Dynamics and QM/MM What is Classical Molecular Dynamics? Simulation of explicit particles (atoms, ions,... ) Particles interact via relatively simple analytical potential

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

Bioengineering 215. An Introduction to Molecular Dynamics for Biomolecules

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

More information

Computation of non-bonded interactions: Part 1

Computation of non-bonded interactions: Part 1 Computation of non-bonded interactions: Part 1 Computation of non-local (non-bonded) interactions in the potential function E p non-local scales with the number of atoms as N. For the large molecular systems

More information

Why study protein dynamics?

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

More information

Introduction to Simulation - Lectures 17, 18. Molecular Dynamics. Nicolas Hadjiconstantinou

Introduction to Simulation - Lectures 17, 18. Molecular Dynamics. Nicolas Hadjiconstantinou Introduction to Simulation - Lectures 17, 18 Molecular Dynamics Nicolas Hadjiconstantinou Molecular Dynamics Molecular dynamics is a technique for computing the equilibrium and non-equilibrium properties

More information

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

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

More information

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

Supplementary Information for: Controlling Cellular Uptake of Nanoparticles with ph-sensitive Polymers

Supplementary Information for: Controlling Cellular Uptake of Nanoparticles with ph-sensitive Polymers Supplementary Information for: Controlling Cellular Uptake of Nanoparticles with ph-sensitive Polymers Hong-ming Ding 1 & Yu-qiang Ma 1,2, 1 National Laboratory of Solid State Microstructures and Department

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

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

Advanced Molecular Molecular Dynamics

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

More information

Molecular Dynamics. A very brief introduction

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

More information

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

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

More information

Chapter 11 Molecular Mechanics

Chapter 11 Molecular Mechanics Chapter 11 Molecular Mechanics Molecular Mechanics uses an analytical, differentiable, and relatively simple potential energy function, (R), for describing the interactions between a set of atoms specified

More information

Computer simulation methods (2) Dr. Vania Calandrini

Computer simulation methods (2) Dr. Vania Calandrini Computer simulation methods (2) Dr. Vania Calandrini in the previous lecture: time average versus ensemble average MC versus MD simulations equipartition theorem (=> computing T) virial theorem (=> computing

More information

LAMMPS Performance Benchmark on VSC-1 and VSC-2

LAMMPS Performance Benchmark on VSC-1 and VSC-2 LAMMPS Performance Benchmark on VSC-1 and VSC-2 Daniel Tunega and Roland Šolc Institute of Soil Research, University of Natural Resources and Life Sciences VSC meeting, Neusiedl am See, February 27-28,

More information

A Molecular Dynamics Simulation of a Homogeneous Organic-Inorganic Hybrid Silica Membrane

A Molecular Dynamics Simulation of a Homogeneous Organic-Inorganic Hybrid Silica Membrane A Molecular Dynamics Simulation of a Homogeneous Organic-Inorganic Hybrid Silica Membrane Supplementary Information: Simulation Procedure and Physical Property Analysis Simulation Procedure The molecular

More information

Molecular Mechanics. Yohann Moreau. November 26, 2015

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

More information

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

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

More information

Efficient Parallelization of Molecular Dynamics Simulations on Hybrid CPU/GPU Supercoputers

Efficient Parallelization of Molecular Dynamics Simulations on Hybrid CPU/GPU Supercoputers Efficient Parallelization of Molecular Dynamics Simulations on Hybrid CPU/GPU Supercoputers Jaewoon Jung (RIKEN, RIKEN AICS) Yuji Sugita (RIKEN, RIKEN AICS, RIKEN QBiC, RIKEN ithes) Molecular Dynamics

More information

Non-bonded interactions

Non-bonded interactions speeding up the number-crunching Marcus Elstner and Tomáš Kubař May 8, 2015 why care? key to understand biomolecular structure and function binding of a ligand efficiency of a reaction color of a chromophore

More information

Computational Chemistry - MD Simulations

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

More information

FENZI: GPU-enabled Molecular Dynamics Simulations of Large Membrane Regions based on the CHARMM force field and PME

FENZI: GPU-enabled Molecular Dynamics Simulations of Large Membrane Regions based on the CHARMM force field and PME 211 IEEE International Parallel & Distributed Processing Symposium : GPU-enabled Molecular Dynamics Simulations of Large Membrane Regions based on the force field and PME Narayan Ganesan, Michela Taufer

More information

Example questions for Molecular modelling (Level 4) Dr. Adrian Mulholland

Example questions for Molecular modelling (Level 4) Dr. Adrian Mulholland Example questions for Molecular modelling (Level 4) Dr. Adrian Mulholland 1) Question. Two methods which are widely used for the optimization of molecular geometies are the Steepest descents and Newton-Raphson

More information

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

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

More information

JASS Modeling and visualization of molecular dynamic processes

JASS Modeling and visualization of molecular dynamic processes JASS 2009 Konstantin Shefov Modeling and visualization of molecular dynamic processes St Petersburg State University, Physics faculty, Department of Computational Physics Supervisor PhD Stepanova Margarita

More information

Molecular Dynamics 9/6/16

Molecular Dynamics 9/6/16 Molecular Dynamics What to choose in an integrator The Verlet algorithm Boundary Conditions in Space and time Reading Assignment: Lesar Chpt 6, F&S Chpt 4 1 The Molecular Dynamics (MD) method for classical

More information

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

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

More information

TOPOLOGIES AND FORCE FIELD PARAMETERS FOR NITROXIDE SPIN LABELS

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

More information

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

Advanced Molecular Dynamics

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

More information

Protein-mineral interactions: molecular dynamics simulations capture importance of variations in mineral surface composition and structure

Protein-mineral interactions: molecular dynamics simulations capture importance of variations in mineral surface composition and structure Supplemental Information for: Protein-mineral interactions: molecular dynamics simulations capture importance of variations in mineral surface composition and structure Amity Andersen, *,1 Patrick N. Reardon,

More information

Principles and Applications of Molecular Dynamics Simulations with NAMD

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

More information

Non-bonded interactions

Non-bonded interactions speeding up the number-crunching continued Marcus Elstner and Tomáš Kubař December 3, 2013 why care? number of individual pair-wise interactions bonded interactions proportional to N: O(N) non-bonded interactions

More information

Van Gunsteren et al. Angew. Chem. Int. Ed. 45, 4064 (2006)

Van Gunsteren et al. Angew. Chem. Int. Ed. 45, 4064 (2006) Van Gunsteren et al. Angew. Chem. Int. Ed. 45, 4064 (2006) Martini Workshop 2015 Coarse Graining Basics Alex de Vries Every word or concept, clear as it may seem to be, has only a limited range of applicability

More information

Molecular Dynamics. What to choose in an integrator The Verlet algorithm Boundary Conditions in Space and time Reading Assignment: F&S Chapter 4

Molecular Dynamics. What to choose in an integrator The Verlet algorithm Boundary Conditions in Space and time Reading Assignment: F&S Chapter 4 Molecular Dynamics What to choose in an integrator The Verlet algorithm Boundary Conditions in Space and time Reading Assignment: F&S Chapter 4 MSE485/PHY466/CSE485 1 The Molecular Dynamics (MD) method

More information

Molecular Dynamics Simulations

Molecular Dynamics Simulations Molecular Dynamics Simulations Dr. Kasra Momeni www.knanosys.com Outline Long-range Interactions Ewald Sum Fast Multipole Method Spherically Truncated Coulombic Potential Speeding up Calculations SPaSM

More information

Methods of Computer Simulation. Molecular Dynamics and Monte Carlo

Methods of Computer Simulation. Molecular Dynamics and Monte Carlo Molecular Dynamics Time is of the essence in biological processes therefore how do we understand time-dependent processes at the molecular level? How do we do this experimentally? How do we do this computationally?

More information

Using Molecular Dynamics to Compute Properties CHEM 430

Using Molecular Dynamics to Compute Properties CHEM 430 Using Molecular Dynamics to Compute Properties CHEM 43 Heat Capacity and Energy Fluctuations Running an MD Simulation Equilibration Phase Before data-collection and results can be analyzed the system

More information

CECAM Tutorial Stuttgart, Oct. 2012

CECAM Tutorial Stuttgart, Oct. 2012 CECAM Tutorial Stuttgart, Oct. 2012 09.10.2012 ESPResSo++ CECAM Tutorial 1 / 40 ESPResSo++ ESPResSo++ is an open-source simulation package designed to perform molecular dynamics and monte carlo simulations

More information

Computational Molecular Biophysics. Computational Biophysics, GRS Jülich SS 2013

Computational Molecular Biophysics. Computational Biophysics, GRS Jülich SS 2013 Computational Molecular Biophysics Computational Biophysics, GRS Jülich SS 2013 Computational Considerations Number of terms for different energy contributions / E el ~N ~N ~N ~N 2 Computational cost for

More information

Structuring of hydrophobic and hydrophilic polymers at interfaces Stephen Donaldson ChE 210D Final Project Abstract

Structuring of hydrophobic and hydrophilic polymers at interfaces Stephen Donaldson ChE 210D Final Project Abstract Structuring of hydrophobic and hydrophilic polymers at interfaces Stephen Donaldson ChE 210D Final Project Abstract In this work, a simplified Lennard-Jones (LJ) sphere model is used to simulate the aggregation,

More information

Molecular Mechanics / ReaxFF

Molecular Mechanics / ReaxFF Molecular Dynamics simulations Lecture 09: Molecular Mechanics / ReaxFF Dr. Olli Pakarinen University of Helsinki Fall 2012 Lecture notes based on notes by Dr. Jani Kotakoski, 2010 CONTENTS Molecular mechanics

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

Force fields, thermo- and barostats. Berk Hess

Force fields, thermo- and barostats. Berk Hess Force fields, thermo- and barostats Berk Hess What is a force field? A force field usually consists of three parts: a set of functional forms parameters for the functional forms that, usually, depend on

More information

This semester. Books

This semester. Books Models mostly proteins from detailed to more abstract models Some simulation methods This semester Books None necessary for my group and Prof Rarey Molecular Modelling: Principles and Applications Leach,

More information

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

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

More information

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

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

More information

Biomolecular modeling I

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

More information

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

Molecular Dynamics, Monte Carlo and Docking. Lecture 21. Introduction to Bioinformatics MNW2 Molecular Dynamics, Monte Carlo and Docking Lecture 21 Introduction to Bioinformatics MNW2 If you throw up a stone, it is Physics. If you throw up a stone, it is Physics. If it lands on your head, it is

More information

Optimizing GROMACS for parallel performance

Optimizing GROMACS for parallel performance Optimizing GROMACS for parallel performance Outline 1. Why optimize? Performance status quo 2. GROMACS as a black box. (PME) 3. How does GROMACS spend its time? (MPE) 4. What you can do What I want to

More information

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

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

More information

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

MARTINI simulation details

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

More information

Supporting information

Supporting information Electronic Supplementary Material ESI for Physical Chemistry Chemical Physics. This journal is the Owner Societies 2018 Supporting information Understanding three-body contributions to coarse-grained force

More information

The GROMOS Software for (Bio)Molecular Simulation

The GROMOS Software for (Bio)Molecular Simulation The GROMOS Software for (Bio)Molecular Simulation Volume 2: Algorithms and Formulae for Modelling of Molecular Systems September 28, 2017 Contents Chapter 1. Introduction 2-1 Chapter 2. Basic choices

More information

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

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

More information

The Molecular Dynamics Simulation Process

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

More information

Multi-Scale Hierarchical Structure Prediction of Helical Transmembrane Proteins

Multi-Scale Hierarchical Structure Prediction of Helical Transmembrane Proteins Multi-Scale Hierarchical Structure Prediction of Helical Transmembrane Proteins Zhong Chen Dept. of Biochemistry and Molecular Biology University of Georgia, Athens, GA 30602 Email: zc@csbl.bmb.uga.edu

More information

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

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

More information

Force fields in computer simulation of soft nanomaterials

Force fields in computer simulation of soft nanomaterials Lecture 2 Part B Force fields in computer simulation of soft nanomaterials Recommended reading: Leach Chapter 4 1 Force Field Methods Force field methods are simulation methods that use classical force

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

PH 548 Atomistic Simulation Techniques

PH 548 Atomistic Simulation Techniques PH 548 Atomistic Simulation Techniques Lectures: Lab: 2-0-2-6 Tuesday 12-1 PM Thursday 12-1 PM Monday 2-5 PM P. K. Padmanabhan PH548: Two Excellent Books How to do it? 1 2 F 12 F 23 3 F i = F ij j i F

More information

A Control Algorithm for Multiscale Simulations of Liquid Water

A Control Algorithm for Multiscale Simulations of Liquid Water A Control Algorithm for Multiscale Simulations of Liquid Water Evangelos M. Kotsalis and Petros Koumoutsakos Computational Science, ETH Zürich, CH-8092, Switzerland petros@ethz.ch Abstract. We present

More information

Introduction to model potential Molecular Dynamics A3hourcourseatICTP

Introduction to model potential Molecular Dynamics A3hourcourseatICTP Introduction to model potential Molecular Dynamics A3hourcourseatICTP Alessandro Mattoni 1 1 Istituto Officina dei Materiali CNR-IOM Unità di Cagliari SLACS ICTP School on numerical methods for energy,

More information

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

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

More information

Viscous Flow Computations with Molecular Dynamics

Viscous Flow Computations with Molecular Dynamics FAKULTÄT FÜR INFORMATIK DER TECHNISCHEN UNIVERSITÄT MÜNCHEN Bachelorarbeit in Informatik Viscous Flow Computations with Molecular Dynamics Ching-Yu Kao FAKULTÄT FÜR INFORMATIK DER TECHNISCHEN UNIVERSITÄT

More information

) (3) Structure Optimization Combining Soft-Core Interaction Functions, the Diffusion Equation Method, and Molecular Dynamics

) (3) Structure Optimization Combining Soft-Core Interaction Functions, the Diffusion Equation Method, and Molecular Dynamics 5926 J. Phys. Chem. A 1997, 101, 5926-5930 Structure Optimization Combining Soft-Core Interaction Functions, the Diffusion Equation Method, and Molecular Dynamics Thomas Huber, Andrew E. Torda, and Wilfred

More information

Molecular Dynamics Simulation of a Nanoconfined Water Film

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

More information

Metropolis, 2D Ising model

Metropolis, 2D Ising model Metropolis, 2D Ising model You can get visual understanding from the java applets available, like: http://physics.ucsc.edu/~peter/ising/ising.html Average value of spin is magnetization. Abs of this as

More information

Crystal Structure Prediction using CRYSTALG program

Crystal Structure Prediction using CRYSTALG program Crystal Structure Prediction using CRYSTALG program Yelena Arnautova Baker Laboratory of Chemistry and Chemical Biology, Cornell University Problem of crystal structure prediction: - theoretical importance

More information

Molecular Dynamics Simulation of Nanometric Machining Under Realistic Cutting Conditions Using LAMMPS

Molecular Dynamics Simulation of Nanometric Machining Under Realistic Cutting Conditions Using LAMMPS Molecular Dynamics Simulation of Nanometric Machining Under Realistic Cutting Conditions Using LAMMPS Rapeepan Promyoo Thesis Presentation Advisor: Dr. Hazim El-Mounayri Department of Mechanical Engineering

More information

Solutions to Assignment #4 Getting Started with HyperChem

Solutions to Assignment #4 Getting Started with HyperChem Solutions to Assignment #4 Getting Started with HyperChem 1. This first exercise is meant to familiarize you with the different methods for visualizing molecules available in HyperChem. (a) Create a molecule

More information

The Potential Energy Surface (PES) And the Basic Force Field Chem 4021/8021 Video II.iii

The Potential Energy Surface (PES) And the Basic Force Field Chem 4021/8021 Video II.iii The Potential Energy Surface (PES) And the Basic Force Field Chem 4021/8021 Video II.iii Fundamental Points About Which to Be Thinking It s clear the PES is useful, so how can I construct it for an arbitrary

More information

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

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

More information

Biomolecular modeling I

Biomolecular modeling I 2016, December 6 Biomolecular structure Structural elements of life Biomolecules proteins, nucleic acids, lipids, carbohydrates... Biomolecular structure Biomolecules biomolecular complexes aggregates...

More information

CE 530 Molecular Simulation

CE 530 Molecular Simulation 1 CE 530 Molecular Simulation Lecture 14 Molecular Models David A. Kofke Department of Chemical Engineering SUNY Buffalo kofke@eng.buffalo.edu 2 Review Monte Carlo ensemble averaging, no dynamics easy

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

T6.2 Molecular Mechanics

T6.2 Molecular Mechanics T6.2 Molecular Mechanics We have seen that Benson group additivities are capable of giving heats of formation of molecules with accuracies comparable to those of the best ab initio procedures. However,

More information

Free energy calculations of small molecules in dense amorphous polymers. Effect of the initial guess configuration in molecular dynamics studies

Free energy calculations of small molecules in dense amorphous polymers. Effect of the initial guess configuration in molecular dynamics studies Free energy calculations of small molecules in dense amorphous polymers. Effect of the initial guess configuration in molecular dynamics studies Nico F. A. van der Vegt Chemical Physics Laboratory and

More information

Supporting Information for: Physics Behind the Water Transport through. Nanoporous Graphene and Boron Nitride

Supporting Information for: Physics Behind the Water Transport through. Nanoporous Graphene and Boron Nitride Supporting Information for: Physics Behind the Water Transport through Nanoporous Graphene and Boron Nitride Ludovic Garnier, Anthony Szymczyk, Patrice Malfreyt, and Aziz Ghoufi, Institut de Physique de

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

NWChem: Molecular Dynamics and QM/MM

NWChem: Molecular Dynamics and QM/MM NWChem: Molecular Dynamics and QM/MM Molecular Dynamics Functionality Target systems: General features: biomolecules (proteins, DNA/RNA, biomembranes) energy evaluation (SP) energy minimization (EM) molecular

More information

Coupling the Level-Set Method with Variational Implicit Solvent Modeling of Molecular Solvation

Coupling the Level-Set Method with Variational Implicit Solvent Modeling of Molecular Solvation Coupling the Level-Set Method with Variational Implicit Solvent Modeling of Molecular Solvation Bo Li Math Dept & CTBP, UCSD Li-Tien Cheng (Math, UCSD) Zhongming Wang (Math & Biochem, UCSD) Yang Xie (MAE,

More information

Error Analysis of the Poisson P 3 MForce Field Scheme for Particle-Based Simulations of Biological Systems

Error Analysis of the Poisson P 3 MForce Field Scheme for Particle-Based Simulations of Biological Systems Journal of Computational Electronics 4: 179 183, 2005 c 2005 Springer Science + Business Media, Inc. Manufactured in The Netherlands. Error Analysis of the Poisson P 3 MForce Field Scheme for Particle-Based

More information

Biomolecules are dynamic no single structure is a perfect model

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

More information

Molecular Dynamics. The Molecular Dynamics (MD) method for classical systems (not H or He)

Molecular Dynamics. The Molecular Dynamics (MD) method for classical systems (not H or He) Molecular Dynamics What to choose in an integrator The Verlet algorithm Boundary Conditions in Space and time Reading Assignment: F&S Chapter 4 1 The Molecular Dynamics (MD) method for classical systems

More information

Molecular Dynamics Study on the Binary Collision of Nanometer-Sized Droplets of Liquid Argon

Molecular Dynamics Study on the Binary Collision of Nanometer-Sized Droplets of Liquid Argon Molecular Dynamics Study on the Binary Collision Bull. Korean Chem. Soc. 2011, Vol. 32, No. 6 2027 DOI 10.5012/bkcs.2011.32.6.2027 Molecular Dynamics Study on the Binary Collision of Nanometer-Sized Droplets

More information

Department of Chemical Engineering University of California, Santa Barbara Spring Exercise 3. Due: Thursday, 5/3/12

Department of Chemical Engineering University of California, Santa Barbara Spring Exercise 3. Due: Thursday, 5/3/12 Department of Chemical Engineering ChE 210D University of California, Santa Barbara Spring 2012 Exercise 3 Due: Thursday, 5/3/12 Objective: To learn how to write & compile Fortran libraries for Python,

More information

From Atoms to Materials: Predictive Theory and Simulations

From Atoms to Materials: Predictive Theory and Simulations From Atoms to Materials: Predictive Theory and Simulations Week 3 Lecture 4 Potentials for metals and semiconductors Ale Strachan strachan@purdue.edu School of Materials Engineering & Birck anotechnology

More information

Diffusion of Water and Diatomic Oxygen in Poly(3-hexylthiophene) Melt: A Molecular Dynamics Simulation Study

Diffusion of Water and Diatomic Oxygen in Poly(3-hexylthiophene) Melt: A Molecular Dynamics Simulation Study Diffusion of Water and Diatomic Oxygen in Poly(3-hexylthiophene) Melt: A Molecular Dynamics Simulation Study Julia Deitz, Yeneneh Yimer, and Mesfin Tsige Department of Polymer Science University of Akron

More information