“One Ring to Rule Them All”

Total Page:16

File Type:pdf, Size:1020Kb

“One Ring to Rule Them All” OpenMM library “One ring to rule them all” https://simtk.org/home/openmm CHARMM * Abalone Presto * ACEMD NAMD * ADUN * Ascalaph Gromacs AMBER * COSMOS ??? HOOMD * Desmond * Culgi * ESPResSo Tinker * GROMOS * GULP * Hippo LAMMPS * Kalypso MD * LPMD * MacroModel * MDynaMix * MOLDY * Materials Studio * MOSCITO * ProtoMol The OpenM(olecular)M(echanics) API * RedMD * YASARA * ORAC https://simtk.org/home/openmm * XMD Goals of OpenMM l Complete library l provide what is most needed l easy to learn and use l Fast, general, extensible l optimize for speed l hide hardware specifics l support new hardware l add new force fields, integration methods etc. l Available APIs in C++, Fortran95, Python l Advantages l Object oriented l Modular l Extensible l Disadvantages l Programs written in other languages need to invoke it through a layer of C++ code Features • Electrostatics: cut-off, Ewald, PME • Implicit solvent • Integrators: Verlet, Langevin, Brownian, custom • Thermostat: Andersen • Barostat: MonteCarlo • Others: energy minimization, virtual sites 5 The OpenMM Architecture Public Interface OpenMM Public API Platform Independent Code OpenMM Implementation Layer Platform Abstraction Layer OpenMM Low Level API Computational Kernels CUDA/OpenCL/Brook/MPI etc. Public API Classes (1) l System l A collection of interaction particles l Defines the mass of each particle (needed for integration) l Specifies distance restraints l Contains a list of Force objects that define the interactions l OpenMMContext l Contains all state information for a particular simulation − Positions, velocities, other parmeters Public API Classes (2) l Force l Anything that affects the system's behavior: forces, barostats, thermostats, etc. l A Force may: − Apply forces to particles − Contribute to the potential energy − Define adjustable parameters − Modify positions, velocities, and parameters at the start of each time step l Existing Force subclasses − HarmonicBond, HarmonicAngle, PeriodicTorsion, RBTorsion, Nonbonded, GBSAOBC, AndersenThermostat, CMMotionRemover... Public API Classes (3) l Integrator l Advances the system through time l Only fixed step size integrators are supported l LeapFrog, Langevin, Brownian Integrators l State l A snapshot of the state of the system l Immutable (used only for reporting) l Creating a state is the only way to access positions, velocities, energies or forces. Example • Create a System System system ; for (int i = 0; i < numParticles; ++i) system.addParticle(mass[i]); for (int i = 0; i < numConstraints; ++i) system.addConstraint(constraint[i].atom1, constraint[i].atom2, constraint[i].distance); • Add Forces to it HarmonicBondForce* bonds = new HarmonicBondForce; for (int i = 0; i < numBonds; ++i) bonds->addBond(bond[i].atom1, bond[i].atom2, bond[i].length, bond[i].k); system.addForce(bonds); // ... add Forces for other force !eld terms. Example (continued) • Simulate it LangevinIntegrator integrator(297.0, 1.0, 0.002); // Temperature, friction, // step size OpenMMContext context(system, integrator); context.setPositions(positions); context.setVelocities(velocities); integrator.step(500); // Take 500 steps • Retrieve state information State state = context.getState(State::Positions | State::Velocities); for (int i = 0; i < numParticles ; ++i) cout << state.getPositions()[i] << endl; Some algorithms for stream computing in OpenMM Algorithms for calculation of long-range interactions in MD l O(N2) (all-vs-all) algorithm l O(N) algorithm l Ewald summation (O(N3/2)) l Particle-Mesh Ewald (PME) (O(N*logN) MD simulations on GPUs l Algorithms need to be reconsidered from the ground up l Fast on CPU != Fast on GPU Slow on CPU != Slow on GPU nonbonded interactions in molecular systems l Divide into short-range and long-range interactions l Calculate short-range analytically l Use approximations for the long-range O(N2) (all-vs-all) algorithm on GPUs efficient implementation of O(N2) algorithm would... l minimize global memory access l avoid thread synchronization l take advantage of symmetry algorithm • Group atoms into blocks of 32 • Interactions divide into 32x32 Atoms 0 32 64 96 ... Atoms 0 tiles 32 • Each tile is processed by a group of 32 threads 64 – Load atom coordinates and parameters into shared memory 96 – Each thread computes ... interactions of one atom with 32 atoms – Use symmetry to skip half the tiles algorithm (cont.) • Each thread loops over atoms in a different order – Avoids con#icts between threads • No explicit synchronization needed – Threads in a warp are always synchronized Atoms Threads O(N) algorithm on GPUs why this is hard • Traditional O(N) methods (e.g. neighbor lists) are slow on GPUs – Out of order memory access for i = 1 to numNeighbors load coordinates and parameters for neighbor[i] slow! compute force store force for neighbor[i] slow! • The inner loop contains non-coalesced memory access! general approach 2 • Start with the O(N ) algorithm • Exclude tiles with no interactions – Like a neighbor list between blocks of 32 atoms Atoms 0 32 64 96 128 160 192 224 ... Atoms Atoms 0 32 64 96 128 160 192 224 ... identifying tiles with interactions • Compute an axis aligned bounding box for the 32 atoms in each block • Calculate the distance between bounding boxes solvent molecules • Solvent molecules must be ordered to be spatially coherent – Otherwise bounding boxes will be very large • Arrange along a space !lling curve • Reorder every ~100 time steps performance of this algorithm 2 • Much faster than O(N ) for large systems • Performance scales linearly But • Computes many more interactions than really required Computes– all 1024 interactions in a tile, even if few (or none!) are within the cutoff Finer Grained Neighbor List • For each tile with interactions: – Compute distance of each atom in one block from the bounding box of the other block – Set a #ag for each atom Force Computation for Tile for i = 1 to 32 if (hasInteractions[i]) } on each thread compute interaction with atom i • All 32 threads must loop over atoms in the same order Atoms – Requires a reduction to sum Threads the forces – For a few atoms, this is still much faster – For many atoms, better to just compute all interactions benchmarks Tiling circlesTiling is difficult serial computing stream computing Two issues: • You need a lot of cubes to cover a sphere • All interactions beyond the cut-off need to be zero Para2010 – p. 20/22 TheCalculating art of calculating zeros zeros! GPU 3k, rc=1.5, buffered GPU 48k, rc=1.5, buffered zeros CPU, rc=1.5, no water force loops CPU, rc=1.5 CPU, rc=0.9 0 2000 4000 6000 8000 10000 pair interactions per µs Para2010 – p. 21/22 Ewald summation method Ewald summation method O(N2) algorithm Ewald summation method O(N3 / 2) algorithm for each wave vector K CosSum = 0 SinSum = 0 for each atom i StructureFactor_Real(i) = charge(i) * cos(K.coord(i)) StructureFactor_Imag(i) = charge(i) * sin(K.coord(i)) CosSum += StructureFactor_Real(i) SinSum += StructureFactor_Imag(i) for each atom i force(i) = CosSum * StructureFactor_Imag(i) – SinSum * StructureFactor_Real(i) Ewald O(N3 / 2) algorithm on GPUs CalculateEwaldForces_kernel() // Each thread is processing // one of the atoms CalculateCosSinSums_kernel() atom = threadIdx.x + blockIdx.x * blockDim.x; // Each thread is processing // one of the wave vectors K // Load atom data force = Force(atom) K = threadIdx.x + blockIdx.x * blockDim.x; coord = Coord(atom) // Compute the sum for that K // Loop over all wave vectors. // Compute the force contribution of this wave vector. #oat2 sum = make_#oat2(0.0f, 0.0f); for each wave vector K // Read atom data for each atom i // calculate again (!) the structure sum.x += charge(i) * cos(K.coord(i)) // factor for this wave vector sum.y += charge(i) * sin(K.coord(i)) structureFactor.x = cos(K.coord(i)) structureFactor.y = sin(K.coord(i)) // Store the sum in global memory Sum(K) = sum; // Load the Cosine/Sine Sum from memory cosSinSum = cSim.pEwaldCosSinSum[K]; // Compute the contribution to the energy. force += charge(i) * energy += sum * sum (cosSinSum.x*structureFactor.y- cosSinSum.y*StructureFactor.x) // Store energy in global memory Energy(K) = energy // Record the force on the atom. Force(atom) = force Particle-Mesh Ewald (PME) method Particle-Mesh Ewald method 1) calculate scaled fractionals 2) calculate B-spline coefficient 3) “smear” the charges over the grid points from spline-coefficient 4) execute forward FFT 5) calculate the reciprocal energy 6) execute backward FFT 7) calculate force gradient Particle-Mesh Ewald method CPU GPU spreading of charges gathering of charges l sort the atoms before gather ! OpenMM GPU weak scaling Water box on a Nvidia Telsa2050 0.6 real space 0.4 F reduction q spread/gather 3D FFT s/atom/step 0.2 µ 0 3k 6k 12k 24k 48k 96k # atoms Note: real space cut-off 1.5 nm, on a CPU around 0.9 nm Para2010 – p. 18/22 GPU - CPU comparison Nvidia Tesla 2050 vs Intel Core i7 920 (2.66 GHZ, 4 threads) real space 1 F reduction q spread/gather 3D FFT 0.5 s/atom/step µ 0 GPU 3k GPU 48k CPU rc=1.5 CPU rc=0.9 3 real space cost ∼ rc − FFT cost ∼ spacing 3 for constant accuracy: spacing = rc/a 3 3 −3 total cost: Cpp rc + CFFT a rc Para2010 – p. 19/22 Integrating Gromacs and OpenMM Gromacs & OpenMM in practice Gromacs & OpenMM in practice • GPUs supported in Gromacs 4.5 mdrun ... -device “OpenMM:Cuda” Gromacs & OpenMM in practice • GPUs supported in Gromacs 4.5 mdrun ... -device “OpenMM:Cuda” • Same input files, same output files Gromacs & OpenMM in practice • GPUs supported in Gromacs 4.5 mdrun ... -device “OpenMM:Cuda”
Recommended publications
  • 20 Years of Polarizable Force Field Development
    20 YEARS OF POLARIZABLE FORCEFIELDDEVELOPMENTfor biomolecular systems thor van heesch Supervised by Daan P. Geerke and Paola Gori-Giorg 1 contents 2 1 Introduction 3 2contentsForce fields: Basics, Caveats and Extensions 4 2.1 The Classical Approach . 4 2.2 The caveats of point-charge electrostatics . 8 2.3 Physical phenomenon of polarizability . 10 2.4 Common implementation methods of electronic polarization . 11 2.5 Accounting for anisotropic interactions . 14 3 Knitting the reviews and perspectives together 17 3.1 Polarizability: A smoking gun? . 17 3.2 New branches of electronic polarization . 18 3.3 Descriptions of electrostatics . 19 3.4 Solvation and polarization . 20 3.5 The rise of new challenges . 21 3.6 Parameterization or polarization? . 22 3.7 Enough response: how far away? . 23 3.8 The last perspectives . 23 3.9 A new hope: the next-generation force fields . 29 4 Learning with machines 29 4.1 Replace the functional form with machine learned force fields . 31 4.2 A different take on polarizable force fields . 33 4.3 Are transferable parameters an universal requirement? . 33 4.4 The difference between derivation and prediction . 34 4.5 From small molecules to long range interactions . 36 4.6 Enough knowledge to fold a protein? . 37 4.7 Boltzmann generators, a not so hypothetical machine anymore . 38 5 Summary: The Red Thread 41 introduction 3 In this literature study we aimed to answer the following question: What has changedabstract in the outlook on polarizable force field development during the last 20 years? The theory, history, methods, and applications of polarizable force fields have been discussed to address this question.
    [Show full text]
  • Open Babel Documentation Release 2.3.1
    Open Babel Documentation Release 2.3.1 Geoffrey R Hutchison Chris Morley Craig James Chris Swain Hans De Winter Tim Vandermeersch Noel M O’Boyle (Ed.) December 05, 2011 Contents 1 Introduction 3 1.1 Goals of the Open Babel project ..................................... 3 1.2 Frequently Asked Questions ....................................... 4 1.3 Thanks .................................................. 7 2 Install Open Babel 9 2.1 Install a binary package ......................................... 9 2.2 Compiling Open Babel .......................................... 9 3 obabel and babel - Convert, Filter and Manipulate Chemical Data 17 3.1 Synopsis ................................................. 17 3.2 Options .................................................. 17 3.3 Examples ................................................. 19 3.4 Differences between babel and obabel .................................. 21 3.5 Format Options .............................................. 22 3.6 Append property values to the title .................................... 22 3.7 Filtering molecules from a multimolecule file .............................. 22 3.8 Substructure and similarity searching .................................. 25 3.9 Sorting molecules ............................................ 25 3.10 Remove duplicate molecules ....................................... 25 3.11 Aliases for chemical groups ....................................... 26 4 The Open Babel GUI 29 4.1 Basic operation .............................................. 29 4.2 Options .................................................
    [Show full text]
  • Melissa Gajewski & Jonathan Mane
    Melissa Gajewski & Jonathan Mane Molecular Mechanics (MM) Methods Force fields & potential energy calculations Example using noscapine Molecular Dynamics (MD) Methods Ensembles & trajectories Example using 18-crown-6 Quantum Mechanics (QM) Methods Schrödinger’s equation Semi-empirical (SE) Wave Functional Theory (WFT) Density Functional Theory (DFT) Hybrid QM/MM & MD Methods Comparison of hybrid methods 2 3 Molecular Mechanics (MM) Methods Force fields & potential energy calculations Example using noscapine Molecular Dynamics (MD) Methods Ensembles & trajectories Example using 18-crown-6 Quantum Mechanics (QM) Methods Schrödinger’s equation Semi-empirical (SE) Wave Functional Theory (WFT) Density Functional Theory (DFT) Hybrid QM/MM & MD Methods Comparison of hybrid methods 4 Useful for all system size ◦ Small molecules, proteins, material assemblies, surface science, etc … ◦ Based on Newtonian mechanics (classical mechanics) d F = (mv) dt ◦ The potential energy of the system is calculated using a force field € 5 An atom is considered as a single particle Example: H atom Particle variables: ◦ Radius (typically van der Waals radius) ◦ Polarizability ◦ Net charge Obtained from experiment or QM calculations ◦ Bond interactions Equilibrium bond lengths & angles from experiment or QM calculations 6 All atom approach ◦ Provides parameters for every atom in the system (including hydrogen) Ex: In –CH3 each atom is assigned a set of data MOLDEN MOLDEN (Radius, polarizability, netMOLDENMOLDENMOLDENMOLDENMOLDEN charge,
    [Show full text]
  • BOSS, Version 4.6 Biochemical and Organic Simulation System User’S Manual for UNIX, Linux, and Windows
    BOSS, Version 4.6 Biochemical and Organic Simulation System User’s Manual for UNIX, Linux, and Windows William L. Jorgensen Department of Chemistry, Yale University P. O. Box 208107 New Haven, Connecticut 06520-8107 Phone: (203) 432-6278 Fax: (203) 432-6299 Internet: [email protected] January 2004 Contents Page Introduction 4 1 Can’t Wait to Start – Use the x Scripts 6 2 Statistical Mechanics Simulation – Theory 6 3 Energy and Free Energy Evaluation 7 4 New Features 9 5 Operating Systems 14 6 Installation 14 7 Files 14 8 Command or bat File Input 16 9 Parameter File Input 18 10 Z-matrix File Input 26 10.1 Atom Input 29 10.2 Geometry Variations 29 10.3 Bond Length Variations 29 10.4 Additional Bonds 30 10.5 Harmonic Restraints 30 10.6 Bond Angle Variations 30 10.7 Additional Bond Angles 31 10.8 Dihedral Angle Variations 31 10.9 Additional Dihedral Angles 33 10.10 Domain Definitions 34 10.11 Conformational Searching 34 10.12 Sample Z-matrix 34 10.13 Z-matrix Input for Custom Solvents 35 11 PDB Input 37 12 Coordinate Input in Mind Format and Reaction Path Following 38 13 Pure Liquid Simulations 39 14 Cluster Simulations 39 2 15 Solventless and Molecular Mechanics Calculations 40 15.1 Continuum Simulations 40 15.2 Energy Minimizations 41 15.3 Dihedral Angle Driving 42 15.4 Potential Surface Scanning 42 15.5 Normal Coordinate Analysis 43 15.6 Conformational Searching 45 16 Available Solvent Boxes 48 17 Ewald Summation for Long-Range Electrostatics 50 18 Test Jobs 51 19 Output 56 19.1 Some Variable Definitions 58 20 Contents of the Distribution Files 59 21 Appendix – No.
    [Show full text]
  • Calculation of Effective Interaction Potentials From
    Methodologies of systematic structure-based coarse-graining Alexander Lyubartsev Division of Physical Chemistry Department of Material and Environmental Chemistry Stockholm University E-CAM workshop: State of the art in mesoscale and multiscale modeling Dublin 29-31 May 2017 Outline 1. Multiscale and coarse-grained simulations 2. Systematic structure-based coarse-graining by Inverse Monte Carlo 3. Examples - water and ions - lipid bilayers and lipid assemblies 4. Software - MagiC Example of systematic coarse-graining: DNA in Chromatin: presentation 30 May Computer modeling: from 1st principles to mesoscale Levels of molecular modeling: First-principles Atomistic Meso-scale (Quantum Classical Langevine/ BD, Mechanics) Molecular Dynamics DPD... nuclei electrons atoms coarse-grained biomolecules atoms molecules molecules soft matter 0.1 nm 1.0 nm 10 nm 100 nm 1 000 nm Larger scale more approximations Mesoscale Simulations Length scale: > 10 nm ( nanoscale: 10 - 1000 nm) Atomistic modeling is generally not possible box 10 nm - more than 105 atoms even if doable for 105 - 106 particles - do not forget about time scale! larger size : longer time for equilibration and reliable sampling 105 atoms - time scale should be above 1 ms = 1000 ns Need approximations - coarse-graining Coarse-graining – an example Original size – 2.4Mb Compressed to 24 Kb Levels of coarse- graining Level of coarse-graining can be different. For example, for a DMPC lipid: All-atom model United-atom Coarse-grained Coarse-grained 118 atoms model: 10 sites: 3 sites: 46 united atoms Martini model Cooke model more details - chemical specificity faster computations; larger systems Coarse-graining of solvent: 1) Explicit solvent: 2) Implicit solvent: One or several solvent molecules are No solvent particles but their effect is united in a single site.
    [Show full text]
  • Calculation of Effective Interaction Potentials From
    Systematic Coarse-Graining of Molecular Models by the Inverse Monte Carlo: Theory, Practice and Software Alexander Lyubartsev Division of Physical Chemistry Department of Material and Environmental Chemistry Stockholm University Modeling Soft Matter: Linking Multiple Length and Time Scales Kavli Institute of Theoretical Physics, UCSB, Santa Barbara 4-8 June 2012 Soft Matter Simulations length model method time 1Å electron w.f + ab-initio 100 ps 1 nm nuclei BOMD, CPMD 10 nm atomistic classical MD 100 ns coarse-grained Langevine MD, 100 nm µ more DPD, etc 100 s coarse-grained µ 1 m continuous The problem: Larger scale ⇔ more approximations Coarse-graining – an example Original size - 900K Compressed to 24K Coares-graining: reduction degrees of freedom All-atom model Coarse-grained model Large-scale 118 atoms 10 sites simulations We need to: 1) Design Coarse-Grained mapping: specify the important degrees of freedom 2) For “important” degrees of freedom we need interaction potential Question: what is the interaction potential for the coarse-grained model? Formal solution: N-body mean force potential Original (FG = fine grained system) FG ( ) =θ( ) H r 1, r 2,... ,rn R j r1, ...r n n = 118 j = 1,...,10 Usually, centers of mass of selected molecular fragments Partition function : n =∫∏ (−β ( ))= Z dr i exp H FG r 1, ...,r n i=1 n N =∫∏ ∏ δ( −θ ( )) (−β ( ))= dr i dR j R j j r1, ...rn exp H FG r1, ... ,rn = i1 j 1 N =∫∏ (−β ( )) dR j exp H CG R1, ... , RN j =1 1 where β= k B T n N ( )=−1 ∫∏ ∏ δ( −θ ( )) (− ( )) H CG R1, ..., R N β ln dr i R j
    [Show full text]
  • Tinker-HP : Accelerating Molecular Dynamics Simulations of Large Complex Systems with Advanced Point Dipole Polarizable Force Fields Using Gpus and Multi-Gpus Systems
    Tinker-HP : Accelerating Molecular Dynamics Simulations of Large Complex Systems with Advanced Point Dipole Polarizable Force Fields using GPUs and Multi-GPUs systems Olivier Adjoua,y Louis Lagardère*,y,z Luc-Henri Jolly,z Arnaud Durocher,{ Thibaut Very,x Isabelle Dupays,x Zhi Wang,k Théo Jaffrelot Inizan,y Frédéric Célerse,y,? Pengyu Ren,# Jay W. Ponder,k and Jean-Philip Piquemal∗,y,# ySorbonne Université, LCT, UMR 7616 CNRS, F-75005, Paris, France zSorbonne Université, IP2CT, FR2622 CNRS, F-75005, Paris, France {Eolen, 37-39 Rue Boissière, 75116 Paris, France xIDRIS, CNRS, Orsay, France kDepartment of Chemistry, Washington University in Saint Louis, USA ?Sorbonne Université, CNRS, IPCM, Paris, France. #Department of Biomedical Engineering, The University of Texas at Austin, USA E-mail: [email protected],[email protected] arXiv:2011.01207v4 [physics.comp-ph] 3 Mar 2021 Abstract We present the extension of the Tinker-HP package (Lagardère et al., Chem. Sci., 2018,9, 956-972) to the use of Graphics Processing Unit (GPU) cards to accelerate molecular dynamics simulations using polarizable many-body force fields. The new high-performance module allows for an efficient use of single- and multi-GPUs archi- 1 tectures ranging from research laboratories to modern supercomputer centers. After de- tailing an analysis of our general scalable strategy that relies on OpenACC and CUDA , we discuss the various capabilities of the package. Among them, the multi-precision possibilities of the code are discussed. If an efficient double precision implementation is provided to preserve the possibility of fast reference computations, we show that a lower precision arithmetic is preferred providing a similar accuracy for molecular dynamics while exhibiting superior performances.
    [Show full text]
  • Mai Muuttunut Pilit Muut Aidi Mini
    MAIMUUTTUNUT US009963689B2 PILIT MUUT AIDI MINI (12 ) United States Patent ( 10 ) Patent No. : US 9 ,963 , 689 B2 Doudna et al. ( 45) Date of Patent: May 8 , 2018 ( 54 ) CASI CRYSTALS AND METHODS OF USE FOREIGN PATENT DOCUMENTS THEREOF WO WO 2013 / 126794 AL 8 / 2013 ( 71 ) Applicant: The Regents of the University of wo WO 2013 / 142578 A19 / 2013 California , Oakland , CA (US ) WO WO 2013 / 176772 A1 11/ 2013 ( 72 ) Inventors : Jennifer A . Doudna , Oakland , CA OTHER PUBLICATIONS (US ) ; Samuel H . Sternberg , Oakland , McPherson , A . Current Approaches to Macromolecular Crystalli CA (US ) ; Martin Jinek , Oakland , CA zation . European Journal of Biochemistry . 1990 . vol . 189 , pp . (US ) ; Fuguo Jiang , Oakland , CA (US ); 1 - 23 . * Emine Kaya , Oakland , CA (US ) ; Kundrot, C . E . Which Strategy for a Protein Crystallization Project ? Cellular Molecular Life Science . 2004 . vol . 61, pp . 525 - 536 . * David W . Taylor, Jr. , Oakland , CA Benevenuti et al. , Crystallization of Soluble Proteins in Vapor (US ) Diffusion for X - ray Crystallography , Nature Protocols , published on - line Jun . 28 , 2007 , 2 ( 7 ) : 1633 - 1651. * ( 73 ) Assignee : THE REGENTS OF THE Cudney R . Protein Crystallization and Dumb Luck . The Rigaku UNIVERSITY OF CALIFORNIA , Journal. 1999 . vol. 16 , No . 1 , pp . 1 - 7 . * Drenth , “ Principles of Protein X - Ray Crystallography ” , 2nd Edi Oakland , CA (US ) tion , 1999 Springer - Verlag New York Inc ., Chapter 1 , p . 1 - 21. * Moon et al . , “ A synergistic approach to protein crystallization : ( * ) Notice : Subject to any disclaimer , the term of this Combination of a fixed -arm carrier with surface entropy reduction ” , patent is extended or adjusted under 35 Protein Science , 2010 , 19 : 901 -913 .
    [Show full text]
  • Multiscale Friction Simulation of Dry Polymer Contacts: Reaching Experimental Length Scales by Coupling Molecular Dynamics and Contact Mechanics
    Multiscale Friction Simulation of Dry Polymer Contacts: Reaching Experimental Length Scales by Coupling Molecular Dynamics and Contact Mechanics Daniele Savio ( [email protected] ) Freudenberg Technology Innovation SE &amp; Co. KG https://orcid.org/0000-0003-1908-2379 Jannik Hamann Fraunhofer Institute for Mechanics of Materials: Fraunhofer-Institut fur Werkstoffmechanik IWM Pedro A. Romero Freudenberg Technology Innovation SE &amp; Co. KG Christoph Klingshirn Freudenberg FST GmbH Ravindrakumar Bactavatchalou Freudenberg Technology Innovation SE &amp; Co. KG Martin Dienwiebel Fraunhofer Institute for Mechanics of Materials: Fraunhofer-Institut fur Werkstoffmechanik IWM Michael Moseler Fraunhofer Institute for Mechanics of Materials: Fraunhofer-Institut fur Werkstoffmechanik IWM Research Article Keywords: Coupling Molecular Dynamics, Contact Mechanics, Multiscale Friction Posted Date: February 23rd, 2021 DOI: https://doi.org/10.21203/rs.3.rs-223573/v1 License: This work is licensed under a Creative Commons Attribution 4.0 International License. Read Full License Multiscale friction simulation of dry polymer contacts: reaching experimental length scales by coupling molecular dynamics and contact mechanics Daniele Savio1*, Jannik Hamann2, Pedro A. Romero1, Christoph Klingshirn3, Ravindrakumar Bactavatchalou1, Martin Dienwiebel2,4, Michael Moseler2,5 1 Freudenberg Technology Innovation SE & Co. KG, Weinheim, Germany 2 µTC Microtribology Center, Fraunhofer Institute for Mechanics of Materials IWM, Freiburg, Germany 3 Freudenberg FST GmbH, Weinheim, Germany 4 Karlsruhe Institute of Technology, Institute for Applied Materials, IAM-CMS, Karlsruhe, Germany 5 Institute of Physics, University of Freiburg, Freiburg, Germany *Corresponding author: [email protected] Abstract This work elucidates friction in Poly-Ether-Ether-Ketone (PEEK) sliding contacts through multiscale simulations. At the nanoscale, non-reactive classical molecular dynamics (MD) simulations of dry and water-lubricated amorphous PEEK-PEEK interfaces are performed.
    [Show full text]
  • M.Dynamix Studies of Solvation, Solubility and Permeability
    5 M.DynaMix Studies of Solvation, Solubility and Permeability Aatto Laaksonen1, Alexander Lyubartsev1 and Francesca Mocci1,2 1Stockholm University, Division of Physical Chemistry, Department of Materials and Environmental Chemistry, Arrhenius Laboratory, Stockholm 2Università di Cagliari, Dipartimento di Scienze Chimiche Cittadella Universitaria di Monserrato, Monserrato, Cagliari 1Sweden 2Italy 1. Introduction During the last four decades Molecular Dynamics (MD) simulations have developed to a powerful discipline and finally very close to the early vision from early 80’s that it would mature and become a computer laboratory to study molecular systems in conditions similar to that valid in experimental studies using instruments giving information about molecular structure, interactions and dynamics in condensed phases and at interfaces between different phases. Today MD simulations are more or less routinely used by many scientists originally educated and trained towards experimental work which later have found simulations (along with Quantum Chemistry and other Computational methods) as a powerful complement to their experimental studies to obtain molecular insight and thereby interpretation of their results. In this chapter we wish to introduce a powerful methodology to obtain detailed and accurate information about solvation and solubility of different categories of solute molecules and ions in water (and other solvents and phases including mixed solvents) and also about permeability and transport of solutes in different non-aqueous phases. Among the most challenging problems today are still the computations of the free energy and many to it related problems. The methodology used in our studies for free energy calculations is our Expanded Ensemble scheme recently implemented in a general MD simulation package called “M.DynaMix”.
    [Show full text]
  • Macromodel Quick Start Guide
    MacroModel Quick Start Guide MacroModel 9.9 Quick Start Guide Schrödinger Press MacroModel Quick Start Guide Copyright © 2012 Schrödinger, LLC. All rights reserved. While care has been taken in the preparation of this publication, Schrödinger assumes no responsibility for errors or omissions, or for damages resulting from the use of the information contained herein. BioLuminate, Canvas, CombiGlide, ConfGen, Epik, Glide, Impact, Jaguar, Liaison, LigPrep, Maestro, Phase, Prime, PrimeX, QikProp, QikFit, QikSim, QSite, SiteMap, Strike, and WaterMap are trademarks of Schrödinger, LLC. Schrödinger and MacroModel are registered trademarks of Schrödinger, LLC. MCPRO is a trademark of William L. Jorgensen. DESMOND is a trademark of D. E. Shaw Research, LLC. Desmond is used with the permission of D. E. Shaw Research. All rights reserved. This publication may contain the trademarks of other companies. Schrödinger software includes software and libraries provided by third parties. For details of the copyrights, and terms and conditions associated with such included third party software, see the Legal Notices, or use your browser to open $SCHRODINGER/docs/html/third_party_legal.html (Linux OS) or %SCHRODINGER%\docs\html\third_party_legal.html (Windows OS). This publication may refer to other third party software not included in or with Schrödinger software ("such other third party software"), and provide links to third party Web sites ("linked sites"). References to such other third party software or linked sites do not constitute an endorsement by Schrödinger, LLC or its affiliates. Use of such other third party software and linked sites may be subject to third party license agreements and fees. Schrödinger, LLC and its affiliates have no responsibility or liability, directly or indirectly, for such other third party software and linked sites, or for damage resulting from the use thereof.
    [Show full text]
  • CORINA Classic Program Manual
    CORINA Classic Generation of Three-Dimensional Molecular Models Version 4.4.0 Program Description Molecular Networks GmbH September 2021 www.mn-am.com Molecular Networks GmbH Altamira LLC Neumeyerstraße 28 470 W Broad St, Unit #5007 90411 Nuremberg Columbus, OH 43215 Germany USA mn-am.com This document is copyright © 1998-2021 by Molecular Networks GmbH Computerchemie and Altamira LLC. All rights reserved. Except as permitted under the terms of the Software Licensing Agreement of Molecular Networks GmbH Computerchemie, no part of this publication may be reproduced or distributed in any form or by any means or stored in a database retrieval system without the prior written permission of Molecular Networks GmbH or Altamira LLC. The software described in this document is furnished under a license and may be used and copied only in accordance with the terms of such license. (Document version: 4.4.0-2021-09-30) Content Content 1 Introducing CORINA Classic 1 1.1 Objective of CORINA Classic 1 1.2 CORINA Classic in Brief 1 2 Release Notes 3 2.1 CORINA (Full Version) 3 2.2 CORINA_F (Restricted FlexX Interface Version) 25 3 Getting Started with CORINA Classic 26 4 Using CORINA Classic 29 4.1 Synopsis 29 4.2 Options 29 5 Use Cases of CORINA Classic 60 6 Supported File Formats and Interfaces 64 6.1 V2000 Structure Data File (SD) and Reaction Data File (RD) 64 6.2 V3000 Structure Data File (SD) and Reaction Data File (RD) 67 6.3 SMILES Linear Notation 67 6.4 InChI file format 69 6.5 SYBYL File Formats 70 6.6 Brookhaven Protein Data Bank Format (PDB)
    [Show full text]