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

Size: px
Start display at page:

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

Transcription

1 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)

2 Molecular Dynamics (MD) 1. Energy/forces are described by classical molecular mechanics force field. 2. Update state according to equations of motion. dr i dt dp dt i p i m F Equation of motion i p r ( ) ( ) i i t t ri t t m p ( t t) p ( t) F t i i i Integration Long time MD trajectories are important to obtain thermodynamic quantities of target systems. Long time MD trajectory => Ensemble generation

3 Potential energy in MD using PME E k ( b b ) total b 0 bonds angles k a dihedrals 0 2 ( ) V [1 cos( n )] n 2 N1 N r r q q ij 2 r j 1i j 1 ij r ij r ij ij 0ij i j O(N) Total number of particles O(N) O(N) O(N 2 ) Main bottleneck in MD i j R ij 12 6 r 2 2 0ij r0ij qiq jerfc( rij ) exp( / 4 ) 2 k FFT( Q( )) r 2 ij r k ij rij k0 k Real space, O(CN) Reciprocal space, O(NlogN) 3

4 GENESIS MD software (Generalized Ensemble Simulation Systems) 1. Aims at developing efficient and accurate methodologies for free energy calculations in biological systems. 2. Efficient Parallelization - Suitable for massively parallel supercomputers, in particular, K. 3. Applicability for large scale simulation. 4. Algorithms coupled with different molecular models such as coarsegrained, all-atom, and hybrid QM/MM. 5. Generalized ensemble with Replica Exchange Molecular Dynamics. Ref : Jaewoon Jung et al. WIREs CMS, 5, (2015) Website :

5 Parallelization of the real space interaction: Midpoint cell method (1) Midpoint method : interaction between two particles are decided from the midpoint position of them. Midpoint cell method : interaction between two particles are decided from the midpoint cells where each particle resides. Small communication, efficient energy/force evaluations Ref : J. Jung, T. Mori and Y. Sugita, JCC 35, 1064 (2014)

6 Basic domain decomposition using the midpoint cell method (2) 1. Partitioning space into fixed size boxes, with dimension larger than the cutoff distance. 2. We need only information of neighbor space(domain) for computation of energies. 3. Communication is reduced by increasing process number. 4. Efficient for good parallelization and suitable for large system with massively parallel supercomputers.

7 Parallelization of FFT in GENESIS : Volumetric decomposition scheme in 3D FFT 1. More communications than existing FFT 2. MPI Alltoall communications only in one dimensional space (existing : communications in two/three dimensional space) 3. Reduce communicational cost for large number of processors

8 FFT in GENESIS (2 dimensional view) GENESIS (Identical domain decomposition between two space) NAMD, Gromacs (Different domain decomposition)

9 ns/day GENESIS performance on K GENESIS r1.1 GENESIS r1.0 NAMD GENESIS r1.0 GENESIS r1.1 GENESIS r1.2 NAMD 2.9 Gromacs Gromacs Number of Cores ApoA1 (92,224 atoms) on 128 cores STMV (1,066,628 atoms)

10 Why midpoint cell method for GPU+CPU cluster? 1. The main bottleneck of MD is the real space non-bonded interactions for small number of processors. 2. The main bottleneck of MD moves to the reciprocal space non-bonded interactions as we increase the number of processors. 3. When we assign GPU for the real space non-bonded interactions, the reciprocal space interaction will be more crucial. 4. The midpoint cell method with volumetric decomposition FFT could be one of good solutions to optimize the reciprocal space interactions due to avoiding communications before/after FFT. 5. In particular, the midpoint cell method with volumetric decomposition FFT will be very useful for massively parallel supercomputers with GPUs.

11 Overview of CPU+GPU calculations 1. Computation intensive work : GPU Pairlist Real space non-bonded interaction 2. Communication intensive work or no computation intensive work : CPU Reciprocal space non-bonded interaction with FFT Bonded interaction Exclusion list 3. Integration is performed on CPU due to file I/O.

12 Real space non-bonded interaction on GPU (1) - non-excluded particle list scheme Non-excluded particle list scheme is suitable for GPU due to small amount of memory for pairlist.

