Optimizing GROMACS for parallel performance

Size: px
Start display at page:

Download "Optimizing GROMACS for parallel performance"

Transcription

1 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 do next

2 1 Why optimize? The performance status quo GROMACS: high single CPU performance compared to AMBER, CHARMM, GROMOS96 (Lindahl et al. 2001) faster multiple CPUs

3 2 Why optimize? The performance status quo 1 n processors: scaling/efficiency E, speedup S E = 1 T 1 n T n S = T 1 T n run times T n (±0.5%) on Orca1 n T n (s) scaling E speedup S good acceptable waste of resources

4 What can be done?

5 3 Potential for optimizations GROMACS as a black box LAM / mpich parameters: communication module (TCP, usysv, VIA), size of rpi tcp short,... GROMACS parameters: shuffle & sort, optimize FFT, fourierspacing & PME order Inside the box Local optimizations: MPI realization of given task Restructure communication scheme

6 4 Why PME is used Van der Waals: ok to use cut-off radius of nm Coulomb: cutoff unphysical artefacts in structure + dynamics 90% of run time calc. non-bonded electrostatic forces

7 5 Particle Mesh Ewald = Mesh up the Ewald sum! N particles, charges q i, positions r i, neutral cubic box, length L, periodic b.c. Electrostatic energy. (Conditionally convergent, S-L-O-W) V = 1 2 N i, j=1 n Z 3 q i q j r i j + nl (1) Trick 1: Ewald summation. Split eq. (1) into: 1 r = f (r) + 1 f (r) r r (2) Coulomb: rapid variation at small r, slow decay at large r f (r) r 0 beyond some cutoff r max, transform needs only a few k 1 f (r) r slowly varying function r Fourier

8 6 Ewald formula for f = erfc(r) Ewald parameter α: rel weight of V dir to V rec V = V dir +V rec +V 0 V dir = 1 2 i, j V rec = 1 2L 3 k 0 V 0 = α π q 2 i i erfc(α r i j + ml ) q i q j r m Z 3 i j + ml (4) 4π k 2 e k2 /4α 2 ρ( k) 2 k {2π n/l : n Z 3 } (5) (3) (6) exponentially converging sums over m and k in eqs. (4, 5) allow introduction of cutoffs ρ( k) = N j=1 q j e i k r j FT charge density finally get forces by F i = r i V

9 7 Ewald summation on a grid Trick 2: discretization of charge density: continuous charge positions discrete mesh, use FFT SPME: Approximate e ikx by cardinal-b-splines M (P) of order P (=pme order) for even P (x: continuous particle coordinate) e ikx b(k) M P (x lh)e iklh (7) l Z insert (7) into (5) and derive V rec 1 2 h 3 ρ M ( r p )[ρ M G]( r p ) (8) r p M ρ M G = FFT[ FFT(ρ M ) FFT(G)] (9)

10 8 Reduce communication Spline interpolation: local; FFT: global reducing charge mesh size reduces communication keep force error constant by enlarging interpolation order Aquaporin-1, atoms, protein (tetramer) embedded in a lipid bilayer membrane surrounded by water

11 9 A measure of accuracy just consider absolute force values Exact (absolute) force on particle number i: approximated numerically by F i F exa i Difference in abs force: F i F exa i Mean force deviation: FD mean = 1 N N i=1 { F i F exa i } Relative force deviation: FD rel = N i=1 { F i F exa N i=1 Fexa i i } 1 time step F i for 80k particles out of traj.trr reference calculation at fine mesh F exa i

12 10 Parameter combinations at same error level Characteristics of test system: maximum force F max = 5102 Mean force F mean = 868 kj mol nm kj mol nm kj fourierspacing grid size PME FD mean [ mol nm ] FD kj rel FD max [ x350x reference x88x x60x x52x x48x mol nm ] Which possibility performes best? f(ncpu, CPU speed, network speed)

13 11 Scaling at optimal PME settings Dolphin default optimal PME settings n scaling speedup scaling speedup PME order *

