High Performance Computing

Size: px
Start display at page:

Download "High Performance Computing"

Transcription

1 High Performance Computing ADVANCED SCIENTIFIC COMPUTING Dr. Ing. Morris Riedel Adjunct Associated Professor School of Engineering and Natural Sciences, University of Iceland Research Group Leader, Juelich Supercomputing Centre, Germany SHORT LECTURE 14 Molecular Systems & Libraries November 9 th, 2017 Room Ág-303

2 Review of Lecture 13 Systems Biology & Bioinformatics Protein Folding Function of a protein is closely related to its 3D shape BLAST & Role of Databases query target (1) Compares gene sequences to DBs (2) Calculates match significance Monte Carlo Methods Pointwise real data inputs Pointwise sampling from probability distribution Inputs model (w/o monte carlo) model (with monte carlo) Output Output [1] Wikipedia on Monte Carlo method [2] S. Mohanty et al, JSC Simlab Biology modified from [3] Sequence Searching 2/ 27

3 HPC-A[dvanced] Scientific Computing Second Part Consists of techniques for programming large-scale HPC Systems Approach: Get a broad understanding what HPC is and what can be done Goal: Train general HPC techniques and bits of domain-specific applications Domain-specific Science & Engineering A Domain-specific Molecular Systems High Performance Computing (a field of constant changes) HPC A Course Domain-specific Application Libraries Domain-specific Science & Engineering N 3/ 27

4 Outline of the Course 1. High Performance Computing 2. Parallelization Fundamentals 3. Parallel Programming with MPI 4. Advanced MPI Techniques 5. Parallel Algorithms & Data Structures 6. Parallel Programming with OpenMP 7. Hybrid Programming & Patterns 8. Debugging & Profiling Techniques 9. Performance Optimization & Tools 10. Scalable HPC Infrastructures & GPUs 11. Scientific Visualization & Steering 12. Terrestrial Systems & Climate 13. Systems Biology & Bioinformatics 14. Molecular Systems & Libraries 15. Computational Fluid Dynamics 16. Finite Elements Method 17. Machine Learning & Data Mining 18. Epilogue + additional practical lectures for our hands-on exercises in context 4/ 27

5 Outline Molecular Systems Terminology & Motivation Ab Initio Calculations Molecular Docking Molecular Dynamics Selected Methods & Libraries NAMD CPMD MP2C AMBER Parallel Interoperability Application Short Lecture only shows subsets of libraries & applications in domains Selected promises from previous lecture(s): Lecture 2: Lectures will provide details on applied parallelization methods within parallel applications Lecture 4: Lectures will provide parallel application examples that take advantage of the NetCDF Lecture 5: Lecture 14 will give indepth details on parallel molecular systems algorithms, tools, and methods Lecture 10: Lecture 14 will provide insights into application packages that are able to leverage also GPGPUs Lecture 11: Lectures will provide scientific visualizations for different HPC application domain fields 5/ 27

6 Molecular Systems 6/ 27

7 Molecular Systems Terminology & Motivation Molecular systems refers to techniques to model the behaviour (and dynamics) of molecules Used in many domains (e.g. computational chemistry, biology, materials science, drug design, etc.) Domain-specific usage E.g. used to understand small chemical systems or large biological molecules (e.g. proteins, cf. Lecture 13) E.g. used to study large material assemblies (with many thousands to millions of atoms) Different Approaches Common is to enable atomistic level description of the molecular system A wide variety of methods and libraries evolved over time Parallelization techniques are used to make studying molecular systems possible modified from [4] Wikipedia on Molecular Modelling (molecular model of a protein) (molecules are a group of two or more atoms held together by chemical bonds) (atoms are the smallest unit that defines the chemical elements: chemical substances consisting of a single type of atom) [6] Wikipedia on Atoms [5] Wikipedia on Molecule (consists of electron cloud & nucleus of protons and neutrons) 7/ 27

8 Molecular Systems Terminology Different Approaches Molecular Mechanics (aka coarse granular ) Systems treat atoms as the smallest individual unit Potential energy of systems is calculated using force fields Quantum Chemistry / Mechanics (aka more fine granular ) Experiments of chemical systems with focus of quantum mechanics in physical models Quantum mechanics provides a mathematical description (i.e. equations) of much of the behavior and interactions of energy and matter Explicitly models electrons of each atom (force field) [7] Wikipedia on Molecular Mechanics [8] Wikipedia on Quantum Chemistry (Schroedinger Equation) (describe the behaviour of a particle in a field of force) [9] Wikipedia on Quantum Mechanics 8/ 27

9 Molecular Systems Terminology Ab Initio Calculations Ab initio calculations rely on basic and established laws of nature w/o additional assumptions Ab initio calculations in computational chemistry refer to methods based on quantum chemistry Term often used in science & engineering Also known as from first principles calculations or from the beginning E.g. Terrestrial Systems Terrestrial systems: ab initio calculation of liquid water includes the properties of the constituent hydrogen and oxygen atoms Calculation use these properties with the established laws of electrostatics and quantum mechanics (1 water molecule groups of them water) E.g. Bioinformatics / Biophysics modified from [10] Wikipedia on Ab initio Bioinformatics: term used to define methods for making predictions about biological features using a computational model Biophysics: term used to define methods for the prediction of protein structures in protein folding (cf. Lecture 13) as computational model 9/ 27