13 Real space non-bonded interaction on GPU (2) - How to make block/threads in each cell pair We make 32 thread blocks for efficient calculation on GPU by making blocks according to 8 atoms in cell I and 4 atoms in cell j.

14 Overview of GPU+CPU calculations with multiple time step integrator 1. In the multiple time step integrator, we do not perform reciprocal space interaction every step. 2. If reciprocal space interaction is not necessary, we assign subset of real space interaction on CPU to maximize the performance. 3. Integration is performed on CPU only.

15 Validation Tests (Energy drift) Machine Precision Integrator Energy drift CPU Double Velocity Verlet CPU Single Velocity Verlet CPU Double RESPA (4fs) CPU Single RESPA (4fs) CPU+GPU Double Velocity Verlet CPU+GPU Single Velocity Verlet CPU+GPU Double RESPA (4fs) CPU+GPU Single RESPA (4fs) CPU+GPU Single Langevin RESPA (8fs) CPU+GPU Single Langevin RESPA (10fs) Unit : kt/ns/degree of freedom 2fs time step with SHAKE/RATTLE/SETTLE constraints In the case of RESPA, the slow force time step is written in parentheses Our energy drift is similar to AMBER double and hybrid precision calculation.

16 1. MD program : GENESIS Benchmark condition 2. System : TIP3P water (22,000), STMV (1 million), Crowding system1 (11.7 million), and Crowding system 2 (100 million) 3. Cutoff : 12.0 Å 4. PME grid sizes : (STMV), (Crowding system1), and (Crowding system 2) 5. Integrator : Velocity Verlet (VVER), Respa (PME reciprocal every second step), and Langevin Respa (PME reciprocal every fourth step)

17 Acceleration of real space interactions (1) System : 9,250 TIP water molecules Cutoff distance : 12 Å Box size : 64 Å 64 Å 64 Å 1. 1 GPU increase the speed 3 times and 2 GPUs 6 times. 2. By assigning CPU as well as GPU when FFT on CPU is skipped, we can increase the speed up to 7.7 times.

18 Acceleration of real space interactions (2) Benchmark system (11.7 million atoms, Cutoff = 12.0 Å)

19 Comparison between real space and reciprocal space interactions STMV (1 million atoms) 11.7 million atoms 1. In both systems, the main bottleneck is the reciprocal space interactions irrespective of the number of processors. 2. Therefore, it is important to optimize the reciprocal space interaction when CPU+GPU clusters are used (=> Midpoint cell method could be best choice)

20 Comparison between TSUBAME and K STMV (1 million atoms) 11.7 million atoms 1. K has better parallel efficiency of reciprocal space interaction than TSUBAME. 2. Irrespective of the performance of reciprocal space interaction, TSUBAME shows better performance than K due to efficient evaluation of real space interaction on GPU.

21 Benchmark on TSUBAME VVER (1 million atoms) VVER (11.7 million atoms) RESPA (1 million atoms) RESPA (11.7 million atoms)

22 Performance on TSUBAME for 100 million atom systems Integrator Number of Nodes Time per step (ms) Simulation time (ns/day) VVER RESPA Langevin RESPA

23 Summary 1. We implemented MD for GPU+CPU clusters. 2. We assign GPUs for real space non-bonded interactions and CPUs for reciprocal space interactions, bonded interactions, and integrators. 3. We introduce a non-excluded particle list scheme for efficient usage of memory on GPU. 4. We also optimized the usage of GPUs and CPUs for multiple time step integrators. 5. Benchmark result on TSUBAME shows very good strong/weak scalability for 1 million, 11.7 million, and 100 million atoms systems.

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

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

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

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 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

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

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

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

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

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

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

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

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

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

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

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

Lattice Boltzmann simulations on heterogeneous CPU-GPU clusters

Lattice Boltzmann simulations on heterogeneous CPU-GPU clusters Lattice Boltzmann simulations on heterogeneous CPU-GPU clusters H. Köstler 2nd International Symposium Computer Simulations on GPU Freudenstadt, 29.05.2013 1 Contents Motivation walberla software concepts

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

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

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