14 12 Scaling at optimal PME settings Orca1 (Ethernet) default optimal PME settings n scaling speedup scaling speedup PME order * Orca2 (Myrinet) default optimal PME settings n scaling speedup scaling speedup PME order *

15 13 Scaling at optimal PME settings IBM p690 default optimal PME settings n scaling speedup scaling speedup PME order grid size x88x x88x x88x x64x x54x x64x x54x x54x x64x x64x60 + i.e. 1.5 the performance of 8 Orca2 CPUs

16 What does GROMACS do all the time? Detailed analysis of time step

17 14 Installation of MPE logging MPE: automatic logging of MPI calls manual MPE logging by defining events: #include <mpi.h> #include <mpe.h>... MPI Init( );... MPE Describe state( ev1, ev2, doing PME, grey ); MPE Describe state( ev3, ev4, whatever, orange );... MPE Log event( ev1, 0, ); <code fragment to be logged> MPE Log event( ev2, 0, );... MPI Finalize( );...

18 15 Calculation of the non-bonded forces do force LOOP OVER TIME STEPS... force do fnbf calc V vdw and V dir part of Coulomb do pme calc V rec part of Coulomb spread on grid spread home atom charges on full grid sum qgrid sum contributions to local (z slice) grid from other CPUs (n MPI Reduce) gmxfft3d ρ M = FFT(ρ M ) (n slices in z) solve pme gmxfft3d ρ M G FFT [ ( ρ M ) G ] sum qgrid distribute local (= z slice) grid to all nodes gather f bsplines get forces on home atoms F i = r i V

19 16 Detailed analysis - ncpu 1, 2, 4, 6

20 17 Detailed analysis - PME order 4, 6, 8

21 18 Shuffle and Sort

22 19 Changing MPI routines in sum qgrid timing results at n = 4, pme-order 6 Operation time(s) (Dolphin) time(s) (Orca1) n MPI Reduce MPI Reduce scatter MPI Alltoall+sum time step length: 0.99s (Dolphin), 0.34 s (Orca1) use of MPI Alltoall enhances 4 CPU scaling xx on Dolphin xx on Orca1

23 20 Problem: Communication delays for ncpu 6

24 21 Summary for ncpu > 1 replace xxx pme order=4 xxx fourierspacing=0.120 by xxx pme order=6 xxx fourierspacing=0.178 in your.mdp file Orca/Ethernet (4 CPUs): switch to PME order 6 scaling 57 75% Orca/Myrinet: 2 8 CPUs: speedup=3

25 22 What next 1. Replace n MPI Bcast-calls by 1 MPI Alltoall Further enhancement of 4-CPU scaling 2. Cause of communication delays? Monitor network traffic. 3. Overlap V rec communication with V dir calculation

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

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

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

Neighbor Tables Long-Range Potentials

Neighbor Tables Long-Range Potentials Neighbor Tables Long-Range Potentials Today we learn how we can handle long range potentials. Neighbor tables Long-range potential Ewald sums MSE485/PHY466/CSE485 1 Periodic distances Minimum Image Convention:

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

Long-range interactions: P 3 M, MMMxD, ELC, MEMD and ICC

Long-range interactions: P 3 M, MMMxD, ELC, MEMD and ICC Long-range interactions: P 3 M, MMMxD, ELC, MEMD and ICC Axel Arnold Institute for Computational Physics Universität Stuttgart October 10, 2012 Long-range interactions gravity Coulomb interaction dipolar

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

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

ab initio Electronic Structure Calculations

ab initio Electronic Structure Calculations ab initio Electronic Structure Calculations New scalability frontiers using the BG/L Supercomputer C. Bekas, A. Curioni and W. Andreoni IBM, Zurich Research Laboratory Rueschlikon 8803, Switzerland ab

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

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

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

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

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

More information

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

N-body simulations. Phys 750 Lecture 10