10 Molecular Systems Terminology Molecular Docking Molecular docking is a method to determine whether one molecule can bind to another Predicting strength of the association or binding affinity between two molecules with score function Approach E.g. Geometric matching shape complementarity methods describe the protein (cf. Lecture 13) and ligand as a set of features that make them dockable Computational complexity Relatively small (simulation of docking becomes more larger) E.g. nicely parallizable (i.e. HTC) Selected applications fields Used to predict the binding orientation of small molecule drug candidates to their protein targets The binding orientation in turn predict the affinity and activity of the small molecule modified from [11] Wikipedia on Molecular Docking (docking of a small molecule ligand to a protein receptor to produce a complex) (once docked a simulation of time is useful to apply) 10 / 27

11 Molecular Systems Terminology Molecular Dynamics Molecular dynamics (MD) refers to the simulation of physical movement of atoms and molecules Atoms (and whole molecules) interact for a period of time to simulate the motion of the atoms Approach (simplified) Trajectories of atoms/molecules are determined by numerically solving Newton s equation of motion for a system of interacting particles Forces between particles and potential energy are defined by molecular mechanics force fields Computational complexity Complex molecular systems consist of a vast number of particles Impossible to find solutions analytically Use numerical methods (cf. Lecture 12) Selected application fields modified from [12] Wikipedia on Molecular Dynamics Chemical physics, materials science, biomolecule modelling (electron sub-atomic particle) (atoms/molecules microscopic particle) (Iterative simulation method calculating forces and solving the equations of motion based on the accelerations obtained from the new forces) 11 / 27

12 [Video] Molecular Dynamics Summary [13] YouTube Video Introduction to MD 12 / 27

13 Selected Methods & Libraries 13 / 27

14 Selected Methods & Libraries NAMD Nanoscale Molecular Dynamics (NAMD) is a parallel code designed for HPC simulations of large biomolecular systems to analyse trajectories and study molecular systems Selected Facts Uses the molecular graphics program VMD for simulation setup Free software package and open source Parallelization Based on Charm++ (abstraction of MPI, cf. Lecture 3) Scalable to hundreds of cores (beyond 200,000) Example atoms simulation on a 1ns simulation timescale modified from [14] NAMD Webpage 14 / 27

15 Selected Methods & Libraries CPMD Selected Facts Plane wave / pseudopotential implementation of density functional theory (DFT) designed for ab initio molecular dynamics Free software package (for non-profit organization) Parallelization Shared memory with OpenMP (cf. Lecture 6) Distributed memory with MPI (cf. Lecture 3) Example Car Parinello Molecular Dynamics (CPMD) is a parallel program used for ab initio electronic structure and molecular dynamics simulations Parallel simulation of 32 water molecules modified from [15] CPMD Webpage (task group optimization) (w/o task group optimization) 15 / 27

16 Molecular Systems Parallel Algorithms - Revisited Scientific case: understanding physical movements of atoms and molecules in the context of n-body simulations Molecular dynamics algorithms for interacting particles Determine trajectories of atoms and molecules Numerically solving the Newton s equations of motion Forces between particles and potential energy is parallel computed according to molecular mechanics force field methods E.g. MP2C code: particle-based hydrodynamics (fluid simulations) Flow field in a gas diffusion membrane 16 / 27

17 Selected Methods & Libraries MP2C MP2C stands for Massively Parallel Multi-Particle Collision Dynamics MP2C is a molecular dynamics code that focusses on mesoscopic particles Selected Facts Implements a hybrid representation of solvated particles in a fluid Parallelization Based on MPI (cf. Lecture 3) Scalable parallel/io (via SionLib, cf. Lecture 4) Example Flow field in gas diffusion membrane Particle-based hydrodynamics application (highly scalable fluid simulation) [16] MP2C Web page (Flow field in a gas diffusion membrane) Lecture 15 will give further details on computational fluid dynamics (CFD) techniques & codes 17 / 27

18 GPGPUs Selected Applications Revisited Human brain research Example: Registration of high resolution brain images [17] NVidia Application Lab Juelich AMBER / CHARMM applications Molecular dynamics package to simulate molecular dynamics on biomolecules Emerging support for GPGPU processing 18 / 27

19 Selected Methods & Libraries AMBER AMBER stands for Assisted Model Building with Energy Refinement AMBER is a set of molecular mechanical force fields for simulating biomolecules & MD software Selected Facts AMBER is a MD suite of several programs Parallelization Full 3D domain decomposition (cf. Lecture 2) Parallel NetCDF (cf. Lecture 4) Offers CUDA GPU use (cf. Lecture 10) Example (Integrase is one of the three essential enzymes required for replication of the HIC-1 virus) Simulation of HIV-1 integrase enzyime Understanding challenging diseases like retroviruses (e.g. HIV) [18] AMBER 19 / 27