Introduction to Benchmark Test for Multi-scale Computational Materials Software

Introduction to Benchmark Test for Multi-scale Computational Materials Software Introduction to Benchmark Test for Multi-scale Computational Materials Software Shun Xu*, Jian Zhang, Zhong Jin xushun@sccas.cn Computer Network Information Center Chinese Academy of Sciences (IPCC member)

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

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

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

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

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

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

Accelerating Three-Body Molecular Dynamics Potentials Using NVIDIA Tesla K20X GPUs. GE Global Research Masako Yamada

Accelerating Three-Body Molecular Dynamics Potentials Using NVIDIA Tesla K20X GPUs. GE Global Research Masako Yamada Accelerating Three-Body Molecular Dynamics Potentials Using NVIDIA Tesla K20X GPUs GE Global Research Masako Yamada Overview of MD Simulations Non-Icing Surfaces for Wind Turbines Large simulations ~ 1

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

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

Huge-Scale Molecular Dynamics Simulation of Multi-bubble Nuclei

Huge-Scale Molecular Dynamics Simulation of Multi-bubble Nuclei 1/20 Huge-Scale Molecular Dynamics Simulation of Multi-bubble Nuclei H. Watanabe ISSP, The M. Suzuki H. Inaoka N. Ito Kyushu University RIKEN AICS The, RIKEN AICS Outline 1. Introduction 2. Benchmark results

More information

Performance Analysis of Lattice QCD Application with APGAS Programming Model

Performance Analysis of Lattice QCD Application with APGAS Programming Model Performance Analysis of Lattice QCD Application with APGAS Programming Model Koichi Shirahata 1, Jun Doi 2, Mikio Takeuchi 2 1: Tokyo Institute of Technology 2: IBM Research - Tokyo Programming Models

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

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

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

Two case studies of Monte Carlo simulation on GPU

Two case studies of Monte Carlo simulation on GPU Two case studies of Monte Carlo simulation on GPU National Institute for Computational Sciences University of Tennessee Seminar series on HPC, Feb. 27, 2014 Outline 1 Introduction 2 Discrete energy lattice

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

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

SPARSE SOLVERS POISSON EQUATION. Margreet Nool. November 9, 2015 FOR THE. CWI, Multiscale Dynamics

SPARSE SOLVERS POISSON EQUATION. Margreet Nool. November 9, 2015 FOR THE. CWI, Multiscale Dynamics SPARSE SOLVERS FOR THE POISSON EQUATION Margreet Nool CWI, Multiscale Dynamics November 9, 2015 OUTLINE OF THIS TALK 1 FISHPACK, LAPACK, PARDISO 2 SYSTEM OVERVIEW OF CARTESIUS 3 POISSON EQUATION 4 SOLVERS

More information

Accelerating Three-Body Potentials using GPUs NVIDIA Tesla K20X

Accelerating Three-Body Potentials using GPUs NVIDIA Tesla K20X Using a Hybrid Cray Supercomputer to Model Non-Icing Surfaces for Cold- Climate Wind Turbines Accelerating Three-Body Potentials using GPUs NVIDIA Tesla K20X GE Global Research Masako Yamada Opportunity

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 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

Welcome to MCS 572. content and organization expectations of the course. definition and classification

Welcome to MCS 572. content and organization expectations of the course. definition and classification Welcome to MCS 572 1 About the Course content and organization expectations of the course 2 Supercomputing definition and classification 3 Measuring Performance speedup and efficiency Amdahl s Law Gustafson

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

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

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

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

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

Direct Self-Consistent Field Computations on GPU Clusters

Direct Self-Consistent Field Computations on GPU Clusters Direct Self-Consistent Field Computations on GPU Clusters Guochun Shi, Volodymyr Kindratenko National Center for Supercomputing Applications University of Illinois at UrbanaChampaign Ivan Ufimtsev, Todd

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

Energy Landscapes and Accelerated Molecular- Dynamical Techniques for the Study of Protein Folding

Energy Landscapes and Accelerated Molecular- Dynamical Techniques for the Study of Protein Folding Energy Landscapes and Accelerated Molecular- Dynamical Techniques for the Study of Protein Folding John K. Prentice Boulder, CO BioMed Seminar University of New Mexico Physics and Astronomy Department

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