N-body simulations. Phys 750 Lecture 10 N-body simulations Phys 750 Lecture 10 N-body simulations Forward integration in time of strongly coupled classical particles or (rigid-body composite objects) dissipation Brownian motion Very general

More information

The Fast Multipole Method in molecular dynamics

The Fast Multipole Method in molecular dynamics The Fast Multipole Method in molecular dynamics Berk Hess KTH Royal Institute of Technology, Stockholm, Sweden ADAC6 workshop Zurich, 20-06-2018 Slide BioExcel Slide Molecular Dynamics of biomolecules

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

Efficient multiple time step method for use with Ewald and particle mesh Ewald for large biomolecular systems

Efficient multiple time step method for use with Ewald and particle mesh Ewald for large biomolecular systems JOURNAL OF CHEMICAL PHYSICS VOLUME 115, NUMBER 5 1 AUGUST 2001 Efficient multiple time step method for use with Ewald and particle mesh Ewald for large biomolecular systems Ruhong Zhou IBM Thomas J. Watson

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

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

Extending Parallel Scalability of LAMMPS and Multiscale Reactive Molecular Simulations

Extending Parallel Scalability of LAMMPS and Multiscale Reactive Molecular Simulations September 18, 2012 Extending Parallel Scalability of LAMMPS and Multiscale Reactive Molecular Simulations Yuxing Peng, Chris Knight, Philip Blood, Lonnie Crosby, and Gregory A. Voth Outline Proton Solvation

More information

Tutorial on the smooth particle-mesh Ewald algorithm

Tutorial on the smooth particle-mesh Ewald algorithm Tutorial on the smooth particle-mesh Ewald algorithm These notes explain the smooth particle-mesh Ewald algorithm (SPME) in detail. The accompanying library libpme6 is a fully-featured implementation of

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

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

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

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

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

Coarse-Grained Models!

Coarse-Grained Models! Coarse-Grained Models! Large and complex molecules (e.g. long polymers) can not be simulated on the all-atom level! Requires coarse-graining of the model! Coarse-grained models are usually also particles

More information

This is an electronic reprint of the original article. This reprint may differ from the original in pagination and typographic detail.

This is an electronic reprint of the original article. This reprint may differ from the original in pagination and typographic detail. This is an electronic reprint of the original article. This reprint may differ from the original in pagination and typographic detail. Author(s): Hub, Jochen S.; Groot, Bert L. De; Grubmüller, Helmut;

More information

Gromacs Workshop Spring CSC

Gromacs Workshop Spring CSC Gromacs Workshop Spring 2007 @ CSC Erik Lindahl Center for Biomembrane Research Stockholm University, Sweden David van der Spoel Dept. Cell & Molecular Biology Uppsala University, Sweden Berk Hess Max-Planck-Institut

More information

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

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

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

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

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

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

Multiple time step Monte Carlo simulations: Application to charged systems with Ewald summation

Multiple time step Monte Carlo simulations: Application to charged systems with Ewald summation JOURNAL OF CHEMICAL PHYSICS VOLUME 11, NUMBER 1 1 JULY 004 Multiple time step Monte Carlo simulations: Application to charged systems with Ewald summation Katarzyna Bernacki a) Department of Chemistry

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

Kasetsart University Workshop. Multigrid methods: An introduction

Kasetsart University Workshop. Multigrid methods: An introduction Kasetsart University Workshop Multigrid methods: An introduction Dr. Anand Pardhanani Mathematics Department Earlham College Richmond, Indiana USA pardhan@earlham.edu A copy of these slides is available

More information

A reciprocal space based method for treating long range interactions in ab initio and force-field-based calculations in clusters

A reciprocal space based method for treating long range interactions in ab initio and force-field-based calculations in clusters A reciprocal space based method for treating long range interactions in ab initio and force-field-based calculations in clusters Glenn J. Martyna and Mark E. Tuckerman Citation: The Journal of Chemical

More information

Free energy simulations

