Behavior of Mdynamix on Intel Xeon Phi Coprocessor

Total Page:16

File Type:pdf, Size:1020Kb

Behavior of Mdynamix on Intel Xeon Phi Coprocessor 2013 First International Conference on Artificial Intelligence, Modelling & Simulation Behavior of MDynaMix on Intel Xeon Phi Coprocessor Manjunatha Valmiki Nisha Kurkure Shweta Das HPCS, C-DAC, Pune, India HPCS, C-DAC, Pune, India HPCS, C-DAC, Pune, India email: [email protected] email: [email protected] email: [email protected] Prashant Dinde Deepu CV Goldi Misra HPCS, C-DAC, Pune, India HPCS, C-DAC, Pune, India HPCS, C-DAC, Pune, India email: [email protected] email: [email protected] email: [email protected] Pradeep Sinha HPC and Corporate R&D, C-DAC, Pune, India email: [email protected] Abstract—Over the years, computational science has witnessed exceptional growth, but still lagging in efficient programming A. About MDynaMix Code to effectively undertake research activities. Today, This program is a general purpose molecular dynamics developments in almost all areas of Science & Technology code for simulations of mixtures of either rigid or flexible heavily rely on computational capabilities. The latest TOP500 molecules, interacting by AMBER-like force field in a supercomputing list shows the relevance of computational periodic rectangular cell. Algorithms for NVE simulation & modeling using accelerator technologies. Porting, (Microcanonical ensemble), NVT (Canonical ensemble), optimization, scaling and tuning of existing High Performance NPT (Isothermal–isobaric ensemble) and anisotropic NPT Computing (HPC) Applications on such hybrid architectures is are employed, Ewald sum for treatment of the electrostatic the norm for reaping the benefits of extreme scale computing. interactions, account for quantum effects using path integral This paper gauges the performance of MDynaMix application approach, as well as possibility for free energy computations from Molecular Dynamic domain on Intel Xeon Processor using expanded ensemble method. The program can be along with Intel Xeon Phi coprocessor. Different test cases were carried out to explore the performance of Intel Xeon Phi cards executed in both sequential and parallel. within the node as well as across the nodes. B. Intel Xeon Phi Architecture Keywords-Supercomputing, High Performance Computing, Intel Xeon Phi coprocessors offer high computational Intel Xeon Phi, Molecular Dynamic, Hybrid Architecture, numerical performance. Getting that performance requires Accelerators, Coprocessor, Micro OS, Linux, Open Multi properly-tuned software; it must be highly scalable, highly Processing (OpenMP), Message Passing Interface (MPI). vectorized, utilize the available memory efficiently. Each core in the Intel Xeon Phi coprocessor is designed to be power efficient while providing a high throughput for highly I. INTRODUCTION parallel workloads and is capable of supporting 4 threads in HPC systems are not only becoming complex day-by-day hardware. The 4 hardware threads per physical core help in but also becoming challenging in terms of speedup and masking the effects of latencies on the in-order instruction scalability. Well-organized and flexible numerical algorithms execution. Application scalability is important because are essential to achieve high performance computing on applications typically have 200+ active threads on the Intel complex environments. The size of compute intensive Xeon Phi system. The computational power comes from the problems also increases as the computing technology 512 bit wide registers. The codes on the Intel Xeon Phi advances. One such addition to the ever demanding market coprocessor will needs to utilize these wide SIMD of HPC computing systems to cope with such challenges is instructions to extract desired performance levels. The best Intel's Xeon Phi Coprocessor accelerator. This paper performance will only be achieved when the number of explores the computation power of Intel’s Xeon Phi using a cores, threads and SIMD or vector operations are used molecular dynamics software package ‘MDynaMix’. The effectively. The main memory for Intel Xeon Phi paper also explains the performance of MDynaMix code coprocessor resides on the same physical card with the with different execution modes without affecting the coprocessor, and is completely separate and not synchronized accuracy of the results. with the memory on the host system. Familiar programming models like Open Multi Processing (OpenMP) and Message Passing Interface (MPI) 978-1-4799-3251-1/13 $31.00 © 2013 IEEE 340346 DOI 10.1109/AIMS.2013.71 allows the developer to execute the compute intensive part of II. EXPERIMENT IN DETAIL the code on underlying architecture. MDynaMix is a compute intensive molecular dynamic A skilled application developer can surely take advantage application. To realize the scalability and performance of of the increased processing power of large number of cores code on a hybrid architecture, it is required to understand the available on Xeon Phi by porting existing parallel scalability of the code and performance on the host CPU. applications and codes on the Coprocessor. C. Methods to compile the code for coprocessor The experiment has been carried out by using following different cases. Native compilation: In this mode, application directly Case 1: CPU Compilation: Compiled and executed on executes on coprocessor without being offloaded to Intel Xeon (Sandybridge) multicore processor by varying coprocessor. Such applications are required to be compiled number of process/threads. and built on the host system using -mmic supporting flag Case 2: Native Compilation: Compiled the code on which enables the compiler to generate an object file for CPU with –mmic flag, transferred the executable on card and Xeon Phi coprocessor. Executing applications in native mode executed thereon with varying number of threads (4-60) with requires all the dynamic libraries and executable must be different KMP_AFFINITY. present on the coprocessor. Case 3: Symmetric mode Compilation: Compiled the Symmetric Mode compilation: In this mode, MPI ranks code for both CPU and coprocessor are run on both the Xeon processors and the Xeon Phi In this experiment, the file system used is Network File coprocessor. The most important thing to remember is that System (NFS). here the Xeon Phi coprocessor cards are treated as another After both the executable is made ready, the executables node in a heterogeneous cluster. To that effect, running an has to be run on CPU and Intel Xeon Phi Card MPI job in either the native and symmetric modes is very simultaneously using the below said command. similar to running a job on Xeon processor. mpirun –f mpi_hosts –perhost 1 –n 2 ~/test_hello Offload Mode compilation: In this mode, user can simply add OpenMP-like pragmas to C/C++ or FORTRAN A. Case 1: CPU Compilation code to mark regions of code that should be offloaded to the Compiled and Benchmarked the MDynaMix code on Intel Xeon Phi Coprocessor and execute it. When the Intel Intel Xeon CPU (E5-2670) of frequency 2.60GHz i.e Sandy compiler encounters an offload pragma, it generates code for bridge architecture without HT (HyperTthread enabling). both the coprocessor and the host. The Code for transferring No of Node = 1 the data to the coprocessor is automatically created by the Total core = 16 compiler, however the programmer can influence the data Input file = md.input transfer by adding data clauses to the offload pragma. Number of steps = 500 Ex. icc -offload-build sample.c Following benchmark evaluation in Table 3 and Fig. 1 D. Hardware and software configuration shows the performance of Molecular Dynamic code on multi-core Intel’s Xeon processor (Sandy Bridge). Below is the hardware and software configuration which was used to conduct the experiment: TABLE III. RESULT ON INTEL XEON PROCESSOR TABLE I. HARDWARE CONFIGURATION Sr. No of Process (NP) Time (sec) No. Sr. Cluster Host Node Intel Xeon Phi 1 4 186 No. Parameter Configuration Co-processor 2 8 98 3 12 75 Intel Xeon 2.60 1 CPU 1.2GHz 4 16 87 GHz 2 RAM 24GB 8GB 3 Cores 16 61 Micro OS Red Hat EL6 4 OS 2.6.34.11- Kernel 2.6.32 g4af9302 5 Thread /core 1 4 8 (2 cards per 6 Nodes 4 Nodes node) TABLE II. SOFTWARE CONFIGURATION Sr. Name Description No. 1 Intel® Compiler 13.0.1 2 Intel MPI Library 4.1.0.018 Figure 1. Result on Intel Xeon Processor 3 MDynaMix Version 2.0 341347 The code scale around 80% from 4 to 8 processes, but the power available on the card is used. Linear scalability is percentage of the scalability is reduced to 30% from 8 to 12 observed as the processes increased from 8 to 16. But the processes. From the above observation, the code is scaling up scalability reduced around 35% as the processes increased to 12 processes on the sandy bridge architecture using one from 16 to 60. For 4 threads per core the compute power node with given number of time steps in the input file. available at the card is completely used. The scalability of the code is around 80% from 8 process to 16 process and around B. Case 2: Native Compilation 30% from 16 processes to 60 processes while using 4 threads 1) A: Native compilation for single card within single per core. node with different threads per core Table 4 explains that the MDynaMix application scales In this case we have executed the code by varying the well on 2 threads per core on single Xeon Phi card. number of threads per core in the Xeon phi coprocessor to 2) Native compilation with KMP_AFFINITY explore the optimal threads per core. Environment variable This case explains the runs which were completed by The Intel runtime library has the ability to bind OpenMP changing the threads utilized per core in Xeon Phi threads to physical processing units. The interface is coprocessor for finalizing the optimal configuration for controlled using the KMP_AFFINITY environment variable. MDynaMix application. Thread affinity restricts execution of certain threads (virtual Following run time environment variables were exported execution units) to a subset of the physical processing units before running the executable. in a multiprocessor computer.
Recommended publications
  • 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]
  • 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]
  • 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]
  • Modification of the CHARMM Force Field for DMPC Lipid Bilayer
    Modification of the CHARMM Force Field for DMPC Lipid Bilayer CARL-JOHAN HÖGBERG,1 ALEXEI M. NIKITIN,1,2 ALEXANDER P. LYUBARTSEV1 1Division of Physical Chemistry, Arrhenius Laboratory, Stockholm University, Stockholm, SE-10691, Sweden 2Engelhardt Institute of Molecular Biology, Russian Academy of Sciences, Moscow 119991, Russia Received 23 August 2007; Revised 8 February 2008; Accepted 10 February 2008 DOI 10.1002/jcc.20974 Published online 29 May 2008 in Wiley InterScience (www.interscience.wiley.com). Abstract: The CHARMM force field for DMPC lipids was modified in order to improve agreement with experiment for a number of important properties of hydrated lipid bilayer. The modification consists in introduction of a scaling factor 0.83 for 1–4 electrostatic interactions (between atoms separated by three covalent bonds), which provides correct transgauche ratio in the alkane tails, and recalculation of the headgroup charges on the basis of HF/6-311(d,p) ab-initio computations. Both rigid TIP3P and flexible SPC water models were used with the new lipid model, showing similar results. The new model in a 75 ns simulation has shown a correct value of the area per lipid at zero surface tension, as well as good agreement with the experiment for the electron density, structure factor, and order parameters, including those in the headgroup part of lipids. © 2008 Wiley Periodicals, Inc. J Comput Chem 29: 2359–2369, 2008 Key words: molecular dynamics; lipid bilayers; force field; DMPC; hydration Introduction to be necessary in order to address such
    [Show full text]
  • “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..
    [Show full text]
  • Advances in Computational Fluid Mechanics in Cellular Flow Manipulation: a Review
    applied sciences Review Advances in Computational Fluid Mechanics in Cellular Flow Manipulation: A Review Masoud Arabghahestani 1,* , Sadegh Poozesh 2 and Nelson K. Akafuah 1 1 Institute of Research for Technology Development (IR4TD), University of Kentucky, Lexington, KY 40506, USA; [email protected] 2 Mechanical Engineering Department, Tuskegee University, Tuskegee, AL 36088, USA; [email protected] * Correspondence: [email protected]; Tel.: +1-(859)-898-7700 Received: 28 August 2019; Accepted: 25 September 2019; Published: 27 September 2019 Abstract: Recently, remarkable developments have taken place, leading to significant improvements in microfluidic methods to capture subtle biological effects down to single cells. As microfluidic devices are getting sophisticated, design optimization through experimentations is becoming more challenging. As a result, numerical simulations have contributed to this trend by offering a better understanding of cellular microenvironments hydrodynamics and optimizing the functionality of the current/emerging designs. The need for new marketable designs with advantageous hydrodynamics invokes easier access to efficient as well as time-conservative numerical simulations to provide screening over cellular microenvironments, and to emulate physiological conditions with high accuracy. Therefore, an excerpt overview on how each numerical methodology and associated handling software works, and how they differ in handling underlying hydrodynamic of lab-on-chip microfluidic is crucial. These numerical means rely on molecular and continuum levels of numerical simulations. The current review aims to serve as a guideline for researchers in this area by presenting a comprehensive characterization of various relevant simulation techniques. Keywords: computational fluid mechanics; microfluidic devices; cellular flow; numerical simulations; molecular and continuum levels 1. Introduction 1.1.
    [Show full text]
  • Open Source Molecular Modeling
    Accepted Manuscript Title: Open Source Molecular Modeling Author: Somayeh Pirhadi Jocelyn Sunseri David Ryan Koes PII: S1093-3263(16)30118-8 DOI: http://dx.doi.org/doi:10.1016/j.jmgm.2016.07.008 Reference: JMG 6730 To appear in: Journal of Molecular Graphics and Modelling Received date: 4-5-2016 Accepted date: 25-7-2016 Please cite this article as: Somayeh Pirhadi, Jocelyn Sunseri, David Ryan Koes, Open Source Molecular Modeling, <![CDATA[Journal of Molecular Graphics and Modelling]]> (2016), http://dx.doi.org/10.1016/j.jmgm.2016.07.008 This is a PDF file of an unedited manuscript that has been accepted for publication. As a service to our customers we are providing this early version of the manuscript. The manuscript will undergo copyediting, typesetting, and review of the resulting proof before it is published in its final form. Please note that during the production process errors may be discovered which could affect the content, and all legal disclaimers that apply to the journal pertain. Open Source Molecular Modeling Somayeh Pirhadia, Jocelyn Sunseria, David Ryan Koesa,∗ aDepartment of Computational and Systems Biology, University of Pittsburgh Abstract The success of molecular modeling and computational chemistry efforts are, by definition, de- pendent on quality software applications. Open source software development provides many advantages to users of modeling applications, not the least of which is that the software is free and completely extendable. In this review we categorize, enumerate, and describe available open source software packages for molecular modeling and computational chemistry. 1. Introduction What is Open Source? Free and open source software (FOSS) is software that is both considered \free software," as defined by the Free Software Foundation (http://fsf.org) and \open source," as defined by the Open Source Initiative (http://opensource.org).
    [Show full text]
  • Alexander Lyubartsev(3),* * Department of Materials And
    Molecular Dynamics Simulations of Polybrominated Diphenyl Ethers in Biological Environments Inna Ermilova(1),* , Samuel Stenberg(2),* , Alexander Lyubartsev(3),* * Department of Materials and Environmental Chemistry, Stockholm University, Sweden (1) [email protected] ; (2) [email protected] ; (3) [email protected] Polybrominated diphenyl ethers (PBDEs) and hydroxylated polybrominated diphenyl ethers (OH-PBDEs) belong to a class of chemical substances which cause environmental and health concerns because of their toxicity. In this work we have been using molecular dynamics simulations with metadynamics (MetaD) and expanded ensemble (EE) approaches. EE calculations have been carried out in for 19 molecules in order to relate toxic mechanisms to partition coefficients between water and octanol systems while metadynamics simulations were supposed to give us answers on how binding free energies are related to toxic mechanisms for 4 chosen molecules. What is a toxicity and how is it studied EE simulations set-ups and MetaD simulations set-ups experimentally? Toxicity is a relative degree of being poisonous of a certain chemical and models compound. A toxicity doesn't have to be referred to deadly effects, it is EE simulations: 20 simulations in octanol (SLipids force field model)+ 20 simulations enough to damage a living organism. Experimentally such effects aren't in water (TIP3p model). Simulations were done at T=298K and p=1 bar for 50 ns. The studied on humans but some animals or other organisms are used in order number of subensembles was 26 for solutes in water and 41 for solutes in octanol. to predict how a specie can affect people.
    [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]
  • Extension of the Slipids Force Field to Polyunsaturated Lipids Inna Ermilova and Alexander P
    Article pubs.acs.org/JPCB Extension of the Slipids Force Field to Polyunsaturated Lipids Inna Ermilova and Alexander P. Lyubartsev* Department of Materials and Environmental Chemistry, Stockholm University, SE 106 91 Stockholm, Sweden *S Supporting Information ABSTRACT: The all-atomic force field Slipids (Stockholm Lipids) for lipid bilayers simulations has been extended to polyunsaturated lipids. Following the strategy adopted in the development of previous versions of the Slipids force field, the parametrization was essentially based on high-level ab initio calculations. Atomic charges and torsion angles related to polyunsaturated lipid tails were parametrized using structures of dienes molecules. The new parameters of the force field were validated in simulations of bilayers composed of seven polyunsaturated lipids. An overall good agreement was found with available experimental data on the areas per lipids, volumetric properties of bilayers, deuterium order parameters, and scattering form factors. Furthermore, simulations of bilayers consisting of highly polyunsaturated lipids and cholesterol molecules have been carried out. The majority of cholesterol molecules were found in a position parallel to bilayer normal with the hydroxyl group directed to the membrane surface, while a small fraction of cholesterol was found in the bilayer center parallel to the membrane plane. Furthermore, a tendency of cholesterol molecules to form chain-like clusters in polyunsaturated bilayers was qualitatively observed. ■ INTRODUCTION docosahexaenoic acid is not only affecting physical-chemical properties of membranes (such as thickness, lipid packing, Lipids are important components of biological systems, such as fl biomembranes.1,2 A lipid bilayer forming a membrane helps to uidity, elasticity, permeability, etc.), but it is activating the control the transport of different molecules into or out of a important signaling protein kinase C (PKC) as well.
    [Show full text]
  • Kanad Hpc Application Reference Manual
    KANAD HPC APPLICATION REFERENCE MANUAL Page 1 of 28 TABLE OF CONTENTS 1. INTRODUCTION ............................................................................................................................................ 4 2. COMPLIERS & LIBRARIES ............................................................................................................................... 4 2.1. INTEL MKL ............................................................................................................................................... 4 2.2. FFTW ....................................................................................................................................................... 4 2.3. OPENMPI ................................................................................................................................................ 5 2.4. INTEL® MPI LIBRARY ................................................................................................................................ 6 2.5. GCC ......................................................................................................................................................... 6 2.6. INTEL 13.0.1 ............................................................................................................................................. 7 2.7. ATLAS (AUTOMATICALLY TUNED LINEAR ALGEBRA SOFTWARE) ................................................................. 7 2.8. BLAS .......................................................................................................................................................
    [Show full text]