Efficient implementation of the overlap operator on multi-gpus

Efficient implementation of the overlap operator on multi-gpus Efficient implementation of the overlap operator on multi-gpus Andrei Alexandru Mike Lujan, Craig Pelissier, Ben Gamari, Frank Lee SAAHPC 2011 - University of Tennessee Outline Motivation Overlap operator

More information

Enhanced sampling via molecular dynamics II: Unbiased approaches

Enhanced sampling via molecular dynamics II: Unbiased approaches Enhanced sampling via molecular dynamics II: Unbiased approaches Mark E. Tuckerman Dept. of Chemistry and Courant Institute of Mathematical Sciences New York University, 100 Washington Square East, NY

More information

Enabling constant pressure hybrid Monte Carlo simulations using the GROMACS molecular simulation package

Enabling constant pressure hybrid Monte Carlo simulations using the GROMACS molecular simulation package Enabling constant pressure hybrid Monte Carlo simulations using the GROMACS molecular simulation package Mario Fernández Pendás MSBMS Group Supervised by Bruno Escribano and Elena Akhmatskaya BCAM 18 October

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

Parallel Longest Common Subsequence using Graphics Hardware

Parallel Longest Common Subsequence using Graphics Hardware Parallel Longest Common Subsequence using Graphics Hardware John Kloetzli rian Strege Jonathan Decker Dr. Marc Olano Presented by: rian Strege 1 Overview Introduction Problem Statement ackground and Related

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

SP-CNN: A Scalable and Programmable CNN-based Accelerator. Dilan Manatunga Dr. Hyesoon Kim Dr. Saibal Mukhopadhyay

SP-CNN: A Scalable and Programmable CNN-based Accelerator. Dilan Manatunga Dr. Hyesoon Kim Dr. Saibal Mukhopadhyay SP-CNN: A Scalable and Programmable CNN-based Accelerator Dilan Manatunga Dr. Hyesoon Kim Dr. Saibal Mukhopadhyay Motivation Power is a first-order design constraint, especially for embedded devices. Certain

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

The Green Index (TGI): A Metric for Evalua:ng Energy Efficiency in HPC Systems

The Green Index (TGI): A Metric for Evalua:ng Energy Efficiency in HPC Systems The Green Index (TGI): A Metric for Evalua:ng Energy Efficiency in HPC Systems Wu Feng and Balaji Subramaniam Metrics for Energy Efficiency Energy- Delay Product (EDP) Used primarily in circuit design

More information

Performance of WRF using UPC

Performance of WRF using UPC Performance of WRF using UPC Hee-Sik Kim and Jong-Gwan Do * Cray Korea ABSTRACT: The Weather Research and Forecasting (WRF) model is a next-generation mesoscale numerical weather prediction system. We

More information

Review for the Midterm Exam

Review for the Midterm Exam Review for the Midterm Exam 1 Three Questions of the Computational Science Prelim scaled speedup network topologies work stealing 2 The in-class Spring 2012 Midterm Exam pleasingly parallel computations

More information

Carlo Cavazzoni, HPC department, CINECA

Carlo Cavazzoni, HPC department, CINECA Large Scale Parallelism Carlo Cavazzoni, HPC department, CINECA Parallel Architectures Two basic architectural scheme: Distributed Memory Shared Memory Now most computers have a mixed architecture + accelerators

More information

Parallel Asynchronous Hybrid Krylov Methods for Minimization of Energy Consumption. Langshi CHEN 1,2,3 Supervised by Serge PETITON 2

Parallel Asynchronous Hybrid Krylov Methods for Minimization of Energy Consumption. Langshi CHEN 1,2,3 Supervised by Serge PETITON 2 1 / 23 Parallel Asynchronous Hybrid Krylov Methods for Minimization of Energy Consumption Langshi CHEN 1,2,3 Supervised by Serge PETITON 2 Maison de la Simulation Lille 1 University CNRS March 18, 2013

More information

Weile Jia 1, Long Wang 1, Zongyan Cao 1, Jiyun Fu 1, Xuebin Chi 1, Weiguo Gao 2, Lin-Wang Wang 3

Weile Jia 1, Long Wang 1, Zongyan Cao 1, Jiyun Fu 1, Xuebin Chi 1, Weiguo Gao 2, Lin-Wang Wang 3 A plane wave pseudopotential density functional theory molecular dynamics code on multi-gpu machine - GPU Technology Conference, San Jose, May 17th, 2012 Weile Jia 1, Long Wang 1, Zongyan Cao 1, Jiyun

More information

Petascale Quantum Simulations of Nano Systems and Biomolecules

Petascale Quantum Simulations of Nano Systems and Biomolecules Petascale Quantum Simulations of Nano Systems and Biomolecules Emil Briggs North Carolina State University 1. Outline of real-space Multigrid (RMG) 2. Scalability and hybrid/threaded models 3. GPU acceleration

More information

Explore Computational Power of GPU in Electromagnetics and Micromagnetics

Explore Computational Power of GPU in Electromagnetics and Micromagnetics Explore Computational Power of GPU in Electromagnetics and Micromagnetics Presenter: Sidi Fu, PhD candidate, UC San Diego Advisor: Prof. Vitaliy Lomakin Center of Magnetic Recording Research, Department

More information

Our Microscope is Made of...

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

More information

Towards accurate calculations of Zn 2+ binding free energies in zinc finger proteins

Towards accurate calculations of Zn 2+ binding free energies in zinc finger proteins Towards accurate calculations of Zn 2+ binding free energies in zinc finger proteins UNDERGRADUATE HONORS RESEARCH THESIS Presented in Partial Fulfillment of the Requirements for the Bachelor of Science

More information

Advanced sampling. fluids of strongly orientation-dependent interactions (e.g., dipoles, hydrogen bonds)

Advanced sampling. fluids of strongly orientation-dependent interactions (e.g., dipoles, hydrogen bonds) Advanced sampling ChE210D Today's lecture: methods for facilitating equilibration and sampling in complex, frustrated, or slow-evolving systems Difficult-to-simulate systems Practically speaking, one is

More information

Heterogeneous programming for hybrid CPU-GPU systems: Lessons learned from computational chemistry

Heterogeneous programming for hybrid CPU-GPU systems: Lessons learned from computational chemistry Heterogeneous programming for hybrid CPU-GPU systems: Lessons learned from computational chemistry and Eugene DePrince Argonne National Laboratory (LCF and CNM) (Eugene moved to Georgia Tech last week)

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

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

Scalable and Power-Efficient Data Mining Kernels

Scalable and Power-Efficient Data Mining Kernels Scalable and Power-Efficient Data Mining Kernels Alok Choudhary, John G. Searle Professor Dept. of Electrical Engineering and Computer Science and Professor, Kellogg School of Management Director of the

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

Parallel PIPS-SBB Multi-level parallelism for 2-stage SMIPS. Lluís-Miquel Munguia, Geoffrey M. Oxberry, Deepak Rajan, Yuji Shinano

Parallel PIPS-SBB Multi-level parallelism for 2-stage SMIPS. Lluís-Miquel Munguia, Geoffrey M. Oxberry, Deepak Rajan, Yuji Shinano Parallel PIPS-SBB Multi-level parallelism for 2-stage SMIPS Lluís-Miquel Munguia, Geoffrey M. Oxberry, Deepak Rajan, Yuji Shinano ... Our contribution PIPS-PSBB*: Multi-level parallelism for Stochastic

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

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

Improved Adaptive Resolution Molecular Dynamics Simulation

Improved Adaptive Resolution Molecular Dynamics Simulation Improved Adaptive Resolution Molecular Dynamics Simulation Iuliana Marin, Virgil Tudose, Anton Hadar, Nicolae Goga, Andrei Doncescu To cite this version: Iuliana Marin, Virgil Tudose, Anton Hadar, Nicolae

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

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

上海超级计算中心 Shanghai Supercomputer Center. Lei Xu Shanghai Supercomputer Center San Jose

上海超级计算中心 Shanghai Supercomputer Center. Lei Xu Shanghai Supercomputer Center San Jose 上海超级计算中心 Shanghai Supercomputer Center Lei Xu Shanghai Supercomputer Center 03/26/2014 @GTC, San Jose Overview Introduction Fundamentals of the FDTD method Implementation of 3D UPML-FDTD algorithm on GPU

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

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

Accelerating Proton Computed Tomography with GPUs

Accelerating Proton Computed Tomography with GPUs Accelerating Proton Computed Tomography with GPUs Thomas'D.'Uram,'Argonne'Leadership'Compu2ng'Facility' Michael'E.'Papka,'Argonne'Leadership'Compu2ng'Facility,'Northern'Illinois'University' Nicholas'T.'Karonis,'Northern'Illinois'University,'Argonne'Na2onal'Laboratory

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

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

Model Order Reduction via Matlab Parallel Computing Toolbox. Istanbul Technical University

Model Order Reduction via Matlab Parallel Computing Toolbox. Istanbul Technical University Model Order Reduction via Matlab Parallel Computing Toolbox E. Fatih Yetkin & Hasan Dağ Istanbul Technical University Computational Science & Engineering Department September 21, 2009 E. Fatih Yetkin (Istanbul

More information

Parallelization of the Dirac operator. Pushan Majumdar. Indian Association for the Cultivation of Sciences, Jadavpur, Kolkata

Parallelization of the Dirac operator. Pushan Majumdar. Indian Association for the Cultivation of Sciences, Jadavpur, Kolkata Parallelization of the Dirac operator Pushan Majumdar Indian Association for the Cultivation of Sciences, Jadavpur, Kolkata Outline Introduction Algorithms Parallelization Comparison of performances Conclusions

More information

Optimizing the Performance of Reactive Molecular Dynamics Simulations for Multi-core Architectures

Optimizing the Performance of Reactive Molecular Dynamics Simulations for Multi-core Architectures 1 Optimizing the Performance of Reactive Molecular Dynamics Simulations for Multi-core Architectures Hasan Metin Aktulga, Chris Knight, Paul Coffman, Tzu-Ray Shan, Wei Jiang Abstract Hybrid parallelism

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

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

Performing 2D Hamiltonian-Exchange method for Biological Free Energy Calculations on Petascale Supercomputer

Performing 2D Hamiltonian-Exchange method for Biological Free Energy Calculations on Petascale Supercomputer Performing D Hamiltonian-Echange method for Biological Free Energy Calculations on Petascale Supercomputer Yun Lyna Luo, Wei Jiang, Benoît Rou* Argonne Leadership Computing Facility, Argonne National Laboratory

More information

Anton, a Special-Purpose Machine for Molecular Dynamics Simulation

Anton, a Special-Purpose Machine for Molecular Dynamics Simulation Anton, a Special-Purpose Machine for Molecular Dynamics Simulation David E. Shaw, Martin M. Deneroff, Ron O. Dror, Jeffrey S. Kuskin, Richard H. Larson, John K. Salmon, Cliff Young, Brannon Batson, Kevin

More information

MOLECULAR DYNAMICS SIMULATIONS OF FRICTION FORCE VERSUS LOAD

MOLECULAR DYNAMICS SIMULATIONS OF FRICTION FORCE VERSUS LOAD MOLECULAR DYNAMICS SIMULATIONS OF FRICTION FORCE VERSUS LOAD Ana-Camelia Pirghie Stefan cel Mare University of Suceava, Department of Mechanics and Technology, camelia.pirghie@fim.usv.ro Abstract: The

More information

Using GPUs for faster LAMMPS particle simulations

Using GPUs for faster LAMMPS particle simulations Using GPUs for faster LAMMPS particle simulations Paul S. Crozier Exploiting New Computer Architectures in Molecular Dynamics Simulations March 23, 2011 Sandia National Laboratories is a multi-program

More information

Trivially parallel computing

Trivially parallel computing Parallel Computing After briefly discussing the often neglected, but in praxis frequently encountered, issue of trivially parallel computing, we turn to parallel computing with information exchange. Our

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

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

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

More information