Free energy simulations Free energy simulations Marcus Elstner and Tomáš Kubař January 14, 2013 Motivation a physical quantity that is of most interest in chemistry? free energies Helmholtz F or Gibbs G holy grail of computational

More information

A Fast N-Body Solver for the Poisson(-Boltzmann) Equation

A Fast N-Body Solver for the Poisson(-Boltzmann) Equation A Fast N-Body Solver for the Poisson(-Boltzmann) Equation Robert D. Skeel Departments of Computer Science (and Mathematics) Purdue University http://bionum.cs.purdue.edu/2008december.pdf 1 Thesis Poisson(-Boltzmann)

More information

Quantum Interference and Selectivity through Biological Ion Channels

Quantum Interference and Selectivity through Biological Ion Channels 1 SUPPLEMENTARY INFORMATION Quantum Interference and Selectivity through Biological Ion Channels Vahid Salari 1,3,*, Hamidreza Naeij 2, Afshin Shafiee 2,3 1 Department of Physics, Isfahan University of

More information

Generation of topology files of a protein chain and simulations of a dipeptide

Generation of topology files of a protein chain and simulations of a dipeptide Chapter-36 Generation of topology files of a protein chain and simulations of a dipeptide After studying this chapter, you will be able to 1) Generate a topology file of a dipeptide molecule. 2) Generate

More information

Seminar in Particles Simulations. Particle Mesh Ewald. Theodora Konstantinidou

Seminar in Particles Simulations. Particle Mesh Ewald. Theodora Konstantinidou Seminar in Particles Simulations Particle Mesh Ewald Theodora Konstantinidou This paper is part of the course work: seminar 2 Contents 1 Introduction 3 1.1 Role of Molecular Dynamics - MD.......................

More information

RWTH Aachen University

RWTH Aachen University IPCC @ RWTH Aachen University Optimization of multibody and long-range solvers in LAMMPS Rodrigo Canales William McDoniel Markus Höhnerbach Ahmed E. Ismail Paolo Bientinesi IPCC Showcase November 2016

More information

Journal of Pharmacology and Experimental Therapy-JPET#172536

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

More information

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

MOLECULAR DYNAMICS SIMULATIONS OF BIOMOLECULES: Long-Range Electrostatic Effects

MOLECULAR DYNAMICS SIMULATIONS OF BIOMOLECULES: Long-Range Electrostatic Effects Annu. Rev. Biophys. Biomol. Struct. 1999. 28:155 79 Copyright c 1999 by Annual Reviews. All rights reserved MOLECULAR DYNAMICS SIMULATIONS OF BIOMOLECULES: Long-Range Electrostatic Effects Celeste Sagui

More information

Anton: A Specialized ASIC for Molecular Dynamics

Anton: A Specialized ASIC for Molecular Dynamics Anton: A Specialized ASIC for Molecular Dynamics Martin M. Deneroff, David E. Shaw, Ron O. Dror, Jeffrey S. Kuskin, Richard H. Larson, John K. Salmon, and Cliff Young D. E. Shaw Research Marty.Deneroff@DEShawResearch.com

More information

Multiscale Modelling, taking into account Collisions

Multiscale Modelling, taking into account Collisions Multiscale Modelling, taking into account Collisions Andreas Adelmann (Paul Scherrer Institut) October 28, 2017 Multiscale Modelling, taking into account Collisions October 28, 2017 Page 1 / 22 1 Motivation

More information

Parallel Utility for Modeling of Molecular Aggregation

Parallel Utility for Modeling of Molecular Aggregation Parallel Utility for Modeling of Molecular Aggregation Peter Spijker, Bart Markvoort and Peter Hilbers BioModeling and bioinformatics Eindhoven University of Technology Eindhoven,The Netherlands p.spijker@pumma.nl

More information

pka Calculations of Key Ionizable Protein Residues in Acetylcholinesterase

pka Calculations of Key Ionizable Protein Residues in Acetylcholinesterase pka Calculations of Key Ionizable Protein Residues in Acetylcholinesterase Jiří Wiesner VOCE Masaryk University Czech Republic www.eu-egee.org EGEE and glite are registered trademarks Outline Introduction

More information

Quantifying Artifacts in Ewald Simulations of Inhomogeneous Systems with a Net Charge

Quantifying Artifacts in Ewald Simulations of Inhomogeneous Systems with a Net Charge pubs.acs.org/jctc Quantifying Artifacts in Ewald Simulations of Inhomogeneous Systems with a et Charge Jochen S. Hub,*, Bert L. de Groot, Helmut Grubmu ller, and Gerrit Groenhof*,, Institute for Microbiology

More information

Parallel programming using MPI. Analysis and optimization. Bhupender Thakur, Jim Lupo, Le Yan, Alex Pacheco

Parallel programming using MPI. Analysis and optimization. Bhupender Thakur, Jim Lupo, Le Yan, Alex Pacheco Parallel programming using MPI Analysis and optimization Bhupender Thakur, Jim Lupo, Le Yan, Alex Pacheco Outline l Parallel programming: Basic definitions l Choosing right algorithms: Optimal serial and

More information

Spring 2011 CS264: Parallel POMDP

Spring 2011 CS264: Parallel POMDP Spring 20 CS264: Parallel POMDP Mark Woodward May 8, 20 Introduction My research is on robots interactively learning from humans. During the interaction there are questions that the robot would like to

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

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

2 Structure. 2.1 Coulomb interactions

2 Structure. 2.1 Coulomb interactions 2 Structure 2.1 Coulomb interactions While the information needed for reproduction of living systems is chiefly maintained in the sequence of macromolecules, any practical use of this information must

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

Energy-Level Alignment at the Interface of Graphene Fluoride and Boron Nitride Monolayers: An Investigation by Many-Body Perturbation Theory

Energy-Level Alignment at the Interface of Graphene Fluoride and Boron Nitride Monolayers: An Investigation by Many-Body Perturbation Theory Supporting Information Energy-Level Alignment at the Interface of Graphene Fluoride and Boron Nitride Monolayers: An Investigation by Many-Body Perturbation Theory Qiang Fu, Dmitrii Nabok, and Claudia

More information

Can a continuum solvent model reproduce the free energy landscape of a β-hairpin folding in water?

Can a continuum solvent model reproduce the free energy landscape of a β-hairpin folding in water? Can a continuum solvent model reproduce the free energy landscape of a β-hairpin folding in water? Ruhong Zhou 1 and Bruce J. Berne 2 1 IBM Thomas J. Watson Research Center; and 2 Department of Chemistry,

More information

Chapter 2 - Water 9/8/2014. Water exists as a H-bonded network with an average of 4 H-bonds per molecule in ice and 3.4 in liquid. 104.

Chapter 2 - Water 9/8/2014. Water exists as a H-bonded network with an average of 4 H-bonds per molecule in ice and 3.4 in liquid. 104. Chapter 2 - Water Water exists as a -bonded network with an average of 4 -bonds per molecule in ice and 3.4 in liquid. 104.5 o -bond: An electrostatic attraction between polarized molecules containing

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

10: Testing Testing. Basic procedure to validate calculations

10: Testing Testing. Basic procedure to validate calculations The Nuts and Bolts of First-Principles Simulation 10: Testing Testing. Basic procedure to validate calculations Durham, 6th-13th December 2001 CASTEP Developers Group with support from the ESF ψ k Network

More information

A smooth particle-mesh Ewald algorithm for Stokes suspension simulations: The sedimentation of fibers

A smooth particle-mesh Ewald algorithm for Stokes suspension simulations: The sedimentation of fibers PHYSICS OF FLUIDS 7, 03330 2005 A smooth particle-mesh Ewald algorithm for Stokes suspension simulations: The sedimentation of fibers David Saintillan and Eric Darve a Department of Mechanical Engineering,

More information

Enhancing drug residence time by shielding of intra-protein hydrogen bonds: a case study on CCR2 antagonists. Supplementary Information

Enhancing drug residence time by shielding of intra-protein hydrogen bonds: a case study on CCR2 antagonists. Supplementary Information Enhancing drug residence time by shielding of intra-protein hydrogen bonds: a case study on CCR2 antagonists Aniket Magarkar, Gisela Schnapp, Anna-Katharina Apel, Daniel Seeliger & Christofer S. Tautermann

More information

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

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

More information

Supporting Information

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

More information

Fourier Series : Dr. Mohammed Saheb Khesbak Page 34

Fourier Series : Dr. Mohammed Saheb Khesbak Page 34 Fourier Series : Dr. Mohammed Saheb Khesbak Page 34 Dr. Mohammed Saheb Khesbak Page 35 Example 1: Dr. Mohammed Saheb Khesbak Page 36 Dr. Mohammed Saheb Khesbak Page 37 Dr. Mohammed Saheb Khesbak Page 38

More information

Introduction to Parallelism in CASTEP

Introduction to Parallelism in CASTEP to ism in CASTEP Stewart Clark Band University of Durham 21 September 2012 Solve for all the bands/electrons (Band-) Band CASTEP solves the Kohn-Sham equations for electrons in a periodic array of nuclei:

More information

Introduction to Spark

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

More information

Laplacian-Centered Poisson Solvers and Multilevel Summation Algorithms

Laplacian-Centered Poisson Solvers and Multilevel Summation Algorithms Laplacian-Centered Poisson Solvers and Multilevel Summation Algorithms Dmitry Yershov 1 Stephen Bond 1 Robert Skeel 2 1 University of Illinois at Urbana-Champaign 2 Purdue University 2009 SIAM Annual Meeting

More information

GPU Acceleration of Cutoff Pair Potentials for Molecular Modeling Applications

GPU Acceleration of Cutoff Pair Potentials for Molecular Modeling Applications GPU Acceleration of Cutoff Pair Potentials for Molecular Modeling Applications Christopher Rodrigues, David J. Hardy, John E. Stone, Klaus Schulten, Wen-Mei W. Hwu University of Illinois at Urbana-Champaign

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

Fast Space Charge Calculations with a Multigrid Poisson Solver & Applications

Fast Space Charge Calculations with a Multigrid Poisson Solver & Applications Fast Space Charge Calculations with a Multigrid Poisson Solver & Applications Gisela Pöplau Ursula van Rienen Rostock University DESY, Hamburg, April 26, 2005 Bas van der Geer Marieke de Loos Pulsar Physics

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

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

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

More information

Secondary beam production with fragment separators

Secondary beam production with fragment separators Secondary beam production with fragment separators Introduction Application Statistics Monte Carlo calculation of fragment transmission EBSS tutorial The code operates under MS Windows environment and

More information

XXL-BIOMD. Large Scale Biomolecular Dynamics Simulations. onsdag, 2009 maj 13

XXL-BIOMD. Large Scale Biomolecular Dynamics Simulations. onsdag, 2009 maj 13 XXL-BIOMD Large Scale Biomolecular Dynamics Simulations David van der Spoel, PI Aatto Laaksonen Peter Coveney Siewert-Jan Marrink Mikael Peräkylä Uppsala, Sweden Stockholm, Sweden London, UK Groningen,

More information

On the calculation of solvation free energy from Kirkwood- Buff integrals: A large scale molecular dynamics study

On the calculation of solvation free energy from Kirkwood- Buff integrals: A large scale molecular dynamics study On the calculation of solvation free energy from Kirkwood- Buff integrals: A large scale molecular dynamics study Wynand Dednam and André E. Botha Department of Physics, University of South Africa, P.O.

More information

Free energy calculations

Free energy calculations Free energy calculations Berk Hess May 5, 2017 Why do free energy calculations? The free energy G gives the population of states: ( ) P 1 G = exp, G = G 2 G 1 P 2 k B T Since we mostly simulate in the

More information

Massively parallel semi-lagrangian solution of the 6d Vlasov-Poisson problem

Massively parallel semi-lagrangian solution of the 6d Vlasov-Poisson problem Massively parallel semi-lagrangian solution of the 6d Vlasov-Poisson problem Katharina Kormann 1 Klaus Reuter 2 Markus Rampp 2 Eric Sonnendrücker 1 1 Max Planck Institut für Plasmaphysik 2 Max Planck Computing

More information

Fast Ewald Summation based on NFFT with Mixed Periodicity

Fast Ewald Summation based on NFFT with Mixed Periodicity Fast Ewald Summation based on NFFT with Mixed Periodicity Franziska Nestler, Michael Pippig and Daniel Potts In this paper we develop new fast Fourier-based methods for the Coulomb problem. We combine

More information

Fast and accurate Coulomb calculation with Gaussian functions

Fast and accurate Coulomb calculation with Gaussian functions Fast and accurate Coulomb calculation with Gaussian functions László Füsti-Molnár and Jing Kong Q-CHEM Inc., Pittsburgh, Pennysylvania 15213 THE JOURNAL OF CHEMICAL PHYSICS 122, 074108 2005 Received 8

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

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

Simulations of bulk phases. Periodic boundaries. Cubic boxes

Simulations of bulk phases. Periodic boundaries. Cubic boxes Simulations of bulk phases ChE210D Today's lecture: considerations for setting up and running simulations of bulk, isotropic phases (e.g., liquids and gases) Periodic boundaries Cubic boxes In simulations

More information

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

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

More information

FFTs in Graphics and Vision. Fast Alignment of Spherical Functions

FFTs in Graphics and Vision. Fast Alignment of Spherical Functions FFTs in Graphics and Vision Fast Alignment of Spherical Functions Outline Math Review Fast Rotational Alignment Review Recall 1: We can represent any rotation R in terms of the triplet of Euler angles

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

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

A particle-in-cell method with adaptive phase-space remapping for kinetic plasmas

A particle-in-cell method with adaptive phase-space remapping for kinetic plasmas A particle-in-cell method with adaptive phase-space remapping for kinetic plasmas Bei Wang 1 Greg Miller 2 Phil Colella 3 1 Princeton Institute of Computational Science and Engineering Princeton University

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

Course Introduction. SASSIE CCP-SAS Workshop. January 23-25, ISIS Neutron and Muon Source Rutherford Appleton Laboratory UK

Course Introduction. SASSIE CCP-SAS Workshop. January 23-25, ISIS Neutron and Muon Source Rutherford Appleton Laboratory UK Course Introduction SASSIE CCP-SAS Workshop January 23-25, 2017 ISIS Neutron and Muon Source Rutherford Appleton Laboratory UK ccpsas.org Scatters & Simulators Develop a community of users and developers

More information

OpenDiscovery: Automated Docking of Ligands to Proteins and Molecular Simulation

OpenDiscovery: Automated Docking of Ligands to Proteins and Molecular Simulation OpenDiscovery: Automated Docking of Ligands to Proteins and Molecular Simulation Gareth Price Computational MiniProject OpenDiscovery Aims + Achievements Produce a high-throughput protocol to screen a

More information

User Guide for LeDock

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

More information

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 Bologna PATC 2015 Today's lecture You will learn: Gromacs @ CINECA: set up and launch of simulations Launch MD code (GROMACS,

More information

1. Hydrogen atom in a box

1. Hydrogen atom in a box 1. Hydrogen atom in a box Recall H atom problem, V(r) = -1/r e r exact answer solved by expanding in Gaussian basis set, had to solve secular matrix involving matrix elements of basis functions place atom

More information

References. Documentation Manuals Tutorials Publications

References.   Documentation Manuals Tutorials Publications References http://siesta.icmab.es Documentation Manuals Tutorials Publications Atomic units e = m e = =1 atomic mass unit = m e atomic length unit = 1 Bohr = 0.5292 Ang atomic energy unit = 1 Hartree =

More information