20 Parallel Network Common Data Form (NETCDF) - Revisited NETCDF is a portable and self-describing file format used for array-oriented data (e.g. vectors) Simple vector example: Create a NetCDF data set with one one-dimensional variable A local vector of integers should be allocated and initialized with the task number Each task should write his vector to the NetCDF data set as a part of the global vector (cf. Lecture 4) [19] I/O workshop [20] E. Hartnett 20 / 27

21 Using High Throughput Computing & Grids Revisited Use of Interoperability of two different computing paradigms E.g. use of HTC in EGI and HPC in PRACE infrastructures (Web-based portal make complex infrastructure access easy for biological domain scientists) HTC HPC [21] M. Riedel et al., Research Advances by using interoperable e-science Infrastructures, / 27

22 [Video] Towards Simulating Jökulsárlón [22] YouTube Video A molecule's eye view of ice melting 22 / 27

23 Lecture Bibliography 23 / 27

24 Lecture Bibliography (1) [1] Wikipedia on Monte Carlo, Online: [2] JSC Simulation Lab Biology, Online: [3] J. Archuleta et al., A Maintainable Software Architecture for Fast and Modular Bioinformatics Sequence Search, Sequence Searching, 2007 [4] Wikipedia on Molecular Modelling, Online: [5] Wikipedia on Molecule, Online: [6] Wikipedia on Atom, Online: [7] Wikipedia on Molecular Mechanics, Online: [8] Wikipedia on Quantum Chemistry, Online: [9] Wikipedia on Quantum Mechanics, Online: [10] Wikipedia on Ab initio, Online: [11] Wikipedia on Molecular Docking, Online: 24 / 27

25 Lecture Bibliography (2) [12] Wikipedia on Molecular Dynamics, Outline: [13] YouTube Video, An Introduction to Molecular Dynamics, Online: [14] NAMD Web page, Online: [15] CPMD Web page, Online: [16] MP2C Webpage, Online: [17] Juelich NVidia Application Online: [18] D.A. Case, V. Babin, J.T. Berryman, R.M. Betz, Q. Cai, D.S. Cerutti, T.E. Cheatham, III, T.A. Darden, R.E. Duke, H. Gohlke, A.W. Goetz, S. Gusarov, N. Homeyer, P. Janowski, J. Kaus, I. Kolossváry, A. Kovalenko, T.S. Lee, S. LeGrand, T. Luchko, R. Luo, B. Madej, K.M. Merz, F. Paesani, D.R. Roe, A. Roitberg, C. Sagui, R. Salomon-Ferrer, G. Seabra, C.L. Simmerling, W. Smith, J. Swails, R.C. Walker, J. Wang, R.M. Wolf, X. Wu and P.A. Kollman (2014), AMBER 14, University of California, San Francisco. [19] Wolfgang Frings, Florian Janetzko, Michael Stephan, Portable Parallel I/O - Parallel netcdf, Parallel I/O Workshop, Juelich Supercomputing Centre, 2014, Online: blob=publicationfile [20] E. Hartnett, : NetCDF and HDF5 - HDF5 Workshop / 27

26 Lecture Bibliography (3) [21] M. Riedel et al., Research Advances by using Interoperable e-science Infrastructures, Journal of Cluster Computing, 12(4): , [22] YouTube Video, A molecule's eye view of ice melting, Online: 26 / 27

27 27 / 27

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

Estimating Convergence Probability for the Hartree-Fock Algorithm for Calculating Electronic Wavefunctions for Molecules

Estimating Convergence Probability for the Hartree-Fock Algorithm for Calculating Electronic Wavefunctions for Molecules Estimating Convergence Probability for the Hartree-Fock Algorithm for Calculating Electronic Wavefunctions for Molecules Sofia Izmailov, Fang Liu December 14, 2012 1 Introduction In quantum mechanics,

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

High Performance Computing

High Performance Computing High Performance Computing ADVANCED SCIENTIFIC COMPUTING Dr. Ing. Morris Riedel Adjunct Associated Professor School of Engineering and Natural Sciences, University of Iceland Research Group Leader, Juelich

More information

Supporting Information Comparative Molecular Dynamics Studies of Human DNA Polymerase η

Supporting Information Comparative Molecular Dynamics Studies of Human DNA Polymerase η Supporting Information Comparative Molecular Dynamics Studies of Human DNA Polymerase η Melek N. Ucisik and Sharon Hammes-Schiffer* Department of Chemistry, University of Illinois at Urbana-Champaign,

More information

Deep Learning. Convolutional Neural Networks Applications

Deep Learning. Convolutional Neural Networks Applications Deep Learning Using a Convolutional Neural Network Dr. Ing. Morris Riedel Adjunct Associated Professor School of Engineering and Natural Sciences, University of Iceland Research Group Leader, Juelich Supercomputing

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

Time-dependence of key H-bond/electrostatic interaction distances in the sirna5-hago2 complexes... Page S14

Time-dependence of key H-bond/electrostatic interaction distances in the sirna5-hago2 complexes... Page S14 Supporting Information Probing the Binding Interactions between Chemically Modified sirnas and Human Argonaute 2 Using Microsecond Molecular Dynamics Simulations S. Harikrishna* and P. I. Pradeepkumar*

More information

Protein structure sampling based on molecular dynamics and improvement of docking prediction

Protein structure sampling based on molecular dynamics and improvement of docking prediction 1 1 1, 2 1 NMR X Protein structure sampling based on molecular dynamics and improvement of docking prediction Yusuke Matsuzaki, 1 Yuri Matsuzaki, 1 Masakazu Sekijima 1, 2 and Yutaka Akiyama 1 When a protein

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

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

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

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

Molecular Modelling for Medicinal Chemistry (F13MMM) Room A36

Molecular Modelling for Medicinal Chemistry (F13MMM) Room A36 Molecular Modelling for Medicinal Chemistry (F13MMM) jonathan.hirst@nottingham.ac.uk Room A36 http://comp.chem.nottingham.ac.uk Assisted reading Molecular Modelling: Principles and Applications. Andrew

More information

Homology modeling. Dinesh Gupta ICGEB, New Delhi 1/27/2010 5:59 PM

Homology modeling. Dinesh Gupta ICGEB, New Delhi 1/27/2010 5:59 PM Homology modeling Dinesh Gupta ICGEB, New Delhi Protein structure prediction Methods: Homology (comparative) modelling Threading Ab-initio Protein Homology modeling Homology modeling is an extrapolation

More information

Integrating Globus into a Science Gateway for Cryo-EM

Integrating Globus into a Science Gateway for Cryo-EM Integrating Globus into a Science Gateway for Cryo-EM Michael Cianfrocco Life Sciences Institute Department of Biological Chemistry University of Michigan Globus World 2018 Impact & growth of Executive

More information

STRUCTURAL BIOINFORMATICS II. Spring 2018

STRUCTURAL BIOINFORMATICS II. Spring 2018 STRUCTURAL BIOINFORMATICS II Spring 2018 Syllabus Course Number - Classification: Chemistry 5412 Class Schedule: Monday 5:30-7:50 PM, SERC Room 456 (4 th floor) Instructors: Ronald Levy, SERC 718 (ronlevy@temple.edu)

More information

Institute for Functional Imaging of Materials (IFIM)

Institute for Functional Imaging of Materials (IFIM) Institute for Functional Imaging of Materials (IFIM) Sergei V. Kalinin Guiding the design of materials tailored for functionality Dynamic matter: information dimension Static matter Functional matter Imaging

More information

Receptor Based Drug Design (1)

Receptor Based Drug Design (1) Induced Fit Model For more than 100 years, the behaviour of enzymes had been explained by the "lock-and-key" mechanism developed by pioneering German chemist Emil Fischer. Fischer thought that the chemicals

More information

Protein-protein interactions of Human Glyoxalase II: findings of a reliable docking protocol

Protein-protein interactions of Human Glyoxalase II: findings of a reliable docking protocol Electronic Supplementary Material (ESI) for Organic & Biomolecular Chemistry. This journal is The Royal Society of Chemistry 2018 SUPPLEMENTARY INFORMATION Protein-protein interactions of Human Glyoxalase

More information

Simulation Laboratories at JSC

Simulation Laboratories at JSC Mitglied der Helmholtz-Gemeinschaft Simulation Laboratories at JSC Paul Gibbon Jülich Supercomputing Centre Jülich Supercomputing Centre Supercomputer operation for Centre FZJ Regional JARA Helmholtz &

More information

Overview & Applications. T. Lezon Hands-on Workshop in Computational Biophysics Pittsburgh Supercomputing Center 04 June, 2015

Overview & Applications. T. Lezon Hands-on Workshop in Computational Biophysics Pittsburgh Supercomputing Center 04 June, 2015 Overview & Applications T. Lezon Hands-on Workshop in Computational Biophysics Pittsburgh Supercomputing Center 4 June, 215 Simulations still take time Bakan et al. Bioinformatics 211. Coarse-grained Elastic

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

PROTEIN-PROTEIN DOCKING REFINEMENT USING RESTRAINT MOLECULAR DYNAMICS SIMULATIONS

PROTEIN-PROTEIN DOCKING REFINEMENT USING RESTRAINT MOLECULAR DYNAMICS SIMULATIONS TASKQUARTERLYvol.20,No4,2016,pp.353 360 PROTEIN-PROTEIN DOCKING REFINEMENT USING RESTRAINT MOLECULAR DYNAMICS SIMULATIONS MARTIN ZACHARIAS Physics Department T38, Technical University of Munich James-Franck-Str.

More information

Klaus Schulten Department of Physics and Theoretical and Computational Biophysics Group University of Illinois at Urbana-Champaign

Klaus Schulten Department of Physics and Theoretical and Computational Biophysics Group University of Illinois at Urbana-Champaign Klaus Schulten Department of Physics and Theoretical and Computational Biophysics Group University of Illinois at Urbana-Champaign GTC, San Jose Convention Center, CA Sept. 20 23, 2010 GPU and the Computational

More information

Computational Biology Course Descriptions 12-14

Computational Biology Course Descriptions 12-14 Computational Biology Course Descriptions 12-14 Course Number and Title INTRODUCTORY COURSES BIO 311C: Introductory Biology I BIO 311D: Introductory Biology II BIO 325: Genetics CH 301: Principles of Chemistry

More information

Molecular Mechanics, Dynamics & Docking

Molecular Mechanics, Dynamics & Docking Molecular Mechanics, Dynamics & Docking Lawrence Hunter, Ph.D. Director, Computational Bioscience Program University of Colorado School of Medicine Larry.Hunter@uchsc.edu http://compbio.uchsc.edu/hunter

More information

Introduction to Chemoinformatics and Drug Discovery

Introduction to Chemoinformatics and Drug Discovery Introduction to Chemoinformatics and Drug Discovery Irene Kouskoumvekaki Associate Professor February 15 th, 2013 The Chemical Space There are atoms and space. Everything else is opinion. Democritus (ca.

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

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

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

Cheminformatics platform for drug discovery application

Cheminformatics platform for drug discovery application EGI-InSPIRE Cheminformatics platform for drug discovery application Hsi-Kai, Wang Academic Sinica Grid Computing EGI User Forum, 13, April, 2011 1 Introduction to drug discovery Computing requirement of

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

Density Functional Theory

Density Functional Theory Density Functional Theory Iain Bethune EPCC ibethune@epcc.ed.ac.uk Overview Background Classical Atomistic Simulation Essential Quantum Mechanics DFT: Approximations and Theory DFT: Implementation using

More information

Enhanced Sampling and Free Energy Applications in Biomolecular Modeling

Enhanced Sampling and Free Energy Applications in Biomolecular Modeling Enhanced Sampling and Free Energy Applications in Biomolecular Modeling Emad Tajkhorshid NIH Center for Macromolecular Modeling and Bioinformatics Beckman Institute for Advanced Science and Technology

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

est Drive K20 GPUs! Experience The Acceleration Run Computational Chemistry Codes on Tesla K20 GPU today

est Drive K20 GPUs! Experience The Acceleration Run Computational Chemistry Codes on Tesla K20 GPU today est Drive K20 GPUs! Experience The Acceleration Run Computational Chemistry Codes on Tesla K20 GPU today Sign up for FREE GPU Test Drive on remotely hosted clusters www.nvidia.com/gputestd rive Shape Searching

More information

Atomic Accessibility Radii for Molecular Dynamics Analysis

Atomic Accessibility Radii for Molecular Dynamics Analysis Zuse Institute Berlin Takustr. 7 14195 Berlin Germany NORBERT LINDOW 1, DANIEL BAUM 2, HANS-CHRISTIAN HEGE 3 Atomic Accessibility Radii for Molecular Dynamics Analysis 1 0000-0001-5143-2573 2 0000-0003-1550-7245

More information

Crossing the Chasm. On the Paths to Exascale: Presented by Mike Rezny, Monash University, Australia

Crossing the Chasm. On the Paths to Exascale: Presented by Mike Rezny, Monash University, Australia On the Paths to Exascale: Crossing the Chasm Presented by Mike Rezny, Monash University, Australia michael.rezny@monash.edu Crossing the Chasm meeting Reading, 24 th October 2016 Version 0.1 In collaboration

More information

ONETEP PB/SA: Application to G-Quadruplex DNA Stability. Danny Cole

ONETEP PB/SA: Application to G-Quadruplex DNA Stability. Danny Cole ONETEP PB/SA: Application to G-Quadruplex DNA Stability Danny Cole Introduction Historical overview of structure and free energy calculation of complex molecules using molecular mechanics and continuum

More information

CMPS 6630: Introduction to Computational Biology and Bioinformatics. Tertiary Structure Prediction

CMPS 6630: Introduction to Computational Biology and Bioinformatics. Tertiary Structure Prediction CMPS 6630: Introduction to Computational Biology and Bioinformatics Tertiary Structure Prediction Tertiary Structure Prediction Why Should Tertiary Structure Prediction Be Possible? Molecules obey the

More information

ALL LECTURES IN SB Introduction

ALL LECTURES IN SB Introduction 1. Introduction 2. Molecular Architecture I 3. Molecular Architecture II 4. Molecular Simulation I 5. Molecular Simulation II 6. Bioinformatics I 7. Bioinformatics II 8. Prediction I 9. Prediction II ALL

More information

The importance of protonation and tautomerization in relative binding affinity prediction: a comparison of AMBER TI and Schrödinger FEP

The importance of protonation and tautomerization in relative binding affinity prediction: a comparison of AMBER TI and Schrödinger FEP J Comput Aided Mol Des (2016) 30:533 539 DOI 10.1007/s10822-016-9920-5 The importance of protonation and tautomerization in relative binding affinity prediction: a comparison of AMBER TI and Schrödinger

More information

In silico pharmacology for drug discovery

In silico pharmacology for drug discovery In silico pharmacology for drug discovery In silico drug design In silico methods can contribute to drug targets identification through application of bionformatics tools. Currently, the application of

More information

Lecture: Computational Systems Biology Universität des Saarlandes, SS Introduction. Dr. Jürgen Pahle

Lecture: Computational Systems Biology Universität des Saarlandes, SS Introduction. Dr. Jürgen Pahle Lecture: Computational Systems Biology Universität des Saarlandes, SS 2012 01 Introduction Dr. Jürgen Pahle 24.4.2012 Who am I? Dr. Jürgen Pahle 2009-2012 Manchester Interdisciplinary Biocentre, The University

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

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

A DFT and ONIOM study of C H hydroxylation catalyzed. by nitrobenzene 1,2-dioxygenase

A DFT and ONIOM study of C H hydroxylation catalyzed. by nitrobenzene 1,2-dioxygenase Electronic Supplementary Material (ESI) for Physical Chemistry Chemical Physics. This journal is the Owner Societies 2014 A DFT and ONIOM study of C H hydroxylation catalyzed by nitrobenzene 1,2-dioxygenase

More information

DATA ANALYTICS IN NANOMATERIALS DISCOVERY

DATA ANALYTICS IN NANOMATERIALS DISCOVERY DATA ANALYTICS IN NANOMATERIALS DISCOVERY Michael Fernandez OCE-Postdoctoral Fellow September 2016 www.data61.csiro.au Materials Discovery Process Materials Genome Project Integrating computational methods

More information

CHE210D Principles of Modern Molecular Simulation Methods

CHE210D Principles of Modern Molecular Simulation Methods CHE210D Principles of Modern Molecular Simulation Methods Instructor: M. Scott Shell Spring Quarter 2012 TuTh 12:30-1:45pm in Eng II 1519 www.engr.ucsb.edu/~shell/che210d The goals of this course This

More information

Turbulence Simulations

Turbulence Simulations Innovatives Supercomputing in Deutschland Innovative HPC in Germany Vol. 14 No. 2 Autumn 2016 Turbulence Simulations The world s largest terrestrial & astrophysical applications Vice World Champion HLRS

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

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

Protein structure prediction. CS/CME/BioE/Biophys/BMI 279 Oct. 10 and 12, 2017 Ron Dror

Protein structure prediction. CS/CME/BioE/Biophys/BMI 279 Oct. 10 and 12, 2017 Ron Dror Protein structure prediction CS/CME/BioE/Biophys/BMI 279 Oct. 10 and 12, 2017 Ron Dror 1 Outline Why predict protein structure? Can we use (pure) physics-based methods? Knowledge-based methods Two major

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

Basic introduction of NWChem software

Basic introduction of NWChem software Basic introduction of NWChem software Background! NWChem is part of the Molecular Science Software Suite! Designed and developed to be a highly efficient and portable Massively Parallel computational chemistry

More information

Topology based deep learning for biomolecular data

Topology based deep learning for biomolecular data Topology based deep learning for biomolecular data Guowei Wei Departments of Mathematics Michigan State University http://www.math.msu.edu/~wei American Institute of Mathematics July 23-28, 2017 Grant

More information

Modeling Biomolecular Systems II. BME 540 David Sept

Modeling Biomolecular Systems II. BME 540 David Sept Modeling Biomolecular Systems II BME 540 David Sept Introduction Why do we perform simulations? What makes simulations possible? How do we perform simulations? What types of things/systems do we simulate?

More information

Scalable Systems for Computational Biology

Scalable Systems for Computational Biology John von Neumann Institute for Computing Scalable Systems for Computational Biology Ch. Pospiech published in From Computational Biophysics to Systems Biology (CBSB08), Proceedings of the NIC Workshop

More information

Definition of Matter. Subatomic particles 8/20/2012

Definition of Matter. Subatomic particles 8/20/2012 Interplay of Biology and Chemistry Here is a link to the video these beetles are fairly common locally an amazing adaptation, and a good example of chemistry and physics in biology. Also look for creationist-evolutionist

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

CMPS 3110: Bioinformatics. Tertiary Structure Prediction

CMPS 3110: Bioinformatics. Tertiary Structure Prediction CMPS 3110: Bioinformatics Tertiary Structure Prediction Tertiary Structure Prediction Why Should Tertiary Structure Prediction Be Possible? Molecules obey the laws of physics! Conformation space is finite

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

Is there a future for quantum chemistry on supercomputers? Jürg Hutter Physical-Chemistry Institute, University of Zurich

Is there a future for quantum chemistry on supercomputers? Jürg Hutter Physical-Chemistry Institute, University of Zurich Is there a future for quantum chemistry on supercomputers? Jürg Hutter Physical-Chemistry Institute, University of Zurich Chemistry Chemistry is the science of atomic matter, especially its chemical reactions,

More information

An introduction to Molecular Dynamics. EMBO, June 2016

An introduction to Molecular Dynamics. EMBO, June 2016 An introduction to Molecular Dynamics EMBO, June 2016 What is MD? everything that living things do can be understood in terms of the jiggling and wiggling of atoms. The Feynman Lectures in Physics vol.

More information

Early Stages of Drug Discovery in the Pharmaceutical Industry

Early Stages of Drug Discovery in the Pharmaceutical Industry Early Stages of Drug Discovery in the Pharmaceutical Industry Daniel Seeliger / Jan Kriegl, Discovery Research, Boehringer Ingelheim September 29, 2016 Historical Drug Discovery From Accidential Discovery

More information

The Fruit Fly Brain Observatory

The Fruit Fly Brain Observatory The Fruit Fly Brain Observatory Aurel A. Lazar, Columbia University The Columbia University Team: Wesley Bruning Allison L. Fenichel Aurel A. Lazar (PI) Nikul H. Ukani Chung-Heng Yeh Yiyin Zhou The National

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

Kd = koff/kon = [R][L]/[RL]

Kd = koff/kon = [R][L]/[RL] Taller de docking y cribado virtual: Uso de herramientas computacionales en el diseño de fármacos Docking program GLIDE El programa de docking GLIDE Sonsoles Martín-Santamaría Shrödinger is a scientific

More information

Professor: Arpita Upadhyaya Physics 131

Professor: Arpita Upadhyaya Physics 131 - Fundamentals of Physics for Biologists i I Professor: Arpita Upadhyaya Quiz 7 Random Motion Diffusion 2 So far we have studied about 1-5 objects. to study cells, fluids,etc LOTS of objects MANY interactions

More information

An Informal AMBER Small Molecule Force Field :

An Informal AMBER Small Molecule Force Field : An Informal AMBER Small Molecule Force Field : parm@frosst Credit Christopher Bayly (1992-2010) initiated, contributed and lead the efforts Daniel McKay (1997-2010) and Jean-François Truchon (2002-2010)

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

MOLECULAR MODELING IN BIOLOGY (BIO 3356) SYLLABUS

MOLECULAR MODELING IN BIOLOGY (BIO 3356) SYLLABUS New York City College of Technology School of Arts and Sciences Department of Biological Sciences MOLECULAR MODELING IN BIOLOGY (BIO 3356) SYLLABUS Course Information Course Title: Molecular Modeling in

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

Simulation environment for Life Sciences

Simulation environment for Life Sciences www.bsc.es Simulation environment for Life Sciences BSC - 14-15 March 2013 1 Objective Overview of simulation technologies used in Life Sciences and their specific adaptation to HPC environment. OUTLINE

More information

Virtual material Design

Virtual material Design Fraunhofer Institute for Algorithms and Scientific Computing SCAI Virtual material Design Foto: viastore systems 1 virtual Material Design Many of the challenges of the 21st century such as the development

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

NIKOLAY V. PLOTNIKOV. Research Experience

NIKOLAY V. PLOTNIKOV. Research Experience NIKOLAY V. PLOTNIKOV Stanford University 333 Campus Drive Stanford, CA 94305-4401 Mudd Building 121, MB 88 Work: 650-926-3304 Mobile: 213-769-6159 Email: nplotnikov@gmail.com nplotnik@stanford.edu Education

More information

MURCIA: Fast parallel solvent accessible surface area calculation on GPUs and application to drug discovery and molecular visualization

MURCIA: Fast parallel solvent accessible surface area calculation on GPUs and application to drug discovery and molecular visualization MURCIA: Fast parallel solvent accessible surface area calculation on GPUs and application to drug discovery and molecular visualization Eduardo J. Cepas Quiñonero Horacio Pérez-Sánchez Wolfgang Wenzel

More information

Chemical properties that affect binding of enzyme-inhibiting drugs to enzymes

Chemical properties that affect binding of enzyme-inhibiting drugs to enzymes Introduction Chemical properties that affect binding of enzyme-inhibiting drugs to enzymes The production of new drugs requires time for development and testing, and can result in large prohibitive costs

More information

October 08-11, Co-Organizer Dr. S D Samantaray Professor & Head,

October 08-11, Co-Organizer Dr. S D Samantaray Professor & Head, A Journey towards Systems system Biology biology :: Biocomputing of of Hi-throughput Omics omics Data data October 08-11, 2018 Coordinator Dr. Anil Kumar Gaur Professor & Head Department of Molecular Biology

More information

Molecular Dynamics for Microsystems. Introduction Evgenii B. Rudnyi and Jan G. Korvink IMTEK Albert Ludwig University Freiburg, Germany

Molecular Dynamics for Microsystems. Introduction Evgenii B. Rudnyi and Jan G. Korvink IMTEK Albert Ludwig University Freiburg, Germany Molecular Dynamics for Microsystems. Introduction Evgenii B. Rudnyi and Jan G. Korvink IMTEK Albert Ludwig University Freiburg, Germany Preliminaries Learning Goals Why Molecular Simulation? Molecular

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

Life Science Webinar Series

Life Science Webinar Series Life Science Webinar Series Elegant protein- protein docking in Discovery Studio Francisco Hernandez-Guzman, Ph.D. November 20, 2007 Sr. Solutions Scientist fhernandez@accelrys.com Agenda In silico protein-protein

More information

Computational chemical biology to address non-traditional drug targets. John Karanicolas

Computational chemical biology to address non-traditional drug targets. John Karanicolas Computational chemical biology to address non-traditional drug targets John Karanicolas Our computational toolbox Structure-based approaches Ligand-based approaches Detailed MD simulations 2D fingerprints

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

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

Development of Software Package for Determining Protein Titration Properties

Development of Software Package for Determining Protein Titration Properties Development of Software Package for Determining Protein Titration Properties By Kaila Bennett, Amitoj Chopra, Jesse Johnson, Enrico Sagullo Bioengineering 175-Senior Design University of California Riverside

More information

USING BLAST TO IDENTIFY PROTEINS THAT ARE EVOLUTIONARILY RELATED ACROSS SPECIES

USING BLAST TO IDENTIFY PROTEINS THAT ARE EVOLUTIONARILY RELATED ACROSS SPECIES USING BLAST TO IDENTIFY PROTEINS THAT ARE EVOLUTIONARILY RELATED ACROSS SPECIES HOW CAN BIOINFORMATICS BE USED AS A TOOL TO DETERMINE EVOLUTIONARY RELATIONSHPS AND TO BETTER UNDERSTAND PROTEIN HERITAGE?

More information

JCICS Major Research Areas

JCICS Major Research Areas JCICS Major Research Areas Chemical Information Text Searching Structure and Substructure Searching Databases Patents George W.A. Milne C571 Lecture Fall 2002 1 JCICS Major Research Areas Chemical Computation

More information

Chemical properties that affect binding of enzyme-inhibiting drugs to enzymes

Chemical properties that affect binding of enzyme-inhibiting drugs to enzymes Chemical properties that affect binding of enzyme-inhibiting drugs to enzymes Introduction The production of new drugs requires time for development and testing, and can result in large prohibitive costs

More information

File ISM02. Dynamics of Soft Matter

File ISM02. Dynamics of Soft Matter File ISM02 Dynamics of Soft Matter 1 Modes of dynamics Quantum Dynamics t: fs-ps, x: 0.1 nm (seldom of importance for soft matter) Molecular Dynamics t: ps µs, x: 1 10 nm Brownian Dynamics t: ns>ps, x:

More information

Understanding hydrogen storage in metal organic frameworks from first principles

Understanding hydrogen storage in metal organic frameworks from first principles Understanding hydrogen storage in metal organic frameworks from first principles Understanding hydrogen storage in metal organic frameworks from first principles Sohrab Ismail-Beigi (Yale Applied Physics)

More information

Basic introduction of NWChem software

Basic introduction of NWChem software Basic introduction of NWChem software Background NWChem is part of the Molecular Science Software Suite Designed and developed to be a highly efficient and portable Massively Parallel computational chemistry

More information

Statistical Clustering of Vesicle Patterns Practical Aspects of the Analysis of Large Datasets with R

Statistical Clustering of Vesicle Patterns Practical Aspects of the Analysis of Large Datasets with R Statistical Clustering of Vesicle Patterns Mirko Birbaumer Rmetrics Workshop 3th July 2008 1 / 23 Statistical Clustering of Vesicle Patterns Practical Aspects of the Analysis of Large Datasets with R Mirko

More information

Agua. Steven E. Massey, Ph.D. Associate Professor Department of Biology University of Puerto Rico Río Piedras

Agua. Steven E. Massey, Ph.D. Associate Professor Department of Biology University of Puerto Rico Río Piedras Agua Steven E. Massey, Ph.D. Associate Professor Department of Biology University of Puerto Rico Río Piedras Office & Lab: Bioinformatics Lab NCN343B 787-764-0000 ext. 7798 stevenemassey@gmail.com Why

More information

Calculation of ground states of few-body nuclei using NVIDIA CUDA technology

Calculation of ground states of few-body nuclei using NVIDIA CUDA technology Calculation of ground states of few-body nuclei using NVIDIA CUDA technology M. A. Naumenko 1,a, V. V. Samarin 1, 1 Flerov Laboratory of Nuclear Reactions, Joint Institute for Nuclear Research, 6 Joliot-Curie

More information

Contents 1 Open-Source Tools, Techniques, and Data in Chemoinformatics

Contents 1 Open-Source Tools, Techniques, and Data in Chemoinformatics Contents 1 Open-Source Tools, Techniques, and Data in Chemoinformatics... 1 1.1 Chemoinformatics... 2 1.1.1 Open-Source Tools... 2 1.1.2 Introduction to Programming Languages... 3 1.2 Chemical Structure

More information

INTENSIVE COMPUTATION. Annalisa Massini

INTENSIVE COMPUTATION. Annalisa Massini INTENSIVE COMPUTATION Annalisa Massini 2015-2016 Course topics The course will cover topics that are in some sense related to intensive computation: Matlab (an introduction) GPU (an introduction) Sparse

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