accelerated Molecular Dynamics (amd) Tutorial Levi Pierce 2012 NBCR Summer InsAtute

Size: px
Start display at page:

Download "accelerated Molecular Dynamics (amd) Tutorial Levi Pierce 2012 NBCR Summer InsAtute"

Transcription

1 accelerated Molecular Dynamics (amd) Tutorial Levi Pierce 2012 NBCR Summer InsAtute

2 Time Scales Accessible with Molecular Dynamics Pierce, L.C.T.; Salomon- Ferrer, R.; de Oliveira C.A.; McCammon, J.A.; Walker, R.C.; RouAne Access to Millisecond Timescales with Accelerated Molecular Dynamics. in press 2

3 Molecular Dynamics Δt... Δt Ensemble of structures McCammon J. A., Gelin, B. R., Karplus M. Nature 267, 585 (1977) 3

4 MoAvaAon Why do we need to accelerate molecular dynamics? Can we just increase our Ame step used for integraaon? Can we just heat our system up?

5 Accelerated Molecular Dynamics Add a bias to our potenaal energy surface to promote escape from energeac traps. EquaAon as applied to total potenaal energy!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! The corrected canonical ensemble average of a given property, <A> c can be obtained by reweighang each point in the configuraaon space on the modified potenaal by the strength of the Boltzmann factor of the bias energy, exp(βδv(r, t i )) 5

6 LimitaAons of amd In 2008 code was not efficiently parallelized Sander amd implementaaon is slow BPTI Simula<on 17,758 Atoms ns/day Number of Processors sander amd How can we accelerate amd? Port method to faster codes (pmemd,namd) Use Graphics Processing Units (GPUs) 6

7 ComputaAon on the GPU Why are they so fast? Lots of relaavely fast workers vs a few fast workers Cluster (48 processors operaang at 2.6GHz) 30ns/day 1GTX 580 (512 processors operaang at 770MHz) 40ns/day Why are they so popular now? Compute Unified Design Architecture (CUDA) GPU molecular dynamics codes ACEMD hkp://mulascalelab.org/acemd OPENMM hkps://simtk.org/home/openmm AMBER (pmemd.cuda) hkp://ambermd.org/gpus/ NAMD hkp:// 7

8 ImplemenAng amd on the GPU First ported sander amd to pmemd Next ported amd to pmemd.cuda 1 GTX ns/day cmd 1 GTX ns/day amd How fast can we run amd? 2 GTX ns/day amd How can we validate our implementaaon? ns/day ns/day ns/day BPTI 17,758 atoms NVT Number of of Processors Number of Processors PMEaMD PMEaMD PMEaMD sander amd sander amd sander amd GTX580 amd NAMD amd GTX580 amd Lindert, S.; Kekenes- Huskey, P.; Huber, G.; Pierce, L.C.T.; McCammon, J.A.; Dynamics and Calcium AssociaAon to the N- Terminal Regulatory Domain of Human Cardiac Troponin C: A MulA- Scale ComputaAonal Study. J. Chem. Phys. B Wang, Y., et. al., ImplementaAon of Accelerated Molecular Dynamics in NAMD. Computa,onal Science & Discovery,

9 Protocol Outline Run convenaonal molecular dynamics unal dihedral and total potenaal energy are converged usually 10-50ns is all that is needed Compute the Ecut and alpha needed for boosang dihedral potenaal Compute Ecut and alpha needed for boosang total potenaal Fire off amd simulaaon!

10 Amber12 BPTI Example Step 1 Running ConvenAonal Molecular Dynamics (cmd) I generally run 10ns of NVT dynamics and then look at the output log for the average total potenaal energy and dihedral energy You can also grep EPtot and DIHED out from your log file and compute the averages A V E R A G E S O V E R S T E P S NSTEP = TIME(PS) = TEMP(K) = PRESS = 0.0 Etot = EKtot = EPtot = BOND = ANGLE = DIHED = NB = EEL = VDWAALS = EELEC = EHBOND = RESTRAINT =

11 Amber12 BPTI Example Step 2 Compute EthreshP and alphap First calculate alphap from the total number of atoms alphap= (0.16kcal mol - 1 atom - 1 * 18,226 atoms) = 2916 kcal mol - 1 To calculate EthreshP you need the average Eptot and the total number of atoms in your system EthreshP= kcal mol alphap = kcal mol - 1 Grant, B. J.; Gorfe, A. A.; McCammon, J. A., Ras conformaaonal switching: simulaang nucleoade- dependent conformaaonal transiaons with accelerated molecular dynamics. PLoS Comput. Biol. 2009, 5, (3), e de Oliveira, C. A. F.; Grant, B. J.; Zhou, M.; McCammon, J. A., Large- Scale ConformaAonal Changes of Trypanosoma cruzi Proline Racemase Predicted by Accelerated Molecular Dynamics SimulaAon. PLoS Comput. Biol. 2011, 7, (10), e

12 Amber12 BPTI Example Step 3 Compute EthreshD and alphad First calculate alphap from the total number of solute residues alphad= (1/5)*(4kcal mol - 1 residue - 1 * 58 solute residues) = 827 kcal mol - 1 To calculate EthreshD you need the average DIHED and the total number of solute residues in your system EthreshD= 595 kcal mol (4kcal mol - 1 residue - 1 * 58 solute residues) = 46.4 kcal mol - 1 Grant, B. J.; Gorfe, A. A.; McCammon, J. A., Ras conformaaonal switching: simulaang nucleoade- dependent conformaaonal transiaons with accelerated molecular dynamics. PLoS Comput. Biol. 2009, 5, (3), e de Oliveira, C. A. F.; Grant, B. J.; Zhou, M.; McCammon, J. A., Large- Scale ConformaAonal Changes of Trypanosoma cruzi Proline Racemase Predicted by Accelerated Molecular Dynamics SimulaAon. PLoS Comput. Biol. 2011, 7, (10), e

13 Amber12 BPTI Example Step 4 Run amd SimulaAon! For the GPU version simply run pmemd.cuda - O - i amd.in - o amd1.out - r amd1.rst - x amd1.nc - p bpa.prmtop - c eq.rst For the effeciently parallelized CPU version run mpirun - np NPROCS pmemd.mpi - O - i amd.in - o amd1.out - r amd1.rst - x amd1.nc - p bpa.prmtop - c eq.rst For the inefficient CPU version run mpirun - np NPROCS sander.mpi - O - i amd.in - o amd1.out - r amd1.rst - x amd1.nc - p bpa.prmtop - c eq.rst amd.in (NVT- CONTINUE) &cntrl imin=0,irest=1,ntx=5, nstlim= ,dt=0.002, ntc=2,nv=2,ig=- 1, cut=10.0, ntb=1, ntp=0, ntpr=1000, ntwx=1000, nk=3, gamma_ln=2.0, temp0=300.0,iouvm=1, iamd=3,iwrap=1, EthreshD=827, alphad=46.4,ethresp= , alphap=2916, /

14 Examining Results How do we observe more sampling from amd compared to MD? PhiPsi plots of dihedral angles RMSD Principal Component Analysis

15 ReweighAng Using the true exponenaal Alanine DipepAde Using approximaaons to the exponenaal BPTI

16 Useful links hkp://ambermd.org/gpus/ amd on NAMD hkp:// ug/node63.html

Routine access to millisecond timescale events with accelerated molecular dynamics

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

More information

enhanced sampling methods recovering <a> Accelerated MD Introduction to Accelerated Molecular Dynamics an enhanced sampling method

enhanced sampling methods recovering <a> Accelerated MD Introduction to Accelerated Molecular Dynamics an enhanced sampling method enhanced sampling methods Introduction to Accelerated Molecular Dynamics an enhanced sampling method Yi Wang McCammon group Aug 2011, NBCR Summer Institute Umbrella sampling B. ROUX, "The calculation of

More information

Thomas E. Cheatham III

Thomas E. Cheatham III NSF OCI-1036208: PRAC Hierarchical molecular dynamics sampling for assessing pathways and free energies of RNA catalysis, ligand binding, and conformational change. NEIS-P2 update, May 2013 Thomas E. Cheatham

More information

Metadynamics. Day 2, Lecture 3 James Dama

Metadynamics. Day 2, Lecture 3 James Dama Metadynamics Day 2, Lecture 3 James Dama Metadynamics The bare bones of metadynamics Bias away from previously visited configuraaons In a reduced space of collecave variables At a sequenaally decreasing

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

w REXAMD: A Hamiltonian Replica Exchange Approach to Improve Free Energy Calculations for Systems with Kinetically Trapped Conformations

w REXAMD: A Hamiltonian Replica Exchange Approach to Improve Free Energy Calculations for Systems with Kinetically Trapped Conformations pubs.acs.org/jctc Downloaded via 148.251.232.83 on March 8, 2019 at 14:33:02 (UTC). See https://pubs.acs.org/sharingguidelines for options on how to legitimately share published articles. w REXAMD: A Hamiltonian

More information

Speed Without Compromise: Rethinking Precision in MD Calculations in the Era of Vanishing Double Precision FloPs

Speed Without Compromise: Rethinking Precision in MD Calculations in the Era of Vanishing Double Precision FloPs Speed Without Compromise: Rethinking Precision in MD Calculations in the Era of Vanishing Double Precision FloPs Ross Walker, Associate Professor and NVIDIA CUDA Fellow San Diego Supercomputer Center UC

More information

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

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

More information

Improved Reweighting of Accelerated Molecular Dynamics Simulations for Free Energy Calculation

Improved Reweighting of Accelerated Molecular Dynamics Simulations for Free Energy Calculation This is an open access article published under an ACS AuthorChoice License, which permits copying and redistribution of the article or any adaptations for non-commercial purposes. pubs.acs.org/jctc Improved

More information

Generate topology (Gromacs)

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

More information

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

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

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

Molecular Dynamics. Molecules in motion

Molecular Dynamics. Molecules in motion Molecular Dynamics Molecules in motion 1 Molecules in mo1on Molecules are not sta1c, but move all the 1me Source: h9p://en.wikipedia.org/wiki/kine1c_theory 2 Gasses, liquids and solids Gasses, liquids

More information

Applications of the Spring. Force: molecules

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

More information

Molecular Dynamics Flexible Fitting

Molecular Dynamics Flexible Fitting Molecular Dynamics Flexible Fitting Ryan McGreevy Research Programmer University of Illinois at Urbana-Champaign NIH Resource for Macromolecular Modeling and Bioinformatics Molecular Dynamics Flexible

More information

VMD: Visual Molecular Dynamics. Our Microscope is Made of...

VMD: Visual Molecular Dynamics. Our Microscope is Made of... VMD: Visual Molecular Dynamics Computational Microscope / Tool to Think amino acid tyrosine enzymatic control BPTI VMD tutorial traficking Ubiquitin case study http://www.ks.uiuc.edu/training/casestudies/

More information

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

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

More information

STRUCTURAL BIOINFORMATICS. Barry Grant University of Michigan

STRUCTURAL BIOINFORMATICS. Barry Grant University of Michigan STRUCTURAL BIOINFORMATICS Barry Grant University of Michigan www.thegrantlab.org bjgrant@umich.edu Bergen, Norway 28-Sep-2015 Objective: Provide an introduction to the practice of structural bioinformatics,

More information

A microsecond a day keeps the doctor away: Efficient GPU Molecular Dynamics with GROMACS

A microsecond a day keeps the doctor away: Efficient GPU Molecular Dynamics with GROMACS GTC 20130319 A microsecond a day keeps the doctor away: Efficient GPU Molecular Dynamics with GROMACS Erik Lindahl erik.lindahl@scilifelab.se Molecular Dynamics Understand biology We re comfortably on

More information

Accelerating Rosetta with OpenMM. Peter Eastman. RosettaCon, August 5, 2010

Accelerating Rosetta with OpenMM. Peter Eastman. RosettaCon, August 5, 2010 Accelerating Rosetta with OpenMM Peter Eastman RosettaCon, August 5, 2010 What is OpenMM? OpenMM is a library for molecular modeling on high performance architectures. Performance 600 500 502 400 ns/day

More information

Parallelization of Molecular Dynamics (with focus on Gromacs) SeSE 2014 p.1/29

Parallelization of Molecular Dynamics (with focus on Gromacs) SeSE 2014 p.1/29 Parallelization of Molecular Dynamics (with focus on Gromacs) SeSE 2014 p.1/29 Outline A few words on MD applications and the GROMACS package The main work in an MD simulation Parallelization Stream computing

More information

Molecular Dynamics Simulation of a Biomolecule with High Speed, Low Power and Accuracy Using GPU-Accelerated TSUBAME2.

Molecular Dynamics Simulation of a Biomolecule with High Speed, Low Power and Accuracy Using GPU-Accelerated TSUBAME2. APSIPA ASC 2011 Xi an Molecular Dynamics Simulation of a Biomolecule with High Speed, Low Power and Accuracy Using GPU-Accelerated TSUBAME2.0 Supercomputer Shiqiao Du, Takuro Udagawa, Toshio Endo and Masakazu

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

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

Hierarchical Metastable States and Kinetic Transition Networks: Trajectory Mapping and Clustering

Hierarchical Metastable States and Kinetic Transition Networks: Trajectory Mapping and Clustering Hierarchical Metastable States and Kinetic Transition Networks: Trajectory Mapping and Clustering Xin Zhou xzhou@gucas.ac.cn Graduate University of Chinese Academy of Sciences, Beijing 2012.6.5 KITP, Santa

More information

Molecular dynamics simulation of Aquaporin-1. 4 nm

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

More information

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

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

More information

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

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

Efficient Molecular Dynamics on Heterogeneous Architectures in GROMACS

Efficient Molecular Dynamics on Heterogeneous Architectures in GROMACS Efficient Molecular Dynamics on Heterogeneous Architectures in GROMACS Berk Hess, Szilárd Páll KTH Royal Institute of Technology GTC 2012 GROMACS: fast, scalable, free Classical molecular dynamics package

More information

Performing Metadynamics Simulations Using NAMD

Performing Metadynamics Simulations Using NAMD Performing Metadynamics Simulations Using NAMD Author: Zhaleh Ghaemi Contents 1 Introduction 2 1.1 Goals of this tutorial.......................... 2 2 Standard metadynamics simulations 3 2.1 Free energy

More information

The Computational Microscope

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

More information

NIH Center for Macromolecular Modeling and Bioinformatics Developer of VMD and NAMD. Beckman Institute

NIH Center for Macromolecular Modeling and Bioinformatics Developer of VMD and NAMD. Beckman Institute NIH Center for Macromolecular Modeling and Bioinformatics Developer of VMD and NAMD 5 faculty members (2 physics, 1 chemistry, 1 biochemistry, 1 computer science); 8 developers; 1 system admin; 15 post

More information

Applications of Molecular Dynamics

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

More information

Characterizing Structural Transitions of Membrane Transport Proteins at Atomic Detail Mahmoud Moradi

Characterizing Structural Transitions of Membrane Transport Proteins at Atomic Detail Mahmoud Moradi Characterizing Structural Transitions of Membrane Transport Proteins at Atomic Detail Mahmoud Moradi NCSA Blue Waters Symposium for Petascale Science and Beyond Sunriver, Oregon May 11, 2015 Outline Introduction

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

Tips Geared Towards R. Adam J. Suarez. Arpil 10, 2015

Tips Geared Towards R. Adam J. Suarez. Arpil 10, 2015 Tips Geared Towards R Departments of Statistics North Carolina State University Arpil 10, 2015 1 / 30 Advantages of R As an interpretive and interactive language, developing an algorithm in R can be done

More information

CRYPTOGRAPHIC COMPUTING

CRYPTOGRAPHIC COMPUTING CRYPTOGRAPHIC COMPUTING ON GPU Chen Mou Cheng Dept. Electrical Engineering g National Taiwan University January 16, 2009 COLLABORATORS Daniel Bernstein, UIC, USA Tien Ren Chen, Army Tanja Lange, TU Eindhoven,

More information

Probing the Flexibility of Tropomyosin and Its Binding to Filamentous Actin Using Molecular Dynamics Simulations

Probing the Flexibility of Tropomyosin and Its Binding to Filamentous Actin Using Molecular Dynamics Simulations 1882 Biophysical Journal Volume 105 October 2013 1882 1892 Probing the Flexibility of Tropomyosin and Its Binding to Filamentous Actin Using Molecular Dynamics Simulations Wenjun Zheng, * Bipasha Barua,

More information

TR&D3: Brownian Mover DBP4: Biosensors

TR&D3: Brownian Mover DBP4: Biosensors TR&D3: Brownian Mover DBP4: Biosensors Aleksei Aksimentiev Lead co-investigator of TR&D3-BD and DBP4 Associate Professor of Physics, UIUC http://bionano.physics.illinois.edu/ TR&D3 Brownian Mover Overview

More information

Alchemical free energy calculations in OpenMM

Alchemical free energy calculations in OpenMM Alchemical free energy calculations in OpenMM Lee-Ping Wang Stanford Department of Chemistry OpenMM Workshop, Stanford University September 7, 2012 Special thanks to: John Chodera, Morgan Lawrenz Outline

More information

Choosing weights for simulated tempering

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

More information

Conformational sampling of macrocycles in solution and in the solid state

Conformational sampling of macrocycles in solution and in the solid state Conformational sampling of macrocycles in solution and in the solid state Paul Hawkins, Ph.D. Head of Scientific Solutions Stanislaw Wlodek, Ph.D. Senior Scientific Developer 6/6/2018 https://berkonomics.com/?p=2437

More information

Running MD on HPC architectures I. Hybrid Clusters

Running MD on HPC architectures I. Hybrid Clusters Running MD on HPC architectures I. Hybrid Clusters Alessandro Grottesi Cineca Today's lecture You will learn: Gromacs @ CINECA: set up and launch of simulations Launch MD code (GROMACS, NAMD) Optimize

More information

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

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

More information

What can be learnt from MD

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

More information

Molecular Dynamics Investigation of the ω-current in the Kv1.2 Voltage Sensor Domains

Molecular Dynamics Investigation of the ω-current in the Kv1.2 Voltage Sensor Domains Molecular Dynamics Investigation of the ω-current in the Kv1.2 Voltage Sensor Domains Fatemeh Khalili-Araghi, Emad Tajkhorshid, Benoît Roux, and Klaus Schulten Department of Physics, Department of Biochemistry,

More information

Molecular sampling is difficult!

Molecular sampling is difficult! Physics of trajectories and the weighted ensemble method Daniel M. Zuckerman Department of Computational & Systems Biology University of Pittsburgh School of Medicine Molecular sampling is difficult! BPTI

More information

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

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

More information

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

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

More information

NIH Center for Macromolecular Modeling and Bioinformatics Developer of VMD and NAMD. Beckman Institute

NIH Center for Macromolecular Modeling and Bioinformatics Developer of VMD and NAMD. Beckman Institute NIH Center for Macromolecular Modeling and Bioinformatics Developer of VMD and NAMD 5 faculty members (2 physics, 1 chemistry, 1 biochemistry, 1 computer science); 8 developers; 1 system admin; 15 post

More information

Investigation of an Unusual Phase Transition Freezing on heating of liquid solution

Investigation of an Unusual Phase Transition Freezing on heating of liquid solution Investigation of an Unusual Phase Transition Freezing on heating of liquid solution Calin Gabriel Floare National Institute for R&D of Isotopic and Molecular Technologies, Cluj-Napoca, Romania Max von

More information

arxiv: v1 [physics.chem-ph] 8 Mar 2010

arxiv: v1 [physics.chem-ph] 8 Mar 2010 arxiv:1003.1678v1 [physics.chem-ph] 8 Mar 2010 A new battery-charging method suggested by molecular dynamics simulations Ibrahim Abou Hamad 1,, M. A. Novotny 1,2, D. Wipf 3, and P. A. Rikvold 4 1 HPC 2,

More information

Accelerated Quantum Molecular Dynamics

Accelerated Quantum Molecular Dynamics Accelerated Quantum Molecular Dynamics Enrique Martinez, Christian Negre, Marc J. Cawkwell, Danny Perez, Arthur F. Voter and Anders M. N. Niklasson Outline Quantum MD Current approaches Challenges Extended

More information

22.6. Adaptively biased MD, steered MD, and umbrella sampling with REMD

22.6. Adaptively biased MD, steered MD, and umbrella sampling with REMD 22. Free energies 22.6. Adaptively biased MD, steered MD, and umbrella sampling with REMD 22.6.1. Overview The following describes a suite of modules useful for the calculation of the free energy associated

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

Supporting information to: Time-resolved observation of protein allosteric communication. Sebastian Buchenberg, Florian Sittel and Gerhard Stock 1

Supporting information to: Time-resolved observation of protein allosteric communication. Sebastian Buchenberg, Florian Sittel and Gerhard Stock 1 Supporting information to: Time-resolved observation of protein allosteric communication Sebastian Buchenberg, Florian Sittel and Gerhard Stock Biomolecular Dynamics, Institute of Physics, Albert Ludwigs

More information

A CUDA Solver for Helmholtz Equation

A CUDA Solver for Helmholtz Equation Journal of Computational Information Systems 11: 24 (2015) 7805 7812 Available at http://www.jofcis.com A CUDA Solver for Helmholtz Equation Mingming REN 1,2,, Xiaoguang LIU 1,2, Gang WANG 1,2 1 College

More information

Graphics Card Computing for Materials Modelling

Graphics Card Computing for Materials Modelling Graphics Card Computing for Materials Modelling Case study: Analytic Bond Order Potentials B. Seiser, T. Hammerschmidt, R. Drautz, D. Pettifor Funded by EPSRC within the collaborative multi-scale project

More information

Multiscale simulations of complex fluid rheology

Multiscale simulations of complex fluid rheology Multiscale simulations of complex fluid rheology Michael P. Howard, Athanassios Z. Panagiotopoulos Department of Chemical and Biological Engineering, Princeton University Arash Nikoubashman Institute of

More information

Dynamics and Calcium Association to the N-Terminal Regulatory Domain of Human Cardiac Troponin C: A Multiscale Computational Study

Dynamics and Calcium Association to the N-Terminal Regulatory Domain of Human Cardiac Troponin C: A Multiscale Computational Study pubs.acs.org/jpcb Dynamics and Calcium Association to the N-Terminal Regulatory Domain of Human Cardiac Troponin C: A Multiscale Computational Study Steffen Lindert,*, Peter M. Kekenes-Huskey, Gary Huber,

More information

MMTSB Toolset. Michael Feig MMTSB/CTBP 2006 Summer Workshop. MMTSB/CTBP Summer Workshop Michael Feig, 2006.

MMTSB Toolset. Michael Feig MMTSB/CTBP 2006 Summer Workshop. MMTSB/CTBP Summer Workshop Michael Feig, 2006. MMTSB Toolset Michael Feig MMTSB/CTBP 2006 Summer Workshop MMTSB Tool Set Overview application programs Perl libraries Perl utilities MMTSB Tool Set Functionality Structure manipulation and analysis Classical

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

Protecting High Energy Barriers: A New Equation to Regulate Boost Energy in Accelerated Molecular Dynamics Simulations

Protecting High Energy Barriers: A New Equation to Regulate Boost Energy in Accelerated Molecular Dynamics Simulations pubs.acs.org/jctc Protecting High Energy Barriers: A New Equation to Regulate Boost Energy in Accelerated Molecular Dynamics Simulations William Sinko,*,, Cesar Augusto F. de Oliveira,*,,, Levi C. T. Pierce,

More information

Introduction to numerical computations on the GPU

Introduction to numerical computations on the GPU Introduction to numerical computations on the GPU Lucian Covaci http://lucian.covaci.org/cuda.pdf Tuesday 1 November 11 1 2 Outline: NVIDIA Tesla and Geforce video cards: architecture CUDA - C: programming

More information

Optimization of CHARMM36-UA Force Field Parameters for Phospholipid Bilayer Simulation

Optimization of CHARMM36-UA Force Field Parameters for Phospholipid Bilayer Simulation Optimization of CHARMM36-UA Force Field Parameters for Phospholipid Bilayer Simulation CMSC-663/664 10/5/2017 Student: Wei Shan Chin wschin@terpmail.umd.edu Advisor: Dr. Jeff Klauda Associate Professor

More information

An FPGA Implementation of Reciprocal Sums for SPME

An FPGA Implementation of Reciprocal Sums for SPME An FPGA Implementation of Reciprocal Sums for SPME Sam Lee and Paul Chow Edward S. Rogers Sr. Department of Electrical and Computer Engineering University of Toronto Objectives Accelerate part of Molecular

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

Algorithm for Rapid Reconstruction of Protein Backbone from Alpha Carbon Coordinates

Algorithm for Rapid Reconstruction of Protein Backbone from Alpha Carbon Coordinates Algorithm for Rapid Reconstruction of Protein Backbone from Alpha Carbon Coordinates MARIUSZ MILIK, 1 *, ANDRZEJ KOLINSKI, 1, 2 and JEFFREY SKOLNICK 1 1 The Scripps Research Institute, Department of Molecular

More information

Simulation of molecular systems by molecular dynamics

Simulation of molecular systems by molecular dynamics Simulation of molecular systems by molecular dynamics Yohann Moreau yohann.moreau@ujf-grenoble.fr November 26, 2015 Yohann Moreau (UJF) Molecular Dynamics, Label RFCT 2015 November 26, 2015 1 / 35 Introduction

More information

Hybrid Vigor. Using Heterogeneous HPC to Accelerate Chemical Biology. Imran Haque Department of Computer Science Stanford University

Hybrid Vigor. Using Heterogeneous HPC to Accelerate Chemical Biology. Imran Haque Department of Computer Science Stanford University Hybrid Vigor Using Heterogeneous HPC to Accelerate Chemical Biology Imran Haque Department of Computer Science Stanford University http://cs.stanford.edu/people/ihaque http://folding.stanford.edu Bio-Molecular

More information

Polymer in Water. Davide Bochicchio and Giovanni M. Pavan* Switzerland, Galleria 2, CH-6928 Manno, Switzerland.

Polymer in Water. Davide Bochicchio and Giovanni M. Pavan* Switzerland, Galleria 2, CH-6928 Manno, Switzerland. Accelerated Atomistic Simulations of a Supramolecular Polymer in Water Davide Bochicchio and Giovanni M. Pavan* Department of Innovative Technologies, University of Applied Sciences and Arts of Southern

More information

Supporting Information

Supporting Information S1 Supporting Information Unraveling the Reaction Mechanism of Enzymatic C5-Cytosine Methylation of DNA. A Combined Molecular Dynamics and QM/MM Study of Wild Type and Gln119 Variant Juan Aranda 1, Kirill

More information

GPU-based computation of the Monte Carlo simulation of classical spin systems

GPU-based computation of the Monte Carlo simulation of classical spin systems Perspectives of GPU Computing in Physics and Astrophysics, Sapienza University of Rome, Rome, Italy, September 15-17, 2014 GPU-based computation of the Monte Carlo simulation of classical spin systems

More information

Computational Design of Biomimetic Phosphate Scavengers

Computational Design of Biomimetic Phosphate Scavengers Downloaded from orbit.dtu.dk on: Oct 19, 2018 Computational Design of Biomimetic Phosphate Scavengers Gruber, Mathias Felix; Wood, Elizabeth Baker; Truelsen, Sigurd Friis; Østergaard, Thomas; Hélix- Nielsen,

More information

Charge equilibration

Charge equilibration Charge equilibration Taylor expansion of energy of atom A @E E A (Q) =E A0 + Q A + 1 @Q A 0 2 Q2 A @ 2 E @Q 2 A 0 +... The corresponding energy of cation/anion and neutral atom E A (+1) = E A0 + @E @Q

More information

Replica Exchange with Solute Scaling: A More Efficient Version of Replica Exchange with Solute Tempering (REST2)

Replica Exchange with Solute Scaling: A More Efficient Version of Replica Exchange with Solute Tempering (REST2) pubs.acs.org/jpcb Replica Exchange with Solute Scaling: A More Efficient Version of Replica Exchange with Solute Tempering (REST2) Lingle Wang, Richard A. Friesner, and B. J. Berne* Department of Chemistry,

More information

Population annealing study of the frustrated Ising antiferromagnet on the stacked triangular lattice

Population annealing study of the frustrated Ising antiferromagnet on the stacked triangular lattice Population annealing study of the frustrated Ising antiferromagnet on the stacked triangular lattice Michal Borovský Department of Theoretical Physics and Astrophysics, University of P. J. Šafárik in Košice,

More information

Segment Problem. Xue Wang, Fasheng Qiu Sushil K. Prasad, Guantao Chen Georgia State University, Atlanta, GA April 21, 2010

Segment Problem. Xue Wang, Fasheng Qiu Sushil K. Prasad, Guantao Chen Georgia State University, Atlanta, GA April 21, 2010 Efficient Algorithms for Maximum Density Segment Problem Xue Wang, Fasheng Qiu Sushil K. Prasad, Guantao Chen Georgia State University, Atlanta, GA 30303 April 21, 2010 Introduction Outline Origin of the

More information

MOLECULAR DYNAMIC SIMULATION OF WATER VAPOR INTERACTION WITH VARIOUS TYPES OF PORES USING HYBRID COMPUTING STRUCTURES

MOLECULAR DYNAMIC SIMULATION OF WATER VAPOR INTERACTION WITH VARIOUS TYPES OF PORES USING HYBRID COMPUTING STRUCTURES MOLECULAR DYNAMIC SIMULATION OF WATER VAPOR INTERACTION WITH VARIOUS TYPES OF PORES USING HYBRID COMPUTING STRUCTURES V.V. Korenkov 1,3, a, E.G. Nikonov 1, b, M. Popovičová 2, с 1 Joint Institute for Nuclear

More information

Accelerating linear algebra computations with hybrid GPU-multicore systems.

Accelerating linear algebra computations with hybrid GPU-multicore systems. Accelerating linear algebra computations with hybrid GPU-multicore systems. Marc Baboulin INRIA/Université Paris-Sud joint work with Jack Dongarra (University of Tennessee and Oak Ridge National Laboratory)

More information

Magnetic Resonance Lectures for Chem 341 James Aramini, PhD. CABM 014A

Magnetic Resonance Lectures for Chem 341 James Aramini, PhD. CABM 014A Magnetic Resonance Lectures for Chem 341 James Aramini, PhD. CABM 014A jma@cabm.rutgers.edu " J.A. 12/11/13 Dec. 4 Dec. 9 Dec. 11" " Outline" " 1. Introduction / Spectroscopy Overview 2. NMR Spectroscopy

More information

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

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

More information

A Brief Guide to All Atom/Coarse Grain Simulations 1.1

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

More information

Computational Biochemistry in the New Era of HPC. Imran Haque Department of Computer Science Stanford University

Computational Biochemistry in the New Era of HPC. Imran Haque Department of Computer Science Stanford University Folding@Everywhere Computational Biochemistry in the New Era of HPC Imran Haque Department of Computer Science Stanford University http://cs.stanford.edu/people/ihaque http://folding.stanford.edu Hyperience,

More information

Acceleration of WRF on the GPU

Acceleration of WRF on the GPU Acceleration of WRF on the GPU Daniel Abdi, Sam Elliott, Iman Gohari Don Berchoff, Gene Pache, John Manobianco TempoQuest 1434 Spruce Street Boulder, CO 80302 720 726 9032 TempoQuest.com THE WORLD S FASTEST

More information

Protein Structure Determination Using NMR Restraints BCMB/CHEM 8190

Protein Structure Determination Using NMR Restraints BCMB/CHEM 8190 Protein Structure Determination Using NMR Restraints BCMB/CHEM 8190 Programs for NMR Based Structure Determination CNS - Brünger, A. T.; Adams, P. D.; Clore, G. M.; DeLano, W. L.; Gros, P.; Grosse-Kunstleve,

More information

Ion-Gated Gas Separation through Porous Graphene

Ion-Gated Gas Separation through Porous Graphene Online Supporting Information for: Ion-Gated Gas Separation through Porous Graphene Ziqi Tian, Shannon M. Mahurin, Sheng Dai,*,, and De-en Jiang *, Department of Chemistry, University of California, Riverside,

More information

Accelerating Protein Coordinate Conversion using GPUs

Accelerating Protein Coordinate Conversion using GPUs Accelerating Protein Coordinate Conversion using GPUs Mahsa Bayati Jaydeep P. Bardhan Department of Electrical and Department of Electrical and Computer Engineering Computer Engineering Northeastern University

More information

Simulating biomolecular function from motions across multiple scales (I) Peter J. Bond (BII)

Simulating biomolecular function from motions across multiple scales (I) Peter J. Bond (BII) Simulating biomolecular function from motions across multiple scales (I) Peter J. Bond (BII) peterjb@bii.a-star.edu.sg Structural Biology: Why the Need for Simulation? 2017 year 1972 0 RCSB PDB: RCSB Protein

More information

PROTEIN STRUCTURE PREDICTION USING GAS PHASE MOLECULAR DYNAMICS SIMULATION: EOTAXIN-3 CYTOKINE AS A CASE STUDY

PROTEIN STRUCTURE PREDICTION USING GAS PHASE MOLECULAR DYNAMICS SIMULATION: EOTAXIN-3 CYTOKINE AS A CASE STUDY International Conference Mathematical and Computational Biology 2011 International Journal of Modern Physics: Conference Series Vol. 9 (2012) 193 198 World Scientific Publishing Company DOI: 10.1142/S2010194512005259

More information

What I Did Last Summer

What I Did Last Summer What I Did Last Summer LINGOs, GPUs, and Monitoring Vertex Imran Haque Department of Computer Science Pande Lab, Stanford University http://cs.stanford.edu/people/ihaque http://folding.stanford.edu ihaque@cs.stanford.edu

More information

Improved Resolution of Tertiary Structure Elasticity in Muscle Protein

Improved Resolution of Tertiary Structure Elasticity in Muscle Protein Improved Resolution of Tertiary Structure Elasticity in Muscle Protein Jen Hsin and Klaus Schulten* Department of Physics and Beckman Institute, University of Illinois at Urbana-Champaign, Urbana, Illinois

More information

Predictive Molecular Simulation for Drug Discovery

Predictive Molecular Simulation for Drug Discovery Predictive Molecular Simulation for Drug Discovery 생명과학 의약연구소의약설계팀이승주 sjlee@lgls.co.kr sjlee.lgls@gmail.com Outline Challenging problems in drug discovery Binding affinity calculation New paradigm for

More information

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

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

More information

Winmostar tutorial Gromacs Interfacial Tension V X-Ability Co., Ltd. 2018/01/15

Winmostar tutorial Gromacs Interfacial Tension V X-Ability Co., Ltd. 2018/01/15 Winmostar tutorial Gromacs Interfacial Tension V8.007 X-Ability Co., Ltd. question@winmostar.com Summary In this tutorial, we will calculate density distribution and interfacial tension between liquid-liquid

More information

PROTEIN'STRUCTURE'DETERMINATION'

PROTEIN'STRUCTURE'DETERMINATION' PROTEIN'STRUCTURE'DETERMINATION' USING'NMR'RESTRAINTS' BCMB/CHEM'8190' Programs for NMR Based Structure Determination CNS - Brünger, A. T.; Adams, P. D.; Clore, G. M.; DeLano, W. L.; Gros, P.; Grosse-Kunstleve,

More information

Introduction to Molecular Modeling Lab X - Modeling Proteins

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

More information

Molecular Dynamics Simulations

Molecular Dynamics Simulations Molecular Dynamics Simulations Dr. Kasra Momeni www.knanosys.com Outline LAMMPS AdHiMad Lab 2 What is LAMMPS? LMMPS = Large-scale Atomic/Molecular Massively Parallel Simulator Open-Source (http://lammps.sandia.gov)

More information