Sample records for molecular dynamics code

  1. ls1 mardyn: The Massively Parallel Molecular Dynamics Code for Large Systems.

    PubMed

    Niethammer, Christoph; Becker, Stefan; Bernreuther, Martin; Buchholz, Martin; Eckhardt, Wolfgang; Heinecke, Alexander; Werth, Stephan; Bungartz, Hans-Joachim; Glass, Colin W; Hasse, Hans; Vrabec, Jadran; Horsch, Martin

    2014-10-14

    The molecular dynamics simulation code ls1 mardyn is presented. It is a highly scalable code, optimized for massively parallel execution on supercomputing architectures and currently holds the world record for the largest molecular simulation with over four trillion particles. It enables the application of pair potentials to length and time scales that were previously out of scope for molecular dynamics simulation. With an efficient dynamic load balancing scheme, it delivers high scalability even for challenging heterogeneous configurations. Presently, multicenter rigid potential models based on Lennard-Jones sites, point charges, and higher-order polarities are supported. Due to its modular design, ls1 mardyn can be extended to new physical models, methods, and algorithms, allowing future users to tailor it to suit their respective needs. Possible applications include scenarios with complex geometries, such as fluids at interfaces, as well as nonequilibrium molecular dynamics simulation of heat and mass transfer.

  2. Las Palmeras Molecular Dynamics: A flexible and modular molecular dynamics code

    NASA Astrophysics Data System (ADS)

    Davis, Sergio; Loyola, Claudia; González, Felipe; Peralta, Joaquín

    2010-12-01

    Las Palmeras Molecular Dynamics (LPMD) is a highly modular and extensible molecular dynamics (MD) code using interatomic potential functions. LPMD is able to perform equilibrium MD simulations of bulk crystalline solids, amorphous solids and liquids, as well as non-equilibrium MD (NEMD) simulations such as shock wave propagation, projectile impacts, cluster collisions, shearing, deformation under load, heat conduction, heterogeneous melting, among others, which involve unusual MD features like non-moving atoms and walls, unstoppable atoms with constant-velocity, and external forces like electric fields. LPMD is written in C++ as a compromise between efficiency and clarity of design, and its architecture is based on separate components or plug-ins, implemented as modules which are loaded on demand at runtime. The advantage of this architecture is the ability to completely link together the desired components involved in the simulation in different ways at runtime, using a user-friendly control file language which describes the simulation work-flow. As an added bonus, the plug-in API (Application Programming Interface) makes it possible to use the LPMD components to analyze data coming from other simulation packages, convert between input file formats, apply different transformations to saved MD atomic trajectories, and visualize dynamical processes either in real-time or as a post-processing step. Individual components, such as a new potential function, a new integrator, a new file format, new properties to calculate, new real-time visualizers, and even a new algorithm for handling neighbor lists can be easily coded, compiled and tested within LPMD by virtue of its object-oriented API, without the need to modify the rest of the code. LPMD includes already several pair potential functions such as Lennard-Jones, Morse, Buckingham, MCY and the harmonic potential, as well as embedded-atom model (EAM) functions such as the Sutton-Chen and Gupta potentials. Integrators to

  3. Sensitivity Analysis and Uncertainty Quantification for the LAMMPS Molecular Dynamics Simulation Code

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Picard, Richard Roy; Bhat, Kabekode Ghanasham

    2017-07-18

    We examine sensitivity analysis and uncertainty quantification for molecular dynamics simulation. Extreme (large or small) output values for the LAMMPS code often occur at the boundaries of input regions, and uncertainties in those boundary values are overlooked by common SA methods. Similarly, input values for which code outputs are consistent with calibration data can also occur near boundaries. Upon applying approaches in the literature for imprecise probabilities (IPs), much more realistic results are obtained than for the complacent application of standard SA and code calibration.

  4. Chemical reactivity and spectroscopy explored from QM/MM molecular dynamics simulations using the LIO code

    NASA Astrophysics Data System (ADS)

    Marcolongo, Juan P.; Zeida, Ari; Semelak, Jonathan A.; Foglia, Nicolás O.; Morzan, Uriel N.; Estrin, Dario A.; González Lebrero, Mariano C.; Scherlis, Damián A.

    2018-03-01

    In this work we present the current advances in the development and the applications of LIO, a lab-made code designed for density functional theory calculations in graphical processing units (GPU), that can be coupled with different classical molecular dynamics engines. This code has been thoroughly optimized to perform efficient molecular dynamics simulations at the QM/MM DFT level, allowing for an exhaustive sampling of the configurational space. Selected examples are presented for the description of chemical reactivity in terms of free energy profiles, and also for the computation of optical properties, such as vibrational and electronic spectra in solvent and protein environments.

  5. Coding considerations for standalone molecular dynamics simulations of atomistic structures

    NASA Astrophysics Data System (ADS)

    Ocaya, R. O.; Terblans, J. J.

    2017-10-01

    The laws of Newtonian mechanics allow ab-initio molecular dynamics to model and simulate particle trajectories in material science by defining a differentiable potential function. This paper discusses some considerations for the coding of ab-initio programs for simulation on a standalone computer and illustrates the approach by C language codes in the context of embedded metallic atoms in the face-centred cubic structure. The algorithms use velocity-time integration to determine particle parameter evolution for up to several thousands of particles in a thermodynamical ensemble. Such functions are reusable and can be placed in a redistributable header library file. While there are both commercial and free packages available, their heuristic nature prevents dissection. In addition, developing own codes has the obvious advantage of teaching techniques applicable to new problems.

  6. Substructured multibody molecular dynamics.

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Grest, Gary Stephen; Stevens, Mark Jackson; Plimpton, Steven James

    2006-11-01

    We have enhanced our parallel molecular dynamics (MD) simulation software LAMMPS (Large-scale Atomic/Molecular Massively Parallel Simulator, lammps.sandia.gov) to include many new features for accelerated simulation including articulated rigid body dynamics via coupling to the Rensselaer Polytechnic Institute code POEMS (Parallelizable Open-source Efficient Multibody Software). We use new features of the LAMMPS software package to investigate rhodopsin photoisomerization, and water model surface tension and capillary waves at the vapor-liquid interface. Finally, we motivate the recipes of MD for practitioners and researchers in numerical analysis and computational mechanics.

  7. Optimizing legacy molecular dynamics software with directive-based offload

    NASA Astrophysics Data System (ADS)

    Michael Brown, W.; Carrillo, Jan-Michael Y.; Gavhane, Nitin; Thakkar, Foram M.; Plimpton, Steven J.

    2015-10-01

    Directive-based programming models are one solution for exploiting many-core coprocessors to increase simulation rates in molecular dynamics. They offer the potential to reduce code complexity with offload models that can selectively target computations to run on the CPU, the coprocessor, or both. In this paper, we describe modifications to the LAMMPS molecular dynamics code to enable concurrent calculations on a CPU and coprocessor. We demonstrate that standard molecular dynamics algorithms can run efficiently on both the CPU and an x86-based coprocessor using the same subroutines. As a consequence, we demonstrate that code optimizations for the coprocessor also result in speedups on the CPU; in extreme cases up to 4.7X. We provide results for LAMMPS benchmarks and for production molecular dynamics simulations using the Stampede hybrid supercomputer with both Intel® Xeon Phi™ coprocessors and NVIDIA GPUs. The optimizations presented have increased simulation rates by over 2X for organic molecules and over 7X for liquid crystals on Stampede. The optimizations are available as part of the "Intel package" supplied with LAMMPS.

  8. Optimizing legacy molecular dynamics software with directive-based offload

    DOE PAGES

    Michael Brown, W.; Carrillo, Jan-Michael Y.; Gavhane, Nitin; ...

    2015-05-14

    The directive-based programming models are one solution for exploiting many-core coprocessors to increase simulation rates in molecular dynamics. They offer the potential to reduce code complexity with offload models that can selectively target computations to run on the CPU, the coprocessor, or both. In our paper, we describe modifications to the LAMMPS molecular dynamics code to enable concurrent calculations on a CPU and coprocessor. We also demonstrate that standard molecular dynamics algorithms can run efficiently on both the CPU and an x86-based coprocessor using the same subroutines. As a consequence, we demonstrate that code optimizations for the coprocessor also resultmore » in speedups on the CPU; in extreme cases up to 4.7X. We provide results for LAMMAS benchmarks and for production molecular dynamics simulations using the Stampede hybrid supercomputer with both Intel (R) Xeon Phi (TM) coprocessors and NVIDIA GPUs: The optimizations presented have increased simulation rates by over 2X for organic molecules and over 7X for liquid crystals on Stampede. The optimizations are available as part of the "Intel package" supplied with LAMMPS. (C) 2015 Elsevier B.V. All rights reserved.« less

  9. COOL: A code for Dynamic Monte Carlo Simulation of molecular dynamics

    NASA Astrophysics Data System (ADS)

    Barletta, Paolo

    2012-02-01

    Cool is a program to simulate evaporative and sympathetic cooling for a mixture of two gases co-trapped in an harmonic potential. The collisions involved are assumed to be exclusively elastic, and losses are due to evaporation from the trap. Each particle is followed individually in its trajectory, consequently properties such as spatial densities or energy distributions can be readily evaluated. The code can be used sequentially, by employing one output as input for another run. The code can be easily generalised to describe more complicated processes, such as the inclusion of inelastic collisions, or the possible presence of more than two species in the trap. New version program summaryProgram title: COOL Catalogue identifier: AEHJ_v2_0 Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEHJ_v2_0.html Program obtainable from: CPC Program Library, Queen's University, Belfast, N. Ireland Licensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.html No. of lines in distributed program, including test data, etc.: 1 097 733 No. of bytes in distributed program, including test data, etc.: 18 425 722 Distribution format: tar.gz Programming language: C++ Computer: Desktop Operating system: Linux RAM: 500 Mbytes Classification: 16.7, 23 Catalogue identifier of previous version: AEHJ_v1_0 Journal reference of previous version: Comput. Phys. Comm. 182 (2011) 388 Does the new version supersede the previous version?: Yes Nature of problem: Simulation of the sympathetic process occurring for two molecular gases co-trapped in a deep optical trap. Solution method: The Direct Simulation Monte Carlo method exploits the decoupling, over a short time period, of the inter-particle interaction from the trapping potential. The particle dynamics is thus exclusively driven by the external optical field. The rare inter-particle collisions are considered with an acceptance/rejection mechanism, that is, by comparing a random number to the collisional probability

  10. Molecular Dynamics Analysis of Lysozyme Protein in Ethanol- Water Mixed Solvent

    DTIC Science & Technology

    2012-01-01

    molecular dynamics simulations of solvent effect on lysozyme protein, using water, ethanol, and different concentrations of water-ethanol mixtures as...understood. This work focuses on detailed molecular dynamics simulations of solvent effect on lysozyme protein, using water, ethanol, and different...using GROMACS molecular dynamics simulation (MD) code. Compared to water environment, the lysozyme structure showed remarkable changes in water

  11. Multigrid based First-Principles Molecular Dynamics

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Fattebert, Jean-Luc; Osei-Kuffuor, Daniel; Dunn, Ian

    2017-06-01

    MGmol ls a First-Principles Molecular Dynamics code. It relies on the Born-Oppenheimer approximation and models the electronic structure using Density Functional Theory, either LDA or PBE. Norm-conserving pseudopotentials are used to model atomic cores.

  12. Interactive molecular dynamics

    NASA Astrophysics Data System (ADS)

    Schroeder, Daniel V.

    2015-03-01

    Physics students now have access to interactive molecular dynamics simulations that can model and animate the motions of hundreds of particles, such as noble gas atoms, that attract each other weakly at short distances but repel strongly when pressed together. Using these simulations, students can develop an understanding of forces and motions at the molecular scale, nonideal fluids, phases of matter, thermal equilibrium, nonequilibrium states, the Boltzmann distribution, the arrow of time, and much more. This article summarizes the basic features and capabilities of such a simulation, presents a variety of student exercises using it at the introductory and intermediate levels, and describes some enhancements that can further extend its uses. A working simulation code, in html5 and javascript for running within any modern Web browser, is provided as an online supplement.

  13. DNA: Polymer and molecular code

    NASA Astrophysics Data System (ADS)

    Shivashankar, G. V.

    1999-10-01

    The thesis work focusses upon two aspects of DNA, the polymer and the molecular code. Our approach was to bring single molecule micromanipulation methods to the study of DNA. It included a home built optical microscope combined with an atomic force microscope and an optical tweezer. This combined approach led to a novel method to graft a single DNA molecule onto a force cantilever using the optical tweezer and local heating. With this method, a force versus extension assay of double stranded DNA was realized. The resolution was about 10 picoN. To improve on this force measurement resolution, a simple light backscattering technique was developed and used to probe the DNA polymer flexibility and its fluctuations. It combined the optical tweezer to trap a DNA tethered bead and the laser backscattering to detect the beads Brownian fluctuations. With this technique the resolution was about 0.1 picoN with a millisecond access time, and the whole entropic part of the DNA force-extension was measured. With this experimental strategy, we measured the polymerization of the protein RecA on an isolated double stranded DNA. We observed the progressive decoration of RecA on the l DNA molecule, which results in the extension of l , due to unwinding of the double helix. The dynamics of polymerization, the resulting change in the DNA entropic elasticity and the role of ATP hydrolysis were the main parts of the study. A simple model for RecA assembly on DNA was proposed. This work presents a first step in the study of genetic recombination. Recently we have started a study of equilibrium binding which utilizes fluorescence polarization methods to probe the polymerization of RecA on single stranded DNA. In addition to the study of material properties of DNA and DNA-RecA, we have developed experiments for which the code of the DNA is central. We studied one aspect of DNA as a molecular code, using different techniques. In particular the programmatic use of template specificity makes

  14. Scalable Molecular Dynamics with NAMD

    PubMed Central

    Phillips, James C.; Braun, Rosemary; Wang, Wei; Gumbart, James; Tajkhorshid, Emad; Villa, Elizabeth; Chipot, Christophe; Skeel, Robert D.; Kalé, Laxmikant; Schulten, Klaus

    2008-01-01

    NAMD is a parallel molecular dynamics code designed for high-performance simulation of large biomolecular systems. NAMD scales to hundreds of processors on high-end parallel platforms, as well as tens of processors on low-cost commodity clusters, and also runs on individual desktop and laptop computers. NAMD works with AMBER and CHARMM potential functions, parameters, and file formats. This paper, directed to novices as well as experts, first introduces concepts and methods used in the NAMD program, describing the classical molecular dynamics force field, equations of motion, and integration methods along with the efficient electrostatics evaluation algorithms employed and temperature and pressure controls used. Features for steering the simulation across barriers and for calculating both alchemical and conformational free energy differences are presented. The motivations for and a roadmap to the internal design of NAMD, implemented in C++ and based on Charm++ parallel objects, are outlined. The factors affecting the serial and parallel performance of a simulation are discussed. Next, typical NAMD use is illustrated with representative applications to a small, a medium, and a large biomolecular system, highlighting particular features of NAMD, e.g., the Tcl scripting language. Finally, the paper provides a list of the key features of NAMD and discusses the benefits of combining NAMD with the molecular graphics/sequence analysis software VMD and the grid computing/collaboratory software BioCoRE. NAMD is distributed free of charge with source code at www.ks.uiuc.edu. PMID:16222654

  15. The MOLDY short-range molecular dynamics package

    NASA Astrophysics Data System (ADS)

    Ackland, G. J.; D'Mellow, K.; Daraszewicz, S. L.; Hepburn, D. J.; Uhrin, M.; Stratford, K.

    2011-12-01

    We describe a parallelised version of the MOLDY molecular dynamics program. This Fortran code is aimed at systems which may be described by short-range potentials and specifically those which may be addressed with the embedded atom method. This includes a wide range of transition metals and alloys. MOLDY provides a range of options in terms of the molecular dynamics ensemble used and the boundary conditions which may be applied. A number of standard potentials are provided, and the modular structure of the code allows new potentials to be added easily. The code is parallelised using OpenMP and can therefore be run on shared memory systems, including modern multicore processors. Particular attention is paid to the updates required in the main force loop, where synchronisation is often required in OpenMP implementations of molecular dynamics. We examine the performance of the parallel code in detail and give some examples of applications to realistic problems, including the dynamic compression of copper and carbon migration in an iron-carbon alloy. Program summaryProgram title: MOLDY Catalogue identifier: AEJU_v1_0 Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEJU_v1_0.html Program obtainable from: CPC Program Library, Queen's University, Belfast, N. Ireland Licensing provisions: GNU General Public License version 2 No. of lines in distributed program, including test data, etc.: 382 881 No. of bytes in distributed program, including test data, etc.: 6 705 242 Distribution format: tar.gz Programming language: Fortran 95/OpenMP Computer: Any Operating system: Any Has the code been vectorised or parallelized?: Yes. OpenMP is required for parallel execution RAM: 100 MB or more Classification: 7.7 Nature of problem: Moldy addresses the problem of many atoms (of order 10 6) interacting via a classical interatomic potential on a timescale of microseconds. It is designed for problems where statistics must be gathered over a number of equivalent runs, such as

  16. The Distributed Diagonal Force Decomposition Method for Parallelizing Molecular Dynamics Simulations

    PubMed Central

    Boršnik, Urban; Miller, Benjamin T.; Brooks, Bernard R.; Janežič, Dušanka

    2011-01-01

    Parallelization is an effective way to reduce the computational time needed for molecular dynamics simulations. We describe a new parallelization method, the distributed-diagonal force decomposition method, with which we extend and improve the existing force decomposition methods. Our new method requires less data communication during molecular dynamics simulations than replicated data and current force decomposition methods, increasing the parallel efficiency. It also dynamically load-balances the processors' computational load throughout the simulation. The method is readily implemented in existing molecular dynamics codes and it has been incorporated into the CHARMM program, allowing its immediate use in conjunction with the many molecular dynamics simulation techniques that are already present in the program. We also present the design of the Force Decomposition Machine, a cluster of personal computers and networks that is tailored to running molecular dynamics simulations using the distributed diagonal force decomposition method. The design is expandable and provides various degrees of fault resilience. This approach is easily adaptable to computers with Graphics Processing Units because it is independent of the processor type being used. PMID:21793007

  17. Avoiding Defect Nucleation during Equilibration in Molecular Dynamics Simulations with ReaxFF

    DTIC Science & Technology

    2015-04-01

    respectively. All simulations are performed using the LAMMPS computer code.12 2 Fig. 1 a) Initial and b) final configurations of the molecular centers...Plimpton S. Fast parallel algorithms for short-range molecular dynamics. Comput J Phys. 1995;117:1–19. (Software available at http:// lammps .sandia.gov

  18. A domain specific language for performance portable molecular dynamics algorithms

    NASA Astrophysics Data System (ADS)

    Saunders, William Robert; Grant, James; Müller, Eike Hermann

    2018-03-01

    Developers of Molecular Dynamics (MD) codes face significant challenges when adapting existing simulation packages to new hardware. In a continuously diversifying hardware landscape it becomes increasingly difficult for scientists to be experts both in their own domain (physics/chemistry/biology) and specialists in the low level parallelisation and optimisation of their codes. To address this challenge, we describe a "Separation of Concerns" approach for the development of parallel and optimised MD codes: the science specialist writes code at a high abstraction level in a domain specific language (DSL), which is then translated into efficient computer code by a scientific programmer. In a related context, an abstraction for the solution of partial differential equations with grid based methods has recently been implemented in the (Py)OP2 library. Inspired by this approach, we develop a Python code generation system for molecular dynamics simulations on different parallel architectures, including massively parallel distributed memory systems and GPUs. We demonstrate the efficiency of the auto-generated code by studying its performance and scalability on different hardware and compare it to other state-of-the-art simulation packages. With growing data volumes the extraction of physically meaningful information from the simulation becomes increasingly challenging and requires equally efficient implementations. A particular advantage of our approach is the easy expression of such analysis algorithms. We consider two popular methods for deducing the crystalline structure of a material from the local environment of each atom, show how they can be expressed in our abstraction and implement them in the code generation framework.

  19. Computationally Efficient Multiconfigurational Reactive Molecular Dynamics

    PubMed Central

    Yamashita, Takefumi; Peng, Yuxing; Knight, Chris; Voth, Gregory A.

    2012-01-01

    It is a computationally demanding task to explicitly simulate the electronic degrees of freedom in a system to observe the chemical transformations of interest, while at the same time sampling the time and length scales required to converge statistical properties and thus reduce artifacts due to initial conditions, finite-size effects, and limited sampling. One solution that significantly reduces the computational expense consists of molecular models in which effective interactions between particles govern the dynamics of the system. If the interaction potentials in these models are developed to reproduce calculated properties from electronic structure calculations and/or ab initio molecular dynamics simulations, then one can calculate accurate properties at a fraction of the computational cost. Multiconfigurational algorithms model the system as a linear combination of several chemical bonding topologies to simulate chemical reactions, also sometimes referred to as “multistate”. These algorithms typically utilize energy and force calculations already found in popular molecular dynamics software packages, thus facilitating their implementation without significant changes to the structure of the code. However, the evaluation of energies and forces for several bonding topologies per simulation step can lead to poor computational efficiency if redundancy is not efficiently removed, particularly with respect to the calculation of long-ranged Coulombic interactions. This paper presents accurate approximations (effective long-range interaction and resulting hybrid methods) and multiple-program parallelization strategies for the efficient calculation of electrostatic interactions in reactive molecular simulations. PMID:25100924

  20. Molecular dynamics and dynamic Monte-Carlo simulation of irradiation damage with focused ion beams

    NASA Astrophysics Data System (ADS)

    Ohya, Kaoru

    2017-03-01

    The focused ion beam (FIB) has become an important tool for micro- and nanostructuring of samples such as milling, deposition and imaging. However, this leads to damage of the surface on the nanometer scale from implanted projectile ions and recoiled material atoms. It is therefore important to investigate each kind of damage quantitatively. We present a dynamic Monte-Carlo (MC) simulation code to simulate the morphological and compositional changes of a multilayered sample under ion irradiation and a molecular dynamics (MD) simulation code to simulate dose-dependent changes in the backscattering-ion (BSI)/secondary-electron (SE) yields of a crystalline sample. Recent progress in the codes for research to simulate the surface morphology and Mo/Si layers intermixing in an EUV lithography mask irradiated with FIBs, and the crystalline orientation effect on BSI and SE yields relating to the channeling contrast in scanning ion microscopes, is also presented.

  1. High dynamic range coding imaging system

    NASA Astrophysics Data System (ADS)

    Wu, Renfan; Huang, Yifan; Hou, Guangqi

    2014-10-01

    We present a high dynamic range (HDR) imaging system design scheme based on coded aperture technique. This scheme can help us obtain HDR images which have extended depth of field. We adopt Sparse coding algorithm to design coded patterns. Then we utilize the sensor unit to acquire coded images under different exposure settings. With the guide of the multiple exposure parameters, a series of low dynamic range (LDR) coded images are reconstructed. We use some existing algorithms to fuse and display a HDR image by those LDR images. We build an optical simulation model and get some simulation images to verify the novel system.

  2. Molecular Dynamics implementation of BN2D or 'Mercedes Benz' water model

    NASA Astrophysics Data System (ADS)

    Scukins, Arturs; Bardik, Vitaliy; Pavlov, Evgen; Nerukh, Dmitry

    2015-05-01

    Two-dimensional 'Mercedes Benz' (MB) or BN2D water model (Naim, 1971) is implemented in Molecular Dynamics. It is known that the MB model can capture abnormal properties of real water (high heat capacity, minima of pressure and isothermal compressibility, negative thermal expansion coefficient) (Silverstein et al., 1998). In this work formulas for calculating the thermodynamic, structural and dynamic properties in microcanonical (NVE) and isothermal-isobaric (NPT) ensembles for the model from Molecular Dynamics simulation are derived and verified against known Monte Carlo results. The convergence of the thermodynamic properties and the system's numerical stability are investigated. The results qualitatively reproduce the peculiarities of real water making the model a visually convenient tool that also requires less computational resources, thus allowing simulations of large (hydrodynamic scale) molecular systems. We provide the open source code written in C/C++ for the BN2D water model implementation using Molecular Dynamics.

  3. Beyond Molecular Codes: Simple Rules to Wire Complex Brains

    PubMed Central

    Hassan, Bassem A.; Hiesinger, P. Robin

    2015-01-01

    Summary Molecular codes, like postal zip codes, are generally considered a robust way to ensure the specificity of neuronal target selection. However, a code capable of unambiguously generating complex neural circuits is difficult to conceive. Here, we re-examine the notion of molecular codes in the light of developmental algorithms. We explore how molecules and mechanisms that have been considered part of a code may alternatively implement simple pattern formation rules sufficient to ensure wiring specificity in neural circuits. This analysis delineates a pattern-based framework for circuit construction that may contribute to our understanding of brain wiring. PMID:26451480

  4. A LAMMPS implementation of volume-temperature replica exchange molecular dynamics

    NASA Astrophysics Data System (ADS)

    Liu, Liang-Chun; Kuo, Jer-Lai

    2015-04-01

    A driver module for executing volume-temperature replica exchange molecular dynamics (VTREMD) was developed for the LAMMPS package. As a patch code, the VTREMD module performs classical molecular dynamics (MD) with Monte Carlo (MC) decisions between MD runs. The goal of inserting the MC step was to increase the breadth of sampled configurational space. In this method, states receive better sampling by making temperature or density swaps with their neighboring states. As an accelerated sampling method, VTREMD is particularly useful to explore states at low temperatures, where systems are easily trapped in local potential wells. As functional examples, TIP4P/Ew and TIP4P/2005 water models were analyzed using VTREMD. The phase diagram in this study covered the deeply supercooled regime, and this test served as a suitable demonstration of the usefulness of VTREMD in overcoming the slow dynamics problem. To facilitate using the current code, attention was also paid on how to optimize the exchange efficiency by using grid allocation. VTREMD was useful for studying systems with rough energy landscapes, such as those with numerous local minima or multiple characteristic time scales.

  5. Beam-dynamics codes used at DARHT

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Ekdahl, Jr., Carl August

    Several beam simulation codes are used to help gain a better understanding of beam dynamics in the DARHT LIAs. The most notable of these fall into the following categories: for beam production – Tricomp Trak orbit tracking code, LSP Particle in cell (PIC) code, for beam transport and acceleration – XTR static envelope and centroid code, LAMDA time-resolved envelope and centroid code, LSP-Slice PIC code, for coasting-beam transport to target – LAMDA time-resolved envelope code, LSP-Slice PIC code. These codes are also being used to inform the design of Scorpius.

  6. Strong scaling of general-purpose molecular dynamics simulations on GPUs

    NASA Astrophysics Data System (ADS)

    Glaser, Jens; Nguyen, Trung Dac; Anderson, Joshua A.; Lui, Pak; Spiga, Filippo; Millan, Jaime A.; Morse, David C.; Glotzer, Sharon C.

    2015-07-01

    We describe a highly optimized implementation of MPI domain decomposition in a GPU-enabled, general-purpose molecular dynamics code, HOOMD-blue (Anderson and Glotzer, 2013). Our approach is inspired by a traditional CPU-based code, LAMMPS (Plimpton, 1995), but is implemented within a code that was designed for execution on GPUs from the start (Anderson et al., 2008). The software supports short-ranged pair force and bond force fields and achieves optimal GPU performance using an autotuning algorithm. We are able to demonstrate equivalent or superior scaling on up to 3375 GPUs in Lennard-Jones and dissipative particle dynamics (DPD) simulations of up to 108 million particles. GPUDirect RDMA capabilities in recent GPU generations provide better performance in full double precision calculations. For a representative polymer physics application, HOOMD-blue 1.0 provides an effective GPU vs. CPU node speed-up of 12.5 ×.

  7. Dynamic code block size for JPEG 2000

    NASA Astrophysics Data System (ADS)

    Tsai, Ping-Sing; LeCornec, Yann

    2008-02-01

    Since the standardization of the JPEG 2000, it has found its way into many different applications such as DICOM (digital imaging and communication in medicine), satellite photography, military surveillance, digital cinema initiative, professional video cameras, and so on. The unified framework of the JPEG 2000 architecture makes practical high quality real-time compression possible even in video mode, i.e. motion JPEG 2000. In this paper, we present a study of the compression impact using dynamic code block size instead of fixed code block size as specified in the JPEG 2000 standard. The simulation results show that there is no significant impact on compression if dynamic code block sizes are used. In this study, we also unveil the advantages of using dynamic code block sizes.

  8. i-PI: A Python interface for ab initio path integral molecular dynamics simulations

    NASA Astrophysics Data System (ADS)

    Ceriotti, Michele; More, Joshua; Manolopoulos, David E.

    2014-03-01

    Recent developments in path integral methodology have significantly reduced the computational expense of including quantum mechanical effects in the nuclear motion in ab initio molecular dynamics simulations. However, the implementation of these developments requires a considerable programming effort, which has hindered their adoption. Here we describe i-PI, an interface written in Python that has been designed to minimise the effort required to bring state-of-the-art path integral techniques to an electronic structure program. While it is best suited to first principles calculations and path integral molecular dynamics, i-PI can also be used to perform classical molecular dynamics simulations, and can just as easily be interfaced with an empirical forcefield code. To give just one example of the many potential applications of the interface, we use it in conjunction with the CP2K electronic structure package to showcase the importance of nuclear quantum effects in high-pressure water. Catalogue identifier: AERN_v1_0 Program summary URL: http://cpc.cs.qub.ac.uk/summaries/AERN_v1_0.html Program obtainable from: CPC Program Library, Queen’s University, Belfast, N. Ireland Licensing provisions: GNU General Public License, version 3 No. of lines in distributed program, including test data, etc.: 138626 No. of bytes in distributed program, including test data, etc.: 3128618 Distribution format: tar.gz Programming language: Python. Computer: Multiple architectures. Operating system: Linux, Mac OSX, Windows. RAM: Less than 256 Mb Classification: 7.7. External routines: NumPy Nature of problem: Bringing the latest developments in the modelling of nuclear quantum effects with path integral molecular dynamics to ab initio electronic structure programs with minimal implementational effort. Solution method: State-of-the-art path integral molecular dynamics techniques are implemented in a Python interface. Any electronic structure code can be patched to receive the atomic

  9. MDANSE: An Interactive Analysis Environment for Molecular Dynamics Simulations.

    PubMed

    Goret, G; Aoun, B; Pellegrini, E

    2017-01-23

    The MDANSE software-Molecular Dynamics Analysis of Neutron Scattering Experiments-is presented. It is an interactive application for postprocessing molecular dynamics (MD) simulations. Given the widespread use of MD simulations in material and biomolecular sciences to get a better insight for experimental techniques such as thermal neutron scattering (TNS), the development of MDANSE has focused on providing a user-friendly, interactive, graphical user interface for analyzing many trajectories in the same session and running several analyses simultaneously independently of the interface. This first version of MDANSE already proposes a broad range of analyses, and the application has been designed to facilitate the introduction of new analyses in the framework. All this makes MDANSE a valuable tool for extracting useful information from trajectories resulting from a wide range of MD codes.

  10. A concurrent multiscale micromorphic molecular dynamics

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Li, Shaofan, E-mail: shaofan@berkeley.edu; Tong, Qi

    2015-04-21

    In this work, we have derived a multiscale micromorphic molecular dynamics (MMMD) from first principle to extend the (Andersen)-Parrinello-Rahman molecular dynamics to mesoscale and continuum scale. The multiscale micromorphic molecular dynamics is a con-current three-scale dynamics that couples a fine scale molecular dynamics, a mesoscale micromorphic dynamics, and a macroscale nonlocal particle dynamics together. By choosing proper statistical closure conditions, we have shown that the original Andersen-Parrinello-Rahman molecular dynamics is the homogeneous and equilibrium case of the proposed multiscale micromorphic molecular dynamics. In specific, we have shown that the Andersen-Parrinello-Rahman molecular dynamics can be rigorously formulated and justified from firstmore » principle, and its general inhomogeneous case, i.e., the three scale con-current multiscale micromorphic molecular dynamics can take into account of macroscale continuum mechanics boundary condition without the limitation of atomistic boundary condition or periodic boundary conditions. The discovered multiscale scale structure and the corresponding multiscale dynamics reveal a seamless transition from atomistic scale to continuum scale and the intrinsic coupling mechanism among them based on first principle formulation.« less

  11. Employing multi-GPU power for molecular dynamics simulation: an extension of GALAMOST

    NASA Astrophysics Data System (ADS)

    Zhu, You-Liang; Pan, Deng; Li, Zhan-Wei; Liu, Hong; Qian, Hu-Jun; Zhao, Yang; Lu, Zhong-Yuan; Sun, Zhao-Yan

    2018-04-01

    We describe the algorithm of employing multi-GPU power on the basis of Message Passing Interface (MPI) domain decomposition in a molecular dynamics code, GALAMOST, which is designed for the coarse-grained simulation of soft matters. The code of multi-GPU version is developed based on our previous single-GPU version. In multi-GPU runs, one GPU takes charge of one domain and runs single-GPU code path. The communication between neighbouring domains takes a similar algorithm of CPU-based code of LAMMPS, but is optimised specifically for GPUs. We employ a memory-saving design which can enlarge maximum system size at the same device condition. An optimisation algorithm is employed to prolong the update period of neighbour list. We demonstrate good performance of multi-GPU runs on the simulation of Lennard-Jones liquid, dissipative particle dynamics liquid, polymer and nanoparticle composite, and two-patch particles on workstation. A good scaling of many nodes on cluster for two-patch particles is presented.

  12. Molecular Dynamic Simulations of Interaction of an AFM Probe with the Surface of an SCN Sample

    NASA Technical Reports Server (NTRS)

    Bune, Adris; Kaukler, William; Rose, M. Franklin (Technical Monitor)

    2001-01-01

    Molecular dynamic (MD) simulations is conducted in order to estimate forces of probe-substrate interaction in the Atomic Force Microscope (AFM). First a review of available molecular dynamic techniques is given. Implementation of MD simulation is based on an object-oriented code developed at the University of Delft. Modeling of the sample material - succinonitrile (SCN) - is based on the Lennard-Jones potentials. For the polystyrene probe an atomic interaction potential is used. Due to object-oriented structure of the code modification of an atomic interaction potential is straight forward. Calculation of melting temperature is used for validation of the code and of the interaction potentials. Various fitting parameters of the probe-substrate interaction potentials are considered, as potentials fitted to certain properties and temperature ranges may not be reliable for the others. This research provides theoretical foundation for an interpretation of actual measurements of an interaction forces using AFM.

  13. Large-scale molecular dynamics simulation of DNA: implementation and validation of the AMBER98 force field in LAMMPS.

    PubMed

    Grindon, Christina; Harris, Sarah; Evans, Tom; Novik, Keir; Coveney, Peter; Laughton, Charles

    2004-07-15

    Molecular modelling played a central role in the discovery of the structure of DNA by Watson and Crick. Today, such modelling is done on computers: the more powerful these computers are, the more detailed and extensive can be the study of the dynamics of such biological macromolecules. To fully harness the power of modern massively parallel computers, however, we need to develop and deploy algorithms which can exploit the structure of such hardware. The Large-scale Atomic/Molecular Massively Parallel Simulator (LAMMPS) is a scalable molecular dynamics code including long-range Coulomb interactions, which has been specifically designed to function efficiently on parallel platforms. Here we describe the implementation of the AMBER98 force field in LAMMPS and its validation for molecular dynamics investigations of DNA structure and flexibility against the benchmark of results obtained with the long-established code AMBER6 (Assisted Model Building with Energy Refinement, version 6). Extended molecular dynamics simulations on the hydrated DNA dodecamer d(CTTTTGCAAAAG)(2), which has previously been the subject of extensive dynamical analysis using AMBER6, show that it is possible to obtain excellent agreement in terms of static, dynamic and thermodynamic parameters between AMBER6 and LAMMPS. In comparison with AMBER6, LAMMPS shows greatly improved scalability in massively parallel environments, opening up the possibility of efficient simulations of order-of-magnitude larger systems and/or for order-of-magnitude greater simulation times.

  14. Implementing Molecular Dynamics for Hybrid High Performance Computers - 1. Short Range Forces

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Brown, W Michael; Wang, Peng; Plimpton, Steven J

    The use of accelerators such as general-purpose graphics processing units (GPGPUs) have become popular in scientific computing applications due to their low cost, impressive floating-point capabilities, high memory bandwidth, and low electrical power requirements. Hybrid high performance computers, machines with more than one type of floating-point processor, are now becoming more prevalent due to these advantages. In this work, we discuss several important issues in porting a large molecular dynamics code for use on parallel hybrid machines - 1) choosing a hybrid parallel decomposition that works on central processing units (CPUs) with distributed memory and accelerator cores with shared memory,more » 2) minimizing the amount of code that must be ported for efficient acceleration, 3) utilizing the available processing power from both many-core CPUs and accelerators, and 4) choosing a programming model for acceleration. We present our solution to each of these issues for short-range force calculation in the molecular dynamics package LAMMPS. We describe algorithms for efficient short range force calculation on hybrid high performance machines. We describe a new approach for dynamic load balancing of work between CPU and accelerator cores. We describe the Geryon library that allows a single code to compile with both CUDA and OpenCL for use on a variety of accelerators. Finally, we present results on a parallel test cluster containing 32 Fermi GPGPUs and 180 CPU cores.« less

  15. Molecular Dynamics of Hot Dense Plasmas: New Horizons

    NASA Astrophysics Data System (ADS)

    Graziani, Frank

    2011-10-01

    We describe the status of a new time-dependent simulation capability for hot dense plasmas. The backbone of this multi-institutional computational and experimental effort--the Cimarron Project--is the massively parallel molecular dynamics (MD) code ``ddcMD''. The project's focus is material conditions such as exist in inertial confinement fusion experiments, and in many stellar interiors: high temperatures, high densities, significant electromagnetic fields, mixtures of high- and low- Zelements, and non-Maxwellian particle distributions. Of particular importance is our ability to incorporate into this classical MD code key atomic, radiative, and nuclear processes, so that their interacting effects under non-ideal plasma conditions can be investigated. This talk summarizes progress in computational methodology, discusses strengths and weaknesses of quantum statistical potentials as effective interactions for MD, explains the model used for quantum events possibly occurring in a collision and highlights some significant results obtained to date. We describe the status of a new time-dependent simulation capability for hot dense plasmas. The backbone of this multi-institutional computational and experimental effort--the Cimarron Project--is the massively parallel molecular dynamics (MD) code ``ddcMD''. The project's focus is material conditions such as exist in inertial confinement fusion experiments, and in many stellar interiors: high temperatures, high densities, significant electromagnetic fields, mixtures of high- and low- Zelements, and non-Maxwellian particle distributions. Of particular importance is our ability to incorporate into this classical MD code key atomic, radiative, and nuclear processes, so that their interacting effects under non-ideal plasma conditions can be investigated. This talk summarizes progress in computational methodology, discusses strengths and weaknesses of quantum statistical potentials as effective interactions for MD, explains the

  16. Environmental Fluid Dynamics Code

    EPA Science Inventory

    The Environmental Fluid Dynamics Code (EFDC)is a state-of-the-art hydrodynamic model that can be used to simulate aquatic systems in one, two, and three dimensions. It has evolved over the past two decades to become one of the most widely used and technically defensible hydrodyn...

  17. Efficient molecular dynamics simulations with many-body potentials on graphics processing units

    NASA Astrophysics Data System (ADS)

    Fan, Zheyong; Chen, Wei; Vierimaa, Ville; Harju, Ari

    2017-09-01

    Graphics processing units have been extensively used to accelerate classical molecular dynamics simulations. However, there is much less progress on the acceleration of force evaluations for many-body potentials compared to pairwise ones. In the conventional force evaluation algorithm for many-body potentials, the force, virial stress, and heat current for a given atom are accumulated within different loops, which could result in write conflict between different threads in a CUDA kernel. In this work, we provide a new force evaluation algorithm, which is based on an explicit pairwise force expression for many-body potentials derived recently (Fan et al., 2015). In our algorithm, the force, virial stress, and heat current for a given atom can be accumulated within a single thread and is free of write conflicts. We discuss the formulations and algorithms and evaluate their performance. A new open-source code, GPUMD, is developed based on the proposed formulations. For the Tersoff many-body potential, the double precision performance of GPUMD using a Tesla K40 card is equivalent to that of the LAMMPS (Large-scale Atomic/Molecular Massively Parallel Simulator) molecular dynamics code running with about 100 CPU cores (Intel Xeon CPU X5670 @ 2.93 GHz).

  18. 50 GFlops molecular dynamics on the Connection Machine 5

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Lomdahl, P.S.; Tamayo, P.; Groenbech-Jensen, N.

    1993-12-31

    The authors present timings and performance numbers for a new short range three dimensional (3D) molecular dynamics (MD) code, SPaSM, on the Connection Machine-5 (CM-5). They demonstrate that runs with more than 10{sup 8} particles are now possible on massively parallel MIMD computers. To the best of their knowledge this is at least an order of magnitude more particles than what has previously been reported. Typical production runs show sustained performance (including communication) in the range of 47--50 GFlops on a 1024 node CM-5 with vector units (VUs). The speed of the code scales linearly with the number of processorsmore » and with the number of particles and shows 95% parallel efficiency in the speedup.« less

  19. Multiscale modeling of dislocation-precipitate interactions in Fe: From molecular dynamics to discrete dislocations.

    PubMed

    Lehtinen, Arttu; Granberg, Fredric; Laurson, Lasse; Nordlund, Kai; Alava, Mikko J

    2016-01-01

    The stress-driven motion of dislocations in crystalline solids, and thus the ensuing plastic deformation process, is greatly influenced by the presence or absence of various pointlike defects such as precipitates or solute atoms. These defects act as obstacles for dislocation motion and hence affect the mechanical properties of the material. Here we combine molecular dynamics studies with three-dimensional discrete dislocation dynamics simulations in order to model the interaction between different kinds of precipitates and a 1/2〈111〉{110} edge dislocation in BCC iron. We have implemented immobile spherical precipitates into the ParaDis discrete dislocation dynamics code, with the dislocations interacting with the precipitates via a Gaussian potential, generating a normal force acting on the dislocation segments. The parameters used in the discrete dislocation dynamics simulations for the precipitate potential, the dislocation mobility, shear modulus, and dislocation core energy are obtained from molecular dynamics simulations. We compare the critical stresses needed to unpin the dislocation from the precipitate in molecular dynamics and discrete dislocation dynamics simulations in order to fit the two methods together and discuss the variety of the relevant pinning and depinning mechanisms.

  20. Surface 3D nanostructuring by tightly focused laser pulse: simulations by Lagrangian code and molecular dynamics

    NASA Astrophysics Data System (ADS)

    Inogamov, Nail A.; Zhakhovsky, Vasily V.

    2016-02-01

    There are many important applications in which the ultrashort diffraction-limited and therefore tightly focused laser pulses irradiates metal films mounted on dielectric substrate. Here we present the detailed picture of laser peeling and 3D structure formation of the thin (relative to a depth of a heat affected zone in the bulk targets) gold films on glass substrate. The underlying physics of such diffraction-limited laser peeling was not well understood previously. Our approach is based on a physical model which takes into consideration the new calculations of the two-temperature (2T) equation of state (2T EoS) and the two-temperature transport coefficients together with the coupling parameter between electron and ion subsystems. The usage of the 2T EoS and the kinetic coefficients is required because absorption of an ultrashort pulse with duration of 10-1000 fs excites electron subsystem of metal and transfers substance into the 2T state with hot electrons (typical electron temperatures 1-3 eV) and much colder ions. It is shown that formation of submicrometer-sized 3D structures is a result of the electron-ion energy transfer, melting, and delamination of film from substrate under combined action of electron and ion pressures, capillary deceleration of the delaminated liquid metal or semiconductor, and ultrafast freezing of molten material. We found that the freezing is going in non-equilibrium regime with strongly overcooled liquid phase. In this case the Stefan approximation is non-applicable because the solidification front speed is limited by the diffusion rate of atoms in the molten material. To solve the problem we have developed the 2T Lagrangian code including all this reach physics in. We also used the high-performance combined Monte- Carlo and molecular dynamics code for simulation of surface 3D nanostructuring at later times after completion of electron-ion relaxation.

  1. DFTBaby: A software package for non-adiabatic molecular dynamics simulations based on long-range corrected tight-binding TD-DFT(B)

    NASA Astrophysics Data System (ADS)

    Humeniuk, Alexander; Mitrić, Roland

    2017-12-01

    A software package, called DFTBaby, is published, which provides the electronic structure needed for running non-adiabatic molecular dynamics simulations at the level of tight-binding DFT. A long-range correction is incorporated to avoid spurious charge transfer states. Excited state energies, their analytic gradients and scalar non-adiabatic couplings are computed using tight-binding TD-DFT. These quantities are fed into a molecular dynamics code, which integrates Newton's equations of motion for the nuclei together with the electronic Schrödinger equation. Non-adiabatic effects are included by surface hopping. As an example, the program is applied to the optimization of excited states and non-adiabatic dynamics of polyfluorene. The python and Fortran source code is available at http://www.dftbaby.chemie.uni-wuerzburg.de.

  2. Minimal Increase Network Coding for Dynamic Networks.

    PubMed

    Zhang, Guoyin; Fan, Xu; Wu, Yanxia

    2016-01-01

    Because of the mobility, computing power and changeable topology of dynamic networks, it is difficult for random linear network coding (RLNC) in static networks to satisfy the requirements of dynamic networks. To alleviate this problem, a minimal increase network coding (MINC) algorithm is proposed. By identifying the nonzero elements of an encoding vector, it selects blocks to be encoded on the basis of relationship between the nonzero elements that the controls changes in the degrees of the blocks; then, the encoding time is shortened in a dynamic network. The results of simulations show that, compared with existing encoding algorithms, the MINC algorithm provides reduced computational complexity of encoding and an increased probability of delivery.

  3. Minimal Increase Network Coding for Dynamic Networks

    PubMed Central

    Wu, Yanxia

    2016-01-01

    Because of the mobility, computing power and changeable topology of dynamic networks, it is difficult for random linear network coding (RLNC) in static networks to satisfy the requirements of dynamic networks. To alleviate this problem, a minimal increase network coding (MINC) algorithm is proposed. By identifying the nonzero elements of an encoding vector, it selects blocks to be encoded on the basis of relationship between the nonzero elements that the controls changes in the degrees of the blocks; then, the encoding time is shortened in a dynamic network. The results of simulations show that, compared with existing encoding algorithms, the MINC algorithm provides reduced computational complexity of encoding and an increased probability of delivery. PMID:26867211

  4. Diffusion in liquid Germanium using ab initio molecular dynamics

    NASA Astrophysics Data System (ADS)

    Kulkarni, R. V.; Aulbur, W. G.; Stroud, D.

    1996-03-01

    We describe the results of calculations of the self-diffusion constant of liquid Ge over a range of temperatures. The calculations are carried out using an ab initio molecular dynamics scheme which combines an LDA model for the electronic structure with the Bachelet-Hamann-Schlüter norm-conserving pseudopotentials^1. The energies associated with electronic degrees of freedom are minimized using the Williams-Soler algorithm, and ionic moves are carried out using the Verlet algorithm. We use an energy cutoff of 10 Ry, which is sufficient to give results for the lattice constant and bulk modulus of crystalline Ge to within 1% and 12% of experiment. The program output includes not only the self-diffusion constant but also the structure factor, electronic density of states, and low-frequency electrical conductivity. We will compare our results with other ab initio and semi-empirical calculations, and discuss extension to impurity diffusion. ^1 We use the ab initio molecular dynamics code fhi94md, developed at 1cm the Fritz-Haber Institute, Berlin. ^2 Work supported by NASA, Grant NAG3-1437.

  5. Dynamic Forces in Spur Gears - Measurement, Prediction, and Code Validation

    NASA Technical Reports Server (NTRS)

    Oswald, Fred B.; Townsend, Dennis P.; Rebbechi, Brian; Lin, Hsiang Hsi

    1996-01-01

    Measured and computed values for dynamic loads in spur gears were compared to validate a new version of the NASA gear dynamics code DANST-PC. Strain gage data from six gear sets with different tooth profiles were processed to determine the dynamic forces acting between the gear teeth. Results demonstrate that the analysis code successfully simulates the dynamic behavior of the gears. Differences between analysis and experiment were less than 10 percent under most conditions.

  6. Development of new two-dimensional spectral/spatial code based on dynamic cyclic shift code for OCDMA system

    NASA Astrophysics Data System (ADS)

    Jellali, Nabiha; Najjar, Monia; Ferchichi, Moez; Rezig, Houria

    2017-07-01

    In this paper, a new two-dimensional spectral/spatial codes family, named two dimensional dynamic cyclic shift codes (2D-DCS) is introduced. The 2D-DCS codes are derived from the dynamic cyclic shift code for the spectral and spatial coding. The proposed system can fully eliminate the multiple access interference (MAI) by using the MAI cancellation property. The effect of shot noise, phase-induced intensity noise and thermal noise are used to analyze the code performance. In comparison with existing two dimensional (2D) codes, such as 2D perfect difference (2D-PD), 2D Extended Enhanced Double Weight (2D-Extended-EDW) and 2D hybrid (2D-FCC/MDW) codes, the numerical results show that our proposed codes have the best performance. By keeping the same code length and increasing the spatial code, the performance of our 2D-DCS system is enhanced: it provides higher data rates while using lower transmitted power and a smaller spectral width.

  7. The SCEC/USGS dynamic earthquake rupture code verification exercise

    USGS Publications Warehouse

    Harris, R.A.; Barall, M.; Archuleta, R.; Dunham, E.; Aagaard, Brad T.; Ampuero, J.-P.; Bhat, H.; Cruz-Atienza, Victor M.; Dalguer, L.; Dawson, P.; Day, S.; Duan, B.; Ely, G.; Kaneko, Y.; Kase, Y.; Lapusta, N.; Liu, Yajing; Ma, S.; Oglesby, D.; Olsen, K.; Pitarka, A.; Song, S.; Templeton, E.

    2009-01-01

    Numerical simulations of earthquake rupture dynamics are now common, yet it has been difficult to test the validity of these simulations because there have been few field observations and no analytic solutions with which to compare the results. This paper describes the Southern California Earthquake Center/U.S. Geological Survey (SCEC/USGS) Dynamic Earthquake Rupture Code Verification Exercise, where codes that simulate spontaneous rupture dynamics in three dimensions are evaluated and the results produced by these codes are compared using Web-based tools. This is the first time that a broad and rigorous examination of numerous spontaneous rupture codes has been performed—a significant advance in this science. The automated process developed to attain this achievement provides for a future where testing of codes is easily accomplished.Scientists who use computer simulations to understand earthquakes utilize a range of techniques. Most of these assume that earthquakes are caused by slip at depth on faults in the Earth, but hereafter the strategies vary. Among the methods used in earthquake mechanics studies are kinematic approaches and dynamic approaches.The kinematic approach uses a computer code that prescribes the spatial and temporal evolution of slip on the causative fault (or faults). These types of simulations are very helpful, especially since they can be used in seismic data inversions to relate the ground motions recorded in the field to slip on the fault(s) at depth. However, these kinematic solutions generally provide no insight into the physics driving the fault slip or information about why the involved fault(s) slipped that much (or that little). In other words, these kinematic solutions may lack information about the physical dynamics of earthquake rupture that will be most helpful in forecasting future events.To help address this issue, some researchers use computer codes to numerically simulate earthquakes and construct dynamic, spontaneous

  8. Molecular dynamics simulation of the structure and dynamics of 5-HT3 serotonin receptor

    NASA Astrophysics Data System (ADS)

    Antonov, M. Yu.; Popinako, A. V.; Prokopiev, G. A.

    2016-10-01

    In this work, we investigated structure, dynamics and ion transportation in transmembrane domain of the 5-HT3 serotonin receptor. High-resolution (0.35 nm) structure of the 5-HT3 receptor in complex with stabilizing nanobodies was determined by protein crystallography in 2014 (Protein data bank (PDB) code 4PIR). Transmembrane domain of the structure was prepared in complex with explicit membrane environment (1-palmitoyl-2-oleoyl-sn-glycero-3-phosphatidylcholine (POPC)) and solvent (TIP3P water model). Molecular dynamics protocols for simulation and stabilization of the transmembrane domain of the 5-HT3 receptor model were developed and 60 ns simulation of the structure was conducted in order to explore structural parameters of the system. We estimated the mean force profile for Na+ ions using umbrella sampling method.

  9. The "Collisions Cube" Molecular Dynamics Simulator.

    ERIC Educational Resources Information Center

    Nash, John J.; Smith, Paul E.

    1995-01-01

    Describes a molecular dynamics simulator that employs ping-pong balls as the atoms or molecules and is suitable for either large lecture halls or small classrooms. Discusses its use in illustrating many of the fundamental concepts related to molecular motion and dynamics and providing a three-dimensional perspective of molecular motion. (JRH)

  10. Molecular dynamics and Monte Carlo simulations resolve apparent diffusion rate differences for proteins confined in nanochannels

    DOE PAGES

    Tringe, J. W.; Ileri, N.; Levie, H. W.; ...

    2015-08-01

    We use Molecular Dynamics and Monte Carlo simulations to examine molecular transport phenomena in nanochannels, explaining four orders of magnitude difference in wheat germ agglutinin (WGA) protein diffusion rates observed by fluorescence correlation spectroscopy (FCS) and by direct imaging of fluorescently-labeled proteins. We first use the ESPResSo Molecular Dynamics code to estimate the surface transport distance for neutral and charged proteins. We then employ a Monte Carlo model to calculate the paths of protein molecules on surfaces and in the bulk liquid transport medium. Our results show that the transport characteristics depend strongly on the degree of molecular surface coverage.more » Atomic force microscope characterization of surfaces exposed to WGA proteins for 1000 s show large protein aggregates consistent with the predicted coverage. These calculations and experiments provide useful insight into the details of molecular motion in confined geometries.« less

  11. GPU Optimizations for a Production Molecular Docking Code*

    PubMed Central

    Landaverde, Raphael; Herbordt, Martin C.

    2015-01-01

    Modeling molecular docking is critical to both understanding life processes and designing new drugs. In previous work we created the first published GPU-accelerated docking code (PIPER) which achieved a roughly 5× speed-up over a contemporaneous 4 core CPU. Advances in GPU architecture and in the CPU code, however, have since reduced this relalative performance by a factor of 10. In this paper we describe the upgrade of GPU PIPER. This required an entire rewrite, including algorithm changes and moving most remaining non-accelerated CPU code onto the GPU. The result is a 7× improvement in GPU performance and a 3.3× speedup over the CPU-only code. We find that this difference in time is almost entirely due to the difference in run times of the 3D FFT library functions on CPU (MKL) and GPU (cuFFT), respectively. The GPU code has been integrated into the ClusPro docking server which has over 4000 active users. PMID:26594667

  12. GPU Optimizations for a Production Molecular Docking Code.

    PubMed

    Landaverde, Raphael; Herbordt, Martin C

    2014-09-01

    Modeling molecular docking is critical to both understanding life processes and designing new drugs. In previous work we created the first published GPU-accelerated docking code (PIPER) which achieved a roughly 5× speed-up over a contemporaneous 4 core CPU. Advances in GPU architecture and in the CPU code, however, have since reduced this relalative performance by a factor of 10. In this paper we describe the upgrade of GPU PIPER. This required an entire rewrite, including algorithm changes and moving most remaining non-accelerated CPU code onto the GPU. The result is a 7× improvement in GPU performance and a 3.3× speedup over the CPU-only code. We find that this difference in time is almost entirely due to the difference in run times of the 3D FFT library functions on CPU (MKL) and GPU (cuFFT), respectively. The GPU code has been integrated into the ClusPro docking server which has over 4000 active users.

  13. General purpose molecular dynamics simulations fully implemented on graphics processing units

    NASA Astrophysics Data System (ADS)

    Anderson, Joshua A.; Lorenz, Chris D.; Travesset, A.

    2008-05-01

    Graphics processing units (GPUs), originally developed for rendering real-time effects in computer games, now provide unprecedented computational power for scientific applications. In this paper, we develop a general purpose molecular dynamics code that runs entirely on a single GPU. It is shown that our GPU implementation provides a performance equivalent to that of fast 30 processor core distributed memory cluster. Our results show that GPUs already provide an inexpensive alternative to such clusters and discuss implications for the future.

  14. mdFoam+: Advanced molecular dynamics in OpenFOAM

    NASA Astrophysics Data System (ADS)

    Longshaw, S. M.; Borg, M. K.; Ramisetti, S. B.; Zhang, J.; Lockerby, D. A.; Emerson, D. R.; Reese, J. M.

    2018-03-01

    This paper introduces mdFoam+, which is an MPI parallelised molecular dynamics (MD) solver implemented entirely within the OpenFOAM software framework. It is open-source and released under the same GNU General Public License (GPL) as OpenFOAM. The source code is released as a publicly open software repository that includes detailed documentation and tutorial cases. Since mdFoam+ is designed entirely within the OpenFOAM C++ object-oriented framework, it inherits a number of key features. The code is designed for extensibility and flexibility, so it is aimed first and foremost as an MD research tool, in which new models and test cases can be developed and tested rapidly. Implementing mdFoam+ in OpenFOAM also enables easier development of hybrid methods that couple MD with continuum-based solvers. Setting up MD cases follows the standard OpenFOAM format, as mdFoam+ also relies upon the OpenFOAM dictionary-based directory structure. This ensures that useful pre- and post-processing capabilities provided by OpenFOAM remain available even though the fully Lagrangian nature of an MD simulation is not typical of most OpenFOAM applications. Results show that mdFoam+ compares well to another well-known MD code (e.g. LAMMPS) in terms of benchmark problems, although it also has additional functionality that does not exist in other open-source MD codes.

  15. The PP1 binding code: a molecular-lego strategy that governs specificity.

    PubMed

    Heroes, Ewald; Lesage, Bart; Görnemann, Janina; Beullens, Monique; Van Meervelt, Luc; Bollen, Mathieu

    2013-01-01

    Ser/Thr protein phosphatase 1 (PP1) is a single-domain hub protein with nearly 200 validated interactors in vertebrates. PP1-interacting proteins (PIPs) are ubiquitously expressed but show an exceptional diversity in brain, testis and white blood cells. The binding of PIPs is mainly mediated by short motifs that dock to surface grooves of PP1. Although PIPs often contain variants of the same PP1 binding motifs, they differ in the number and combination of docking sites. This molecular-lego strategy for binding to PP1 creates holoenzymes with unique properties. The PP1 binding code can be described as specific, universal, degenerate, nonexclusive and dynamic. PIPs control associated PP1 by interference with substrate recruitment or access to the active site. In addition, some PIPs have a subcellular targeting domain that promotes dephosphorylation by increasing the local concentration of PP1. The diversity of the PP1 interactome and the properties of the PP1 binding code account for the exquisite specificity of PP1 in vivo. © 2012 The Authors Journal compilation © 2012 FEBS.

  16. An Evaluation of Explicit Receptor Flexibility in Molecular Docking Using Molecular Dynamics and Torsion Angle Molecular Dynamics.

    PubMed

    Armen, Roger S; Chen, Jianhan; Brooks, Charles L

    2009-10-13

    Incorporating receptor flexibility into molecular docking should improve results for flexible proteins. However, the incorporation of explicit all-atom flexibility with molecular dynamics for the entire protein chain may also introduce significant error and "noise" that could decrease docking accuracy and deteriorate the ability of a scoring function to rank native-like poses. We address this apparent paradox by comparing the success of several flexible receptor models in cross-docking and multiple receptor ensemble docking for p38α mitogen-activated protein (MAP) kinase. Explicit all-atom receptor flexibility has been incorporated into a CHARMM-based molecular docking method (CDOCKER) using both molecular dynamics (MD) and torsion angle molecular dynamics (TAMD) for the refinement of predicted protein-ligand binding geometries. These flexible receptor models have been evaluated, and the accuracy and efficiency of TAMD sampling is directly compared to MD sampling. Several flexible receptor models are compared, encompassing flexible side chains, flexible loops, multiple flexible backbone segments, and treatment of the entire chain as flexible. We find that although including side chain and some backbone flexibility is required for improved docking accuracy as expected, docking accuracy also diminishes as additional and unnecessary receptor flexibility is included into the conformational search space. Ensemble docking results demonstrate that including protein flexibility leads to to improved agreement with binding data for 227 active compounds. This comparison also demonstrates that a flexible receptor model enriches high affinity compound identification without significantly increasing the number of false positives from low affinity compounds.

  17. Molecular Dynamics of Hot Dense Plasmas: New Horizons

    NASA Astrophysics Data System (ADS)

    Graziani, Frank

    2011-06-01

    We describe the status of a new time-dependent simulation capability for hot dense plasmas. The backbone of this multi-institutional computational and experimental effort--the Cimarron Project--is the massively parallel molecular dynamics (MD) code ``ddcMD''. The project's focus is material conditions such as exist in inertial confinement fusion experiments, and in many stellar interiors: high temperatures, high densities, significant electromagnetic fields, mixtures of high- and low- Z elements, and non-Maxwellian particle distributions. Of particular importance is our ability to incorporate into this classical MD code key atomic, radiative, and nuclear processes, so that their interacting effects under non-ideal plasma conditions can be investigated. This talk summarizes progress in computational methodology, discusses strengths and weaknesses of quantum statistical potentials as effective interactions for MD, explains the model used for quantum events possibly occurring in a collision and highlights some significant results obtained to date. We will also discuss a new idea called kinetic theory MD which now being explored to deal more efficiently with the very disparate dynamical timescales that arise in fusion plasmas. We discuss how this approach can be derived rigorously from the n-body quantum Wigner equation and illustrate the approach with an example. This work is performed under the auspices of the U. S. Department of Energy by Lawrence Livermore National Laboratory under Contract DE-AC52-07NA27344.

  18. Parallel Fast Multipole Method For Molecular Dynamics

    DTIC Science & Technology

    2007-06-01

    Parallel Fast Multipole Method For Molecular Dynamics THESIS Reid G. Ormseth, Captain, USAF AFIT/GAP/ENP/07-J02 DEPARTMENT OF THE AIR FORCE AIR...the United States Government. AFIT/GAP/ENP/07-J02 Parallel Fast Multipole Method For Molecular Dynamics THESIS Presented to the Faculty Department of...has also been provided by ‘The Art of Molecular Dynamics Simulation ’ by Dennis Rapaport. This work is the clearest treatment of the Fast Multipole

  19. Lightweight computational steering of very large scale molecular dynamics simulations

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Beazley, D.M.; Lomdahl, P.S.

    1996-09-01

    We present a computational steering approach for controlling, analyzing, and visualizing very large scale molecular dynamics simulations involving tens to hundreds of millions of atoms. Our approach relies on extensible scripting languages and an easy to use tool for building extensions and modules. The system is extremely easy to modify, works with existing C code, is memory efficient, and can be used from inexpensive workstations and networks. We demonstrate how we have used this system to manipulate data from production MD simulations involving as many as 104 million atoms running on the CM-5 and Cray T3D. We also show howmore » this approach can be used to build systems that integrate common scripting languages (including Tcl/Tk, Perl, and Python), simulation code, user extensions, and commercial data analysis packages.« less

  20. Molecular Biodynamers: Dynamic Covalent Analogues of Biopolymers

    PubMed Central

    2017-01-01

    Conspectus Constitutional dynamic chemistry (CDC) features the use of reversible linkages at both molecular and supramolecular levels, including reversible covalent bonds (dynamic covalent chemistry, DCC) and noncovalent interactions (dynamic noncovalent chemistry, DNCC). Due to its inherent reversibility and stimuli-responsiveness, CDC has been widely utilized as a powerful tool for the screening of bioactive compounds, the exploitation of receptors or substrates driven by molecular recognition, and the fabrication of constitutionally dynamic materials. Implementation of CDC in biopolymer science leads to the generation of constitutionally dynamic analogues of biopolymers, biodynamers, at the molecular level (molecular biodynamers) through DCC or at the supramolecular level (supramolecular biodynamers) via DNCC. Therefore, biodynamers are prepared by reversible covalent polymerization or noncovalent polyassociation of biorelevant monomers. In particular, molecular biodynamers, biodynamers of the covalent type whose monomeric units are connected by reversible covalent bonds, are generated by reversible polymerization of bio-based monomers and can be seen as a combination of biopolymers with DCC. Owing to the reversible covalent bonds used in DCC, molecular biodynamers can undergo continuous and spontaneous constitutional modifications via incorporation/decorporation and exchange of biorelevant monomers in response to internal or external stimuli. As a result, they behave as adaptive materials with novel properties, such as self-healing, stimuli-responsiveness, and tunable mechanical and optical character. More specifically, molecular biodynamers combine the biorelevant characters (e.g., biocompatibility, biodegradability, biofunctionality) of bioactive monomers with the dynamic features of reversible covalent bonds (e.g., changeable, tunable, controllable, self-healing, and stimuli-responsive capacities), to realize synergistic properties in one system. In addition

  1. KEWPIE: A dynamical cascade code for decaying exited compound nuclei

    NASA Astrophysics Data System (ADS)

    Bouriquet, Bertrand; Abe, Yasuhisa; Boilley, David

    2004-05-01

    A new dynamical cascade code for decaying hot nuclei is proposed and specially adapted to the synthesis of super-heavy nuclei. For such a case, the interesting channel is of the tiny fraction that will decay through particles emission, thus the code avoids classical Monte-Carlo methods and proposes a new numerical scheme. The time dependence is explicitely taken into account in order to cope with the fact that fission decay rate might not be constant. The code allows to evaluate both statistical and dynamical observables. Results are successfully compared to experimental data.

  2. Dynamic full-scalability conversion in scalable video coding

    NASA Astrophysics Data System (ADS)

    Lee, Dong Su; Bae, Tae Meon; Thang, Truong Cong; Ro, Yong Man

    2007-02-01

    For outstanding coding efficiency with scalability functions, SVC (Scalable Video Coding) is being standardized. SVC can support spatial, temporal and SNR scalability and these scalabilities are useful to provide a smooth video streaming service even in a time varying network such as a mobile environment. But current SVC is insufficient to support dynamic video conversion with scalability, thereby the adaptation of bitrate to meet a fluctuating network condition is limited. In this paper, we propose dynamic full-scalability conversion methods for QoS adaptive video streaming in SVC. To accomplish full scalability dynamic conversion, we develop corresponding bitstream extraction, encoding and decoding schemes. At the encoder, we insert the IDR NAL periodically to solve the problems of spatial scalability conversion. At the extractor, we analyze the SVC bitstream to get the information which enable dynamic extraction. Real time extraction is achieved by using this information. Finally, we develop the decoder so that it can manage the changing scalability. Experimental results showed that dynamic full-scalability conversion was verified and it was necessary for time varying network condition.

  3. Molecular Dynamics Simulations of an Idealized Shock Tube: N2 in Ar Bath Driven by He

    NASA Astrophysics Data System (ADS)

    Piskulich, Ezekiel Ashe; Sewell, Thomas D.; Thompson, Donald L.

    2015-06-01

    The dynamics of 10% N2 in Ar initially at 298 K in an idealized shock tube driven by He was studied using molecular dynamics. The simulations were performed using the Large-Scale Atomic/Molecular Massively Parallel Simulator (LAMMPS) code. Nitrogen was modeled as a Morse oscillator and non-covalent interactions were approximated by the Buckingham exponential-6 pair potential. The initial pressures in the He driver gas and the driven N2/Ar gas were 1000 atm and 20 atm, respectively. Microcanonical trajectories were followed for 2 ns following release of the driver gas. Results for excitation and subsequent relaxation of the N2, as well as properties of the gas during the simulations, will be reported.

  4. An Evaluation of Explicit Receptor Flexibility in Molecular Docking Using Molecular Dynamics and Torsion Angle Molecular Dynamics

    PubMed Central

    Armen, Roger S.; Chen, Jianhan; Brooks, Charles L.

    2009-01-01

    Incorporating receptor flexibility into molecular docking should improve results for flexible proteins. However, the incorporation of explicit all-atom flexibility with molecular dynamics for the entire protein chain may also introduce significant error and “noise” that could decrease docking accuracy and deteriorate the ability of a scoring function to rank native-like poses. We address this apparent paradox by comparing the success of several flexible receptor models in cross-docking and multiple receptor ensemble docking for p38α mitogen-activated protein (MAP) kinase. Explicit all-atom receptor flexibility has been incorporated into a CHARMM-based molecular docking method (CDOCKER) using both molecular dynamics (MD) and torsion angle molecular dynamics (TAMD) for the refinement of predicted protein-ligand binding geometries. These flexible receptor models have been evaluated, and the accuracy and efficiency of TAMD sampling is directly compared to MD sampling. Several flexible receptor models are compared, encompassing flexible side chains, flexible loops, multiple flexible backbone segments, and treatment of the entire chain as flexible. We find that although including side chain and some backbone flexibility is required for improved docking accuracy as expected, docking accuracy also diminishes as additional and unnecessary receptor flexibility is included into the conformational search space. Ensemble docking results demonstrate that including protein flexibility leads to to improved agreement with binding data for 227 active compounds. This comparison also demonstrates that a flexible receptor model enriches high affinity compound identification without significantly increasing the number of false positives from low affinity compounds. PMID:20160879

  5. Dynamic Structure of a Molecular Liquid S0.5Cl0.5: Ab initio Molecular-Dynamics Simulations

    NASA Astrophysics Data System (ADS)

    Ohmura, Satoshi; Shimakura, Hironori; Kawakita, Yukinobu; Shimojo, Fuyuki; Yao, Makoto

    2013-07-01

    The static and dynamic structures of a molecular liquid S0.5Cl0.5 consisting of Cl--S--S--Cl (S2Cl2) type molecules are studied by means of ab initio molecular dynamics simulations. Both the calculated static and dynamic structure factors are in good agreement with experimental results. The dynamic structures are discussed based on van-Hove distinct correlation functions, molecular translational mean-square displacements (TMSD) and rotational mean-square displacements (RMSD). In the TMSD and RMSD, there are ballistic and diffusive regimes in the sub-picosecond and picosecond time regions, respectively. These time scales are consistent with the decay time observed experimentally. The interaction between molecules in the liquid is also discussed in comparison with that in another liquid chalcogen--halogen system Se0.5Cl0.5.

  6. Next generation extended Lagrangian first principles molecular dynamics

    NASA Astrophysics Data System (ADS)

    Niklasson, Anders M. N.

    2017-08-01

    Extended Lagrangian Born-Oppenheimer molecular dynamics [A. M. N. Niklasson, Phys. Rev. Lett. 100, 123004 (2008)] is formulated for general Hohenberg-Kohn density-functional theory and compared with the extended Lagrangian framework of first principles molecular dynamics by Car and Parrinello [Phys. Rev. Lett. 55, 2471 (1985)]. It is shown how extended Lagrangian Born-Oppenheimer molecular dynamics overcomes several shortcomings of regular, direct Born-Oppenheimer molecular dynamics, while improving or maintaining important features of Car-Parrinello simulations. The accuracy of the electronic degrees of freedom in extended Lagrangian Born-Oppenheimer molecular dynamics, with respect to the exact Born-Oppenheimer solution, is of second-order in the size of the integration time step and of fourth order in the potential energy surface. Improved stability over recent formulations of extended Lagrangian Born-Oppenheimer molecular dynamics is achieved by generalizing the theory to finite temperature ensembles, using fractional occupation numbers in the calculation of the inner-product kernel of the extended harmonic oscillator that appears as a preconditioner in the electronic equations of motion. Material systems that normally exhibit slow self-consistent field convergence can be simulated using integration time steps of the same order as in direct Born-Oppenheimer molecular dynamics, but without the requirement of an iterative, non-linear electronic ground-state optimization prior to the force evaluations and without a systematic drift in the total energy. In combination with proposed low-rank and on the fly updates of the kernel, this formulation provides an efficient and general framework for quantum-based Born-Oppenheimer molecular dynamics simulations.

  7. Next generation extended Lagrangian first principles molecular dynamics.

    PubMed

    Niklasson, Anders M N

    2017-08-07

    Extended Lagrangian Born-Oppenheimer molecular dynamics [A. M. N. Niklasson, Phys. Rev. Lett. 100, 123004 (2008)] is formulated for general Hohenberg-Kohn density-functional theory and compared with the extended Lagrangian framework of first principles molecular dynamics by Car and Parrinello [Phys. Rev. Lett. 55, 2471 (1985)]. It is shown how extended Lagrangian Born-Oppenheimer molecular dynamics overcomes several shortcomings of regular, direct Born-Oppenheimer molecular dynamics, while improving or maintaining important features of Car-Parrinello simulations. The accuracy of the electronic degrees of freedom in extended Lagrangian Born-Oppenheimer molecular dynamics, with respect to the exact Born-Oppenheimer solution, is of second-order in the size of the integration time step and of fourth order in the potential energy surface. Improved stability over recent formulations of extended Lagrangian Born-Oppenheimer molecular dynamics is achieved by generalizing the theory to finite temperature ensembles, using fractional occupation numbers in the calculation of the inner-product kernel of the extended harmonic oscillator that appears as a preconditioner in the electronic equations of motion. Material systems that normally exhibit slow self-consistent field convergence can be simulated using integration time steps of the same order as in direct Born-Oppenheimer molecular dynamics, but without the requirement of an iterative, non-linear electronic ground-state optimization prior to the force evaluations and without a systematic drift in the total energy. In combination with proposed low-rank and on the fly updates of the kernel, this formulation provides an efficient and general framework for quantum-based Born-Oppenheimer molecular dynamics simulations.

  8. Algorithms of GPU-enabled reactive force field (ReaxFF) molecular dynamics.

    PubMed

    Zheng, Mo; Li, Xiaoxia; Guo, Li

    2013-04-01

    Reactive force field (ReaxFF), a recent and novel bond order potential, allows for reactive molecular dynamics (ReaxFF MD) simulations for modeling larger and more complex molecular systems involving chemical reactions when compared with computation intensive quantum mechanical methods. However, ReaxFF MD can be approximately 10-50 times slower than classical MD due to its explicit modeling of bond forming and breaking, the dynamic charge equilibration at each time-step, and its one order smaller time-step than the classical MD, all of which pose significant computational challenges in simulation capability to reach spatio-temporal scales of nanometers and nanoseconds. The very recent advances of graphics processing unit (GPU) provide not only highly favorable performance for GPU enabled MD programs compared with CPU implementations but also an opportunity to manage with the computing power and memory demanding nature imposed on computer hardware by ReaxFF MD. In this paper, we present the algorithms of GMD-Reax, the first GPU enabled ReaxFF MD program with significantly improved performance surpassing CPU implementations on desktop workstations. The performance of GMD-Reax has been benchmarked on a PC equipped with a NVIDIA C2050 GPU for coal pyrolysis simulation systems with atoms ranging from 1378 to 27,283. GMD-Reax achieved speedups as high as 12 times faster than Duin et al.'s FORTRAN codes in Lammps on 8 CPU cores and 6 times faster than the Lammps' C codes based on PuReMD in terms of the simulation time per time-step averaged over 100 steps. GMD-Reax could be used as a new and efficient computational tool for exploiting very complex molecular reactions via ReaxFF MD simulation on desktop workstations. Copyright © 2013 Elsevier Inc. All rights reserved.

  9. Dynamic Divisive Normalization Predicts Time-Varying Value Coding in Decision-Related Circuits

    PubMed Central

    LoFaro, Thomas; Webb, Ryan; Glimcher, Paul W.

    2014-01-01

    Normalization is a widespread neural computation, mediating divisive gain control in sensory processing and implementing a context-dependent value code in decision-related frontal and parietal cortices. Although decision-making is a dynamic process with complex temporal characteristics, most models of normalization are time-independent and little is known about the dynamic interaction of normalization and choice. Here, we show that a simple differential equation model of normalization explains the characteristic phasic-sustained pattern of cortical decision activity and predicts specific normalization dynamics: value coding during initial transients, time-varying value modulation, and delayed onset of contextual information. Empirically, we observe these predicted dynamics in saccade-related neurons in monkey lateral intraparietal cortex. Furthermore, such models naturally incorporate a time-weighted average of past activity, implementing an intrinsic reference-dependence in value coding. These results suggest that a single network mechanism can explain both transient and sustained decision activity, emphasizing the importance of a dynamic view of normalization in neural coding. PMID:25429145

  10. Stable and Dynamic Coding for Working Memory in Primate Prefrontal Cortex

    PubMed Central

    Watanabe, Kei; Funahashi, Shintaro; Stokes, Mark G.

    2017-01-01

    Working memory (WM) provides the stability necessary for high-level cognition. Influential theories typically assume that WM depends on the persistence of stable neural representations, yet increasing evidence suggests that neural states are highly dynamic. Here we apply multivariate pattern analysis to explore the population dynamics in primate lateral prefrontal cortex (PFC) during three variants of the classic memory-guided saccade task (recorded in four animals). We observed the hallmark of dynamic population coding across key phases of a working memory task: sensory processing, memory encoding, and response execution. Throughout both these dynamic epochs and the memory delay period, however, the neural representational geometry remained stable. We identified two characteristics that jointly explain these dynamics: (1) time-varying changes in the subpopulation of neurons coding for task variables (i.e., dynamic subpopulations); and (2) time-varying selectivity within neurons (i.e., dynamic selectivity). These results indicate that even in a very simple memory-guided saccade task, PFC neurons display complex dynamics to support stable representations for WM. SIGNIFICANCE STATEMENT Flexible, intelligent behavior requires the maintenance and manipulation of incoming information over various time spans. For short time spans, this faculty is labeled “working memory” (WM). Dominant models propose that WM is maintained by stable, persistent patterns of neural activity in prefrontal cortex (PFC). However, recent evidence suggests that neural activity in PFC is dynamic, even while the contents of WM remain stably represented. Here, we explored the neural dynamics in PFC during a memory-guided saccade task. We found evidence for dynamic population coding in various task epochs, despite striking stability in the neural representational geometry of WM. Furthermore, we identified two distinct cellular mechanisms that contribute to dynamic population coding. PMID

  11. High-Performance First-Principles Molecular Dynamics for Predictive Theory and Modeling

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Gygi, Francois; Galli, Giulia; Schwegler, Eric

    This project focused on developing high-performance software tools for First-Principles Molecular Dynamics (FPMD) simulations, and applying them in investigations of materials relevant to energy conversion processes. FPMD is an atomistic simulation method that combines a quantum-mechanical description of electronic structure with the statistical description provided by molecular dynamics (MD) simulations. This reliance on fundamental principles allows FPMD simulations to provide a consistent description of structural, dynamical and electronic properties of a material. This is particularly useful in systems for which reliable empirical models are lacking. FPMD simulations are increasingly used as a predictive tool for applications such as batteries, solarmore » energy conversion, light-emitting devices, electro-chemical energy conversion devices and other materials. During the course of the project, several new features were developed and added to the open-source Qbox FPMD code. The code was further optimized for scalable operation of large-scale, Leadership-Class DOE computers. When combined with Many-Body Perturbation Theory (MBPT) calculations, this infrastructure was used to investigate structural and electronic properties of liquid water, ice, aqueous solutions, nanoparticles and solid-liquid interfaces. Computing both ionic trajectories and electronic structure in a consistent manner enabled the simulation of several spectroscopic properties, such as Raman spectra, infrared spectra, and sum-frequency generation spectra. The accuracy of the approximations used allowed for direct comparisons of results with experimental data such as optical spectra, X-ray and neutron diffraction spectra. The software infrastructure developed in this project, as applied to various investigations of solids, liquids and interfaces, demonstrates that FPMD simulations can provide a detailed, atomic-scale picture of structural, vibrational and electronic properties of complex

  12. Statistical errors in molecular dynamics averages

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Schiferl, S.K.; Wallace, D.C.

    1985-11-15

    A molecular dynamics calculation produces a time-dependent fluctuating signal whose average is a thermodynamic quantity of interest. The average of the kinetic energy, for example, is proportional to the temperature. A procedure is described for determining when the molecular dynamics system is in equilibrium with respect to a given variable, according to the condition that the mean and the bandwidth of the signal should be sensibly constant in time. Confidence limits for the mean are obtained from an analysis of a finite length of the equilibrium signal. The role of serial correlation in this analysis is discussed. The occurence ofmore » unstable behavior in molecular dynamics data is noted, and a statistical test for a level shift is described.« less

  13. Molecular dynamics simulations of large macromolecular complexes.

    PubMed

    Perilla, Juan R; Goh, Boon Chong; Cassidy, C Keith; Liu, Bo; Bernardi, Rafael C; Rudack, Till; Yu, Hang; Wu, Zhe; Schulten, Klaus

    2015-04-01

    Connecting dynamics to structural data from diverse experimental sources, molecular dynamics simulations permit the exploration of biological phenomena in unparalleled detail. Advances in simulations are moving the atomic resolution descriptions of biological systems into the million-to-billion atom regime, in which numerous cell functions reside. In this opinion, we review the progress, driven by large-scale molecular dynamics simulations, in the study of viruses, ribosomes, bioenergetic systems, and other diverse applications. These examples highlight the utility of molecular dynamics simulations in the critical task of relating atomic detail to the function of supramolecular complexes, a task that cannot be achieved by smaller-scale simulations or existing experimental approaches alone. Copyright © 2015 Elsevier Ltd. All rights reserved.

  14. Next Generation Extended Lagrangian Quantum-based Molecular Dynamics

    NASA Astrophysics Data System (ADS)

    Negre, Christian

    2017-06-01

    A new framework for extended Lagrangian first-principles molecular dynamics simulations is presented, which overcomes shortcomings of regular, direct Born-Oppenheimer molecular dynamics, while maintaining important advantages of the unified extended Lagrangian formulation of density functional theory pioneered by Car and Parrinello three decades ago. The new framework allows, for the first time, energy conserving, linear-scaling Born-Oppenheimer molecular dynamics simulations, which is necessary to study larger and more realistic systems over longer simulation times than previously possible. Expensive, self-consinstent-field optimizations are avoided and normal integration time steps of regular, direct Born-Oppenheimer molecular dynamics can be used. Linear scaling electronic structure theory is presented using a graph-based approach that is ideal for parallel calculations on hybrid computer platforms. For the first time, quantum based Born-Oppenheimer molecular dynamics simulation is becoming a practically feasible approach in simulations of +100,000 atoms-representing a competitive alternative to classical polarizable force field methods. In collaboration with: Anders Niklasson, Los Alamos National Laboratory.

  15. Molecular dynamics simulations: advances and applications

    PubMed Central

    Hospital, Adam; Goñi, Josep Ramon; Orozco, Modesto; Gelpí, Josep L

    2015-01-01

    Molecular dynamics simulations have evolved into a mature technique that can be used effectively to understand macromolecular structure-to-function relationships. Present simulation times are close to biologically relevant ones. Information gathered about the dynamic properties of macromolecules is rich enough to shift the usual paradigm of structural bioinformatics from studying single structures to analyze conformational ensembles. Here, we describe the foundations of molecular dynamics and the improvements made in the direction of getting such ensemble. Specific application of the technique to three main issues (allosteric regulation, docking, and structure refinement) is discussed. PMID:26604800

  16. Dynamic divisive normalization predicts time-varying value coding in decision-related circuits.

    PubMed

    Louie, Kenway; LoFaro, Thomas; Webb, Ryan; Glimcher, Paul W

    2014-11-26

    Normalization is a widespread neural computation, mediating divisive gain control in sensory processing and implementing a context-dependent value code in decision-related frontal and parietal cortices. Although decision-making is a dynamic process with complex temporal characteristics, most models of normalization are time-independent and little is known about the dynamic interaction of normalization and choice. Here, we show that a simple differential equation model of normalization explains the characteristic phasic-sustained pattern of cortical decision activity and predicts specific normalization dynamics: value coding during initial transients, time-varying value modulation, and delayed onset of contextual information. Empirically, we observe these predicted dynamics in saccade-related neurons in monkey lateral intraparietal cortex. Furthermore, such models naturally incorporate a time-weighted average of past activity, implementing an intrinsic reference-dependence in value coding. These results suggest that a single network mechanism can explain both transient and sustained decision activity, emphasizing the importance of a dynamic view of normalization in neural coding. Copyright © 2014 the authors 0270-6474/14/3416046-12$15.00/0.

  17. A molecular dynamics implementation of the 3D Mercedes-Benz water model

    NASA Astrophysics Data System (ADS)

    Hynninen, T.; Dias, C. L.; Mkrtchyan, A.; Heinonen, V.; Karttunen, M.; Foster, A. S.; Ala-Nissila, T.

    2012-02-01

    The three-dimensional Mercedes-Benz model was recently introduced to account for the structural and thermodynamic properties of water. It treats water molecules as point-like particles with four dangling bonds in tetrahedral coordination, representing H-bonds of water. Its conceptual simplicity renders the model attractive in studies where complex behaviors emerge from H-bond interactions in water, e.g., the hydrophobic effect. A molecular dynamics (MD) implementation of the model is non-trivial and we outline here the mathematical framework of its force-field. Useful routines written in modern Fortran are also provided. This open source code is free and can easily be modified to account for different physical context. The provided code allows both serial and MPI-parallelized execution. Program summaryProgram title: CASHEW (Coarse Approach Simulator for Hydrogen-bonding Effects in Water) Catalogue identifier: AEKM_v1_0 Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEKM_v1_0.html Program obtainable from: CPC Program Library, Queen's University, Belfast, N. Ireland Licensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.html No. of lines in distributed program, including test data, etc.: 20 501 No. of bytes in distributed program, including test data, etc.: 551 044 Distribution format: tar.gz Programming language: Fortran 90 Computer: Program has been tested on desktop workstations and a Cray XT4/XT5 supercomputer. Operating system: Linux, Unix, OS X Has the code been vectorized or parallelized?: The code has been parallelized using MPI. RAM: Depends on size of system, about 5 MB for 1500 molecules. Classification: 7.7 External routines: A random number generator, Mersenne Twister ( http://www.math.sci.hiroshima-u.ac.jp/m-mat/MT/VERSIONS/FORTRAN/mt95.f90), is used. A copy of the code is included in the distribution. Nature of problem: Molecular dynamics simulation of a new geometric water model. Solution method: New force-field for

  18. Modeling and Bio molecular Self-assembly via Molecular Dynamics and Dissipative Particle Dynamics

    NASA Astrophysics Data System (ADS)

    Rakesh, L.

    2009-09-01

    Surfactants like materials can be used to increase the solubility of poorly soluble drugs in water and to increase drug bioavailability. A typical case study will be demonstrated using DPD simulation to model the distribution of anti-inflammatory drug molecules. Computer simulation is a convenient approach to understand drug distribution and solubility concepts without much wastage and costly experiments in the laboratory. Often in molecular dynamics (MD) the atoms are represented explicitly and the equation of motion as described by Newtonian dynamics is integrated explicitly. MD has been used to study spontaneous formation of micelles by hydrophobic molecules with amphiphilic head groups in bulk water, as well as stability of pre-configured micelles and membranes. DPD is a state-of the- art mesoscale simulation, it is a more recent molecular dynamics technique, originally developed for simulating complex fluids but lately also applied to membrane dynamics, hemodynamic in biomedical applications. Such fluids pervade industrial research from paints to pharmaceuticals and from cosmetics to the controlled release of drugs. Dissipative particle dynamics (DPD) can provide structural and dynamic properties of fluids in equilibrium, under shear or confined to narrow cavities, at length- and time-scales beyond the scope of traditional atomistic molecular dynamics simulation methods. Mesoscopic particles are used to represent clusters of molecules. The interaction conserves mass and momentum and as a consequence the dynamics is consistent with Navier-Stokes equations. In addition to the conservative forces, stochastic drive and dissipation is introduced to represent internal degrees of freedom in the mesoscopic particles. In this research, an initial study is being conducted using the aqueous solubilization of the nonsteroidal, anti-inflammatory drug is studied theoretically in micellar solution of nonionic (dodecyl hexa(ethylene oxide), C12E6) surfactants possessing the

  19. Jdpd: an open java simulation kernel for molecular fragment dissipative particle dynamics.

    PubMed

    van den Broek, Karina; Kuhn, Hubert; Zielesny, Achim

    2018-05-21

    Jdpd is an open Java simulation kernel for Molecular Fragment Dissipative Particle Dynamics with parallelizable force calculation, efficient caching options and fast property calculations. It is characterized by an interface and factory-pattern driven design for simple code changes and may help to avoid problems of polyglot programming. Detailed input/output communication, parallelization and process control as well as internal logging capabilities for debugging purposes are supported. The new kernel may be utilized in different simulation environments ranging from flexible scripting solutions up to fully integrated "all-in-one" simulation systems.

  20. Chroma sampling and modulation techniques in high dynamic range video coding

    NASA Astrophysics Data System (ADS)

    Dai, Wei; Krishnan, Madhu; Topiwala, Pankaj

    2015-09-01

    High Dynamic Range and Wide Color Gamut (HDR/WCG) Video Coding is an area of intense research interest in the engineering community, for potential near-term deployment in the marketplace. HDR greatly enhances the dynamic range of video content (up to 10,000 nits), as well as broadens the chroma representation (BT.2020). The resulting content offers new challenges in its coding and transmission. The Moving Picture Experts Group (MPEG) of the International Standards Organization (ISO) is currently exploring coding efficiency and/or the functionality enhancements of the recently developed HEVC video standard for HDR and WCG content. FastVDO has developed an advanced approach to coding HDR video, based on splitting the HDR signal into a smoothed luminance (SL) signal, and an associated base signal (B). Both signals are then chroma downsampled to YFbFr 4:2:0 signals, using advanced resampling filters, and coded using the Main10 High Efficiency Video Coding (HEVC) standard, which has been developed jointly by ISO/IEC MPEG and ITU-T WP3/16 (VCEG). Our proposal offers both efficient coding, and backwards compatibility with the existing HEVC Main10 Profile. That is, an existing Main10 decoder can produce a viewable standard dynamic range video, suitable for existing screens. Subjective tests show visible improvement over the anchors. Objective tests show a sizable gain of over 25% in PSNR (RGB domain) on average, for a key set of test clips selected by the ISO/MPEG committee.

  1. Molecular dynamics in principal component space.

    PubMed

    Michielssens, Servaas; van Erp, Titus S; Kutzner, Carsten; Ceulemans, Arnout; de Groot, Bert L

    2012-07-26

    A molecular dynamics algorithm in principal component space is presented. It is demonstrated that sampling can be improved without changing the ensemble by assigning masses to the principal components proportional to the inverse square root of the eigenvalues. The setup of the simulation requires no prior knowledge of the system; a short initial MD simulation to extract the eigenvectors and eigenvalues suffices. Independent measures indicated a 6-7 times faster sampling compared to a regular molecular dynamics simulation.

  2. The structural properties of PbF2 by molecular dynamics

    NASA Astrophysics Data System (ADS)

    Chergui, Y.; Nehaoua, N.; Telghemti, B.; Guemid, S.; Deraddji, N. E.; Belkhir, H.; Mekki, D. E.

    2010-08-01

    This work presents the use of molecular dynamics (MD) and the code of Dl_Poly, in order to study the structure of fluoride glass after melting and quenching. We are realized the processing phase liquid-phase, simulating rapid quenching at different speeds to see the effect of quenching rate on the operation of the devitrification. This technique of simulation has become a powerful tool for investigating the microscopic behaviour of matter as well as for calculating macroscopic observable quantities. As basic results, we calculated the interatomic distance, angles and statistics, which help us to know the geometric form and the structure of PbF2. These results are in experimental agreement to those reported in literature.

  3. Extended Lagrangian Excited State Molecular Dynamics.

    PubMed

    Bjorgaard, J A; Sheppard, D; Tretiak, S; Niklasson, A M N

    2018-02-13

    An extended Lagrangian framework for excited state molecular dynamics (XL-ESMD) using time-dependent self-consistent field theory is proposed. The formulation is a generalization of the extended Lagrangian formulations for ground state Born-Oppenheimer molecular dynamics [Phys. Rev. Lett. 2008 100, 123004]. The theory is implemented, demonstrated, and evaluated using a time-dependent semiempirical model, though it should be generally applicable to ab initio theory. The simulations show enhanced energy stability and a significantly reduced computational cost associated with the iterative solutions of both the ground state and the electronically excited states. Relaxed convergence criteria can therefore be used both for the self-consistent ground state optimization and for the iterative subspace diagonalization of the random phase approximation matrix used to calculate the excited state transitions. The XL-ESMD approach is expected to enable numerically efficient excited state molecular dynamics for such methods as time-dependent Hartree-Fock (TD-HF), Configuration Interactions Singles (CIS), and time-dependent density functional theory (TD-DFT).

  4. Molecular dynamics simulations of substitutional diffusion

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Zhou, Xiaowang; Jones, Reese E.; Gruber, Jacob

    2016-12-18

    In atomistic simulations, diffusion energy barriers are usually calculated for each atomic jump path using a nudged elastic band method. Practical materials often involve thousands of distinct atomic jump paths that are not known a priori. Hence, it is often preferred to determine an overall diffusion energy barrier and an overall pre-exponential factor from the Arrhenius equation constructed through molecular dynamics simulations of mean square displacement of the diffusion species at different temperatures. This approach has been well established for interstitial diffusion, but not for substitutional diffusion at the same confidence. Using In 0.1 Ga 0.9 N as an example,more » we have identified conditions where molecular dynamics simulations can be used to calculate highly converged Arrhenius plots for substitutional alloys. As a result, this may enable many complex diffusion problems to be easily and reliably studied in the future using molecular dynamics, provided that moderate computing resources are available.« less

  5. Retrieving the Molecular Composition of Planet-Forming Material: An Accurate Non-LTE Radiative Transfer Code for JWST

    NASA Astrophysics Data System (ADS)

    Pontoppidan, Klaus

    Based on the observed distributions of exoplanets and dynamical models of their evolution, the primary planet-forming regions of protoplanetary disks are thought to span distances of 1-20 AU from typical stars. A key observational challenge of the next decade will be to understand the links between the formation of planets in protoplanetary disks and the chemical composition of exoplanets. Potentially habitable planets in particular are likely formed by solids growing within radii of a few AU, augmented by unknown contributions from volatiles formed at larger radii of 10-50 AU. The basic chemical composition of these inner disk regions is characterized by near- to far-infrared (2-200 micron) emission lines from molecular gas at temperatures of 50-1500 K. A critical step toward measuring the chemical composition of planet-forming regions is therefore to convert observed infrared molecular line fluxes, profiles and images to gas temperatures, densities and molecular abundances. However, current techniques typically employ approximate radiative transfer methods and assumptions of local thermodynamic equilibrium (LTE) to retrieve abundances, leading to uncertainties of orders of magnitude and inconclusive comparisons to chemical models. Ultimately, the scientific impact of the high quality spectroscopic data expected from the James Webb Space Telescope (JWST) will be limited by the availability of radiative transfer tools for infrared molecular lines. We propose to develop a numerically accurate, non-LTE 3D line radiative transfer code, needed to interpret mid-infrared molecular line observations of protoplanetary and debris disks in preparation for the James Webb Space Telescope (JWST). This will be accomplished by adding critical functionality to the existing Monte Carlo code LIME, which was originally developed to support (sub)millimeter interferometric observations. In contrast to existing infrared codes, LIME calculates the exact statistical balance of arbitrary

  6. Hydrocode and Molecular Dynamics modelling of uniaxial shock wave experiments on Silicon

    NASA Astrophysics Data System (ADS)

    Stubley, Paul; McGonegle, David; Patel, Shamim; Suggit, Matthew; Wark, Justin; Higginbotham, Andrew; Comley, Andrew; Foster, John; Rothman, Steve; Eggert, Jon; Kalantar, Dan; Smith, Ray

    2015-06-01

    Recent experiments have provided further evidence that the response of silicon to shock compression has anomalous properties, not described by the usual two-wave elastic-plastic response. A recent experimental campaign on the Orion laser in particular has indicated a complex multi-wave response. While Molecular Dynamics (MD) simulations can offer a detailed insight into the response of crystals to uniaxial compression, they are extremely computationally expensive. For this reason, we are adapting a simple quasi-2D hydrodynamics code to capture phase change under uniaxial compression, and the intervening mixed phase region, keeping track of the stresses and strains in each of the phases. This strain information is of such importance because a large number of shock experiments use diffraction as a key diagnostic, and these diffraction patterns depend solely on the elastic strains in the sample. We present here a comparison of the new hydrodynamics code with MD simulations, and show that the simulated diffraction taken from the code agrees qualitatively with measured diffraction from our recent Orion campaign.

  7. Simulation of spacecraft attitude dynamics using TREETOPS and model-specific computer Codes

    NASA Technical Reports Server (NTRS)

    Cochran, John E.; No, T. S.; Fitz-Coy, Norman G.

    1989-01-01

    The simulation of spacecraft attitude dynamics and control using the generic, multi-body code called TREETOPS and other codes written especially to simulate particular systems is discussed. Differences in the methods used to derive equations of motion--Kane's method for TREETOPS and the Lagrangian and Newton-Euler methods, respectively, for the other two codes--are considered. Simulation results from the TREETOPS code are compared with those from the other two codes for two example systems. One system is a chain of rigid bodies; the other consists of two rigid bodies attached to a flexible base body. Since the computer codes were developed independently, consistent results serve as a verification of the correctness of all the programs. Differences in the results are discussed. Results for the two-rigid-body, one-flexible-body system are useful also as information on multi-body, flexible, pointing payload dynamics.

  8. Visualizing Energy on Target: Molecular Dynamics Simulations

    DTIC Science & Technology

    2017-12-01

    ARL-TR-8234 ● DEC 2017 US Army Research Laboratory Visualizing Energy on Target: Molecular Dynamics Simulations by DeCarlos E...return it to the originator. ARL-TR-8234● DEC 2017 US Army Research Laboratory Visualizing Energy on Target: Molecular Dynamics...REPORT TYPE Technical Report 3. DATES COVERED (From - To) 1 October 2015–30 September 2016 4. TITLE AND SUBTITLE Visualizing Energy on Target

  9. Nonadiabatic electron wavepacket dynamics behind molecular autoionization

    NASA Astrophysics Data System (ADS)

    Matsuoka, Takahide; Takatsuka, Kazuo

    2018-01-01

    A theoretical method for real-time dynamics of nonadiabatic reorganization of electronic configurations in molecules is developed, with dual aim that the intramolecular electron dynamics can be probed by means of direct and/or indirect photoionizations and that the physical origins behind photoionization signals attained in the time domain can be identified in terms of the language of time-dependent quantum chemistry. In doing so, we first formulate and implement a new computational scheme for nonadiabatic electron dynamics associated with molecular ionization, which well fits in the general theory of nonadiabatic electron dynamics. In this method, the total nonadiabatic electron wavepackets are propagated in time directly with complex natural orbitals without referring to Hartree-Fock molecular orbitals, and the amount of electron flux from a molecular region leading to ionization is evaluated in terms of the relevant complex natural orbitals. In the second half of this paper, we apply the method to electron dynamics in the elementary processes consisting of the Auger decay to demonstrate the methodological significance. An illustrative example is taken from an Auger decay starting from the 2a1 orbital hole-state of H2O+. The roles of nuclear momentum (kinetic) couplings in electronic-state mixing during the decay process are analyzed in terms of complex natural orbitals, which are schematically represented in the conventional language of molecular symmetry of the Hartree-Fock orbitals.

  10. Source Authentication for Code Dissemination Supporting Dynamic Packet Size in Wireless Sensor Networks.

    PubMed

    Kim, Daehee; Kim, Dongwan; An, Sunshin

    2016-07-09

    Code dissemination in wireless sensor networks (WSNs) is a procedure for distributing a new code image over the air in order to update programs. Due to the fact that WSNs are mostly deployed in unattended and hostile environments, secure code dissemination ensuring authenticity and integrity is essential. Recent works on dynamic packet size control in WSNs allow enhancing the energy efficiency of code dissemination by dynamically changing the packet size on the basis of link quality. However, the authentication tokens attached by the base station become useless in the next hop where the packet size can vary according to the link quality of the next hop. In this paper, we propose three source authentication schemes for code dissemination supporting dynamic packet size. Compared to traditional source authentication schemes such as μTESLA and digital signatures, our schemes provide secure source authentication under the environment, where the packet size changes in each hop, with smaller energy consumption.

  11. Biological evaluation, docking and molecular dynamic simulation of some novel diaryl urea derivatives bearing quinoxalindione moiety

    PubMed Central

    Sadeghian-Rizi, Sedighe; Khodarahmi, Ghadamali Ali; Sakhteman, Amirhossein; Jahanian-Najafabadi, Ali; Rostami, Mahboubeh; Mirzaei, Mahmoud; Hassanzadeh, Farshid

    2017-01-01

    In this study a series of diarylurea derivatives containing quinoxalindione group were biologically evaluated for their cytotoxic activities using MTT assay against MCF-7 and HepG2 cell lines. Antibacterial activities of these compounds were also evaluated by Microplate Alamar Blue Assay (MABA) against three Gram-negative (Escherichia coli, Pseudomonas aeruginosa and Salmonella typhi), three Gram-positive (Staphylococcus aureus, Bacillus subtilis and Listeria monocitogenes) and one yeast-like fungus (Candida albicans) strain. Furthermore, molecular docking was carried out to study the binding pattern of the compounds to the active site of B-RAF kinase (PDB code: 1UWH). Molecular dynamics simulation was performed on the best ligand (16e) to investigate the ligand binding dynamics in the physiological environment. Cytotoxic evaluation revealed the most prominent cytotoxicity for 6 compounds with IC50 values of 10-18 μM against two mentioned cell lines. None of the synthesized compounds showed significant antimicrobial activity. The obtained results of the molecular docking study showed that all compounds fitted in the binding site of enzyme with binding energy range of -11.22 to -12.69 kcal/mol vs sorafenib binding energy -11.74 kcal/mol as the lead compound. Molecular dynamic simulation indicated that the binding of ligand (16e) was stable in the active site of B-RAF during the simulation. PMID:29204178

  12. How Dynamic Visualization Technology Can Support Molecular Reasoning

    ERIC Educational Resources Information Center

    Levy, Dalit

    2013-01-01

    This paper reports the results of a study aimed at exploring the advantages of dynamic visualization for the development of better understanding of molecular processes. We designed a technology-enhanced curriculum module in which high school chemistry students conduct virtual experiments with dynamic molecular visualizations of solid, liquid, and…

  13. Properties of a certain stochastic dynamical system, channel polarization, and polar codes

    NASA Astrophysics Data System (ADS)

    Tanaka, Toshiyuki

    2010-06-01

    A new family of codes, called polar codes, has recently been proposed by Arikan. Polar codes are of theoretical importance because they are provably capacity achieving with low-complexity encoding and decoding. We first discuss basic properties of a certain stochastic dynamical system, on the basis of which properties of channel polarization and polar codes are reviewed, with emphasis on our recent results.

  14. Molecular Dynamics Simulations of Simple Liquids

    ERIC Educational Resources Information Center

    Speer, Owner F.; Wengerter, Brian C.; Taylor, Ramona S.

    2004-01-01

    An experiment, in which students were given the opportunity to perform molecular dynamics simulations on a series of molecular liquids using the Amber suite of programs, is presented. They were introduced to both physical theories underlying classical mechanics simulations and to the atom-atom pair distribution function.

  15. How Dynamic Visualization Technology can Support Molecular Reasoning

    NASA Astrophysics Data System (ADS)

    Levy, Dalit

    2013-10-01

    This paper reports the results of a study aimed at exploring the advantages of dynamic visualization for the development of better understanding of molecular processes. We designed a technology-enhanced curriculum module in which high school chemistry students conduct virtual experiments with dynamic molecular visualizations of solid, liquid, and gas. They interact with the visualizations and carry out inquiry activities to make and refine connections between observable phenomena and atomic level processes related to phase change. The explanations proposed by 300 pairs of students in response to pre/post-assessment items have been analyzed using a scale for measuring the level of molecular reasoning. Results indicate that from pretest to posttest, students make progress in their level of molecular reasoning and are better able to connect intermolecular forces and phase change in their explanations. The paper presents the results through the lens of improvement patterns and the metaphor of the "ladder of molecular reasoning," and discusses how this adds to our understanding of the benefits of interacting with dynamic molecular visualizations.

  16. Working research codes into fluid dynamics education: a science gateway approach

    NASA Astrophysics Data System (ADS)

    Mason, Lachlan; Hetherington, James; O'Reilly, Martin; Yong, May; Jersakova, Radka; Grieve, Stuart; Perez-Suarez, David; Klapaukh, Roman; Craster, Richard V.; Matar, Omar K.

    2017-11-01

    Research codes are effective for illustrating complex concepts in educational fluid dynamics courses, compared to textbook examples, an interactive three-dimensional visualisation can bring a problem to life! Various barriers, however, prevent the adoption of research codes in teaching: codes are typically created for highly-specific `once-off' calculations and, as such, have no user interface and a steep learning curve. Moreover, a code may require access to high-performance computing resources that are not readily available in the classroom. This project allows academics to rapidly work research codes into their teaching via a minimalist `science gateway' framework. The gateway is a simple, yet flexible, web interface allowing students to construct and run simulations, as well as view and share their output. Behind the scenes, the common operations of job configuration, submission, monitoring and post-processing are customisable at the level of shell scripting. In this talk, we demonstrate the creation of an example teaching gateway connected to the Code BLUE fluid dynamics software. Student simulations can be run via a third-party cloud computing provider or a local high-performance cluster. EPSRC, UK, MEMPHIS program Grant (EP/K003976/1), RAEng Research Chair (OKM).

  17. Extended Lagrangian Excited State Molecular Dynamics

    DOE PAGES

    Bjorgaard, Josiah August; Sheppard, Daniel Glen; Tretiak, Sergei; ...

    2018-01-09

    In this work, an extended Lagrangian framework for excited state molecular dynamics (XL-ESMD) using time-dependent self-consistent field theory is proposed. The formulation is a generalization of the extended Lagrangian formulations for ground state Born–Oppenheimer molecular dynamics [Phys. Rev. Lett. 2008 100, 123004]. The theory is implemented, demonstrated, and evaluated using a time-dependent semiempirical model, though it should be generally applicable to ab initio theory. The simulations show enhanced energy stability and a significantly reduced computational cost associated with the iterative solutions of both the ground state and the electronically excited states. Relaxed convergence criteria can therefore be used both formore » the self-consistent ground state optimization and for the iterative subspace diagonalization of the random phase approximation matrix used to calculate the excited state transitions. In conclusion, the XL-ESMD approach is expected to enable numerically efficient excited state molecular dynamics for such methods as time-dependent Hartree–Fock (TD-HF), Configuration Interactions Singles (CIS), and time-dependent density functional theory (TD-DFT).« less

  18. Extended Lagrangian Excited State Molecular Dynamics

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Bjorgaard, Josiah August; Sheppard, Daniel Glen; Tretiak, Sergei

    In this work, an extended Lagrangian framework for excited state molecular dynamics (XL-ESMD) using time-dependent self-consistent field theory is proposed. The formulation is a generalization of the extended Lagrangian formulations for ground state Born–Oppenheimer molecular dynamics [Phys. Rev. Lett. 2008 100, 123004]. The theory is implemented, demonstrated, and evaluated using a time-dependent semiempirical model, though it should be generally applicable to ab initio theory. The simulations show enhanced energy stability and a significantly reduced computational cost associated with the iterative solutions of both the ground state and the electronically excited states. Relaxed convergence criteria can therefore be used both formore » the self-consistent ground state optimization and for the iterative subspace diagonalization of the random phase approximation matrix used to calculate the excited state transitions. In conclusion, the XL-ESMD approach is expected to enable numerically efficient excited state molecular dynamics for such methods as time-dependent Hartree–Fock (TD-HF), Configuration Interactions Singles (CIS), and time-dependent density functional theory (TD-DFT).« less

  19. COLLABORATIVE RESEARCH AND DEVELOPMENT (CR&D) Delivery Order 0059: Molecular Dynamics Modeling Support

    DTIC Science & Technology

    2008-03-01

    Molecular Dynamics Simulations 5 Theory: Equilibrium Molecular Dynamics Simulations 6 Theory: Non...Equilibrium Molecular Dynamics Simulations 8 Carbon Nanotube Simulations : Approach and results from equilibrium and non-equilibrium molecular dynamics ...touched from the perspective of molecular dynamics simulations . However, ordered systems such as “Carbon Nanotubes” have been investigated in terms

  20. Dynamics of Nanoscale Grain-Boundary Decohesion in Aluminum by Molecular-Dynamics Simulation

    NASA Technical Reports Server (NTRS)

    Yamakov, V.; Saether, E.; Phillips, D. R.; Glaessegen, E. H.

    2007-01-01

    The dynamics and energetics of intergranular crack growth along a flat grain boundary in aluminum is studied by a molecular-dynamics simulation model for crack propagation under steady-state conditions. Using the ability of the molecular-dynamics simulation to identify atoms involved in different atomistic mechanisms, it was possible to identify the energy contribution of different processes taking place during crack growth. The energy contributions were divided as: elastic energy, defined as the potential energy of the atoms in fcc crystallographic state; and plastically stored energy, the energy of stacking faults and twin boundaries; grain-boundary and surface energy. In addition, monitoring the amount of heat exchange with the molecular-dynamics thermostat gives the energy dissipated as heat in the system. The energetic analysis indicates that the majority of energy in a fast growing crack is dissipated as heat. This dissipation increases linearly at low speed, and faster than linear at speeds approaching 1/3 the Rayleigh wave speed when the crack tip becomes dynamically unstable producing periodic dislocation bursts until the crack is blunted.

  1. Molecular Dynamics Simulations and XAFS (MD-XAFS)

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Schenter, Gregory K.; Fulton, John L.

    2017-01-20

    MD-XAFS (Molecular Dynamics X-ray Adsorption Fine Structure) makes the connection between simulation techniques that generate an ensemble of molecular configurations and the direct signal observed from X-ray measurement.

  2. Molecular dynamics for dense matter

    NASA Astrophysics Data System (ADS)

    Maruyama, Toshiki; Watanabe, Gentaro; Chiba, Satoshi

    2012-08-01

    We review a molecular dynamics method for nucleon many-body systems called quantum molecular dynamics (QMD), and our studies using this method. These studies address the structure and the dynamics of nuclear matter relevant to neutron star crusts, supernova cores, and heavy-ion collisions. A key advantage of QMD is that we can study dynamical processes of nucleon many-body systems without any assumptions about the nuclear structure. First, we focus on the inhomogeneous structures of low-density nuclear matter consisting not only of spherical nuclei but also of nuclear "pasta", i.e., rod-like and slab-like nuclei. We show that pasta phases can appear in the ground and equilibrium states of nuclear matter without assuming nuclear shape. Next, we show our simulation of compression of nuclear matter which corresponds to the collapsing stage of supernovae. With the increase in density, a crystalline solid of spherical nuclei changes to a triangular lattice of rods by connecting neighboring nuclei. Finally, we discuss fragment formation in expanding nuclear matter. Our results suggest that a generally accepted scenario based on the liquid-gas phase transition is not plausible at lower temperatures.

  3. Enhanced Molecular Dynamics Methods Applied to Drug Design Projects.

    PubMed

    Ziada, Sonia; Braka, Abdennour; Diharce, Julien; Aci-Sèche, Samia; Bonnet, Pascal

    2018-01-01

    Nobel Laureate Richard P. Feynman stated: "[…] everything that living things do can be understood in terms of jiggling and wiggling of atoms […]." The importance of computer simulations of macromolecules, which use classical mechanics principles to describe atom behavior, is widely acknowledged and nowadays, they are applied in many fields such as material sciences and drug discovery. With the increase of computing power, molecular dynamics simulations can be applied to understand biological mechanisms at realistic timescales. In this chapter, we share our computational experience providing a global view of two of the widely used enhanced molecular dynamics methods to study protein structure and dynamics through the description of their characteristics, limits and we provide some examples of their applications in drug design. We also discuss the appropriate choice of software and hardware. In a detailed practical procedure, we describe how to set up, run, and analyze two main molecular dynamics methods, the umbrella sampling (US) and the accelerated molecular dynamics (aMD) methods.

  4. Detection of plasticity mechanisms in an energetic molecular crystal through shock-like 3D unidirectional compressions: A Molecular Dynamics study

    NASA Astrophysics Data System (ADS)

    Lafourcade, Paul; Denoual, Christophe; Maillet, Jean-Bernard

    2017-06-01

    TATB crystal structure consists in graphitic-like sheets arranged in the a-b plane where a, b and c define the edge vectors of the unit cell. This type of stacking provides the TATB monocrystal very anisotropic physical, chemical and mechanical properties. In order to explore which mechanisms are involved in TATB plasticity, we use a Molecular Dynamics code in which the overall deformation is prescribed as a function of time, for any deformation path. Furthermore, a computation of the Green-Lagrange strain tensor is proposed, which helps reveal various defects and plasticity mechanisms. Through prescribed large strain of shock-like deformations, a three-dimensional characterization of TATB monocrystal yield stress has been obtained, confirming the very anisotropic behavior of this energetic material. Various plasticity mechanisms are triggered during these simulations, including counter intuitive defects onset such as gliding along transveral planes containing perfect dislocations and twinning. Gliding in the a-b plane occurs systematically and does not lead to significant plastic behavior, in accordance with a previous study on dislocation core structures for this plane, based on a coupling between the Peierls-Nabarro-Galerkin method and Molecular Dynamics simulations.

  5. Control of Mechanotransduction by Molecular Clutch Dynamics.

    PubMed

    Elosegui-Artola, Alberto; Trepat, Xavier; Roca-Cusachs, Pere

    2018-05-01

    The linkage of cells to their microenvironment is mediated by a series of bonds that dynamically engage and disengage, in what has been conceptualized as the molecular clutch model. Whereas this model has long been employed to describe actin cytoskeleton and cell migration dynamics, it has recently been proposed to also explain mechanotransduction (i.e., the process by which cells convert mechanical signals from their environment into biochemical signals). Here we review the current understanding on how cell dynamics and mechanotransduction are driven by molecular clutch dynamics and its master regulator, the force loading rate. Throughout this Review, we place a specific emphasis on the quantitative prediction of cell response enabled by combined experimental and theoretical approaches. Copyright © 2018 Elsevier Ltd. All rights reserved.

  6. Water dynamics in protein hydration shells: the molecular origins of the dynamical perturbation.

    PubMed

    Fogarty, Aoife C; Laage, Damien

    2014-07-17

    Protein hydration shell dynamics play an important role in biochemical processes including protein folding, enzyme function, and molecular recognition. We present here a comparison of the reorientation dynamics of individual water molecules within the hydration shell of a series of globular proteins: acetylcholinesterase, subtilisin Carlsberg, lysozyme, and ubiquitin. Molecular dynamics simulations and analytical models are used to access site-resolved information on hydration shell dynamics and to elucidate the molecular origins of the dynamical perturbation of hydration shell water relative to bulk water. We show that all four proteins have very similar hydration shell dynamics, despite their wide range of sizes and functions, and differing secondary structures. We demonstrate that this arises from the similar local surface topology and surface chemical composition of the four proteins, and that such local factors alone are sufficient to rationalize the hydration shell dynamics. We propose that these conclusions can be generalized to a wide range of globular proteins. We also show that protein conformational fluctuations induce a dynamical heterogeneity within the hydration layer. We finally address the effect of confinement on hydration shell dynamics via a site-resolved analysis and connect our results to experiments via the calculation of two-dimensional infrared spectra.

  7. Water Dynamics in Protein Hydration Shells: The Molecular Origins of the Dynamical Perturbation

    PubMed Central

    2014-01-01

    Protein hydration shell dynamics play an important role in biochemical processes including protein folding, enzyme function, and molecular recognition. We present here a comparison of the reorientation dynamics of individual water molecules within the hydration shell of a series of globular proteins: acetylcholinesterase, subtilisin Carlsberg, lysozyme, and ubiquitin. Molecular dynamics simulations and analytical models are used to access site-resolved information on hydration shell dynamics and to elucidate the molecular origins of the dynamical perturbation of hydration shell water relative to bulk water. We show that all four proteins have very similar hydration shell dynamics, despite their wide range of sizes and functions, and differing secondary structures. We demonstrate that this arises from the similar local surface topology and surface chemical composition of the four proteins, and that such local factors alone are sufficient to rationalize the hydration shell dynamics. We propose that these conclusions can be generalized to a wide range of globular proteins. We also show that protein conformational fluctuations induce a dynamical heterogeneity within the hydration layer. We finally address the effect of confinement on hydration shell dynamics via a site-resolved analysis and connect our results to experiments via the calculation of two-dimensional infrared spectra. PMID:24479585

  8. Dynamic Alignment Models for Neural Coding

    PubMed Central

    Kollmorgen, Sepp; Hahnloser, Richard H. R.

    2014-01-01

    Recently, there have been remarkable advances in modeling the relationships between the sensory environment, neuronal responses, and behavior. However, most models cannot encompass variable stimulus-response relationships such as varying response latencies and state or context dependence of the neural code. Here, we consider response modeling as a dynamic alignment problem and model stimulus and response jointly by a mixed pair hidden Markov model (MPH). In MPHs, multiple stimulus-response relationships (e.g., receptive fields) are represented by different states or groups of states in a Markov chain. Each stimulus-response relationship features temporal flexibility, allowing modeling of variable response latencies, including noisy ones. We derive algorithms for learning of MPH parameters and for inference of spike response probabilities. We show that some linear-nonlinear Poisson cascade (LNP) models are a special case of MPHs. We demonstrate the efficiency and usefulness of MPHs in simulations of both jittered and switching spike responses to white noise and natural stimuli. Furthermore, we apply MPHs to extracellular single and multi-unit data recorded in cortical brain areas of singing birds to showcase a novel method for estimating response lag distributions. MPHs allow simultaneous estimation of receptive fields, latency statistics, and hidden state dynamics and so can help to uncover complex stimulus response relationships that are subject to variable timing and involve diverse neural codes. PMID:24625448

  9. Generalized Green's function molecular dynamics for canonical ensemble simulations

    NASA Astrophysics Data System (ADS)

    Coluci, V. R.; Dantas, S. O.; Tewary, V. K.

    2018-05-01

    The need of small integration time steps (˜1 fs) in conventional molecular dynamics simulations is an important issue that inhibits the study of physical, chemical, and biological systems in real timescales. Additionally, to simulate those systems in contact with a thermal bath, thermostating techniques are usually applied. In this work, we generalize the Green's function molecular dynamics technique to allow simulations within the canonical ensemble. By applying this technique to one-dimensional systems, we were able to correctly describe important thermodynamic properties such as the temperature fluctuations, the temperature distribution, and the velocity autocorrelation function. We show that the proposed technique also allows the use of time steps one order of magnitude larger than those typically used in conventional molecular dynamics simulations. We expect that this technique can be used in long-timescale molecular dynamics simulations.

  10. Single stock dynamics on high-frequency data: from a compressed coding perspective.

    PubMed

    Fushing, Hsieh; Chen, Shu-Chun; Hwang, Chii-Ruey

    2014-01-01

    High-frequency return, trading volume and transaction number are digitally coded via a nonparametric computing algorithm, called hierarchical factor segmentation (HFS), and then are coupled together to reveal a single stock dynamics without global state-space structural assumptions. The base-8 digital coding sequence, which is capable of revealing contrasting aggregation against sparsity of extreme events, is further compressed into a shortened sequence of state transitions. This compressed digital code sequence vividly demonstrates that the aggregation of large absolute returns is the primary driving force for stimulating both the aggregations of large trading volumes and transaction numbers. The state of system-wise synchrony is manifested with very frequent recurrence in the stock dynamics. And this data-driven dynamic mechanism is seen to correspondingly vary as the global market transiting in and out of contraction-expansion cycles. These results not only elaborate the stock dynamics of interest to a fuller extent, but also contradict some classical theories in finance. Overall this version of stock dynamics is potentially more coherent and realistic, especially when the current financial market is increasingly powered by high-frequency trading via computer algorithms, rather than by individual investors.

  11. Single Stock Dynamics on High-Frequency Data: From a Compressed Coding Perspective

    PubMed Central

    Fushing, Hsieh; Chen, Shu-Chun; Hwang, Chii-Ruey

    2014-01-01

    High-frequency return, trading volume and transaction number are digitally coded via a nonparametric computing algorithm, called hierarchical factor segmentation (HFS), and then are coupled together to reveal a single stock dynamics without global state-space structural assumptions. The base-8 digital coding sequence, which is capable of revealing contrasting aggregation against sparsity of extreme events, is further compressed into a shortened sequence of state transitions. This compressed digital code sequence vividly demonstrates that the aggregation of large absolute returns is the primary driving force for stimulating both the aggregations of large trading volumes and transaction numbers. The state of system-wise synchrony is manifested with very frequent recurrence in the stock dynamics. And this data-driven dynamic mechanism is seen to correspondingly vary as the global market transiting in and out of contraction-expansion cycles. These results not only elaborate the stock dynamics of interest to a fuller extent, but also contradict some classical theories in finance. Overall this version of stock dynamics is potentially more coherent and realistic, especially when the current financial market is increasingly powered by high-frequency trading via computer algorithms, rather than by individual investors. PMID:24586235

  12. Sandia National Laboratories environmental fluid dynamics code. Marine Hydrokinetic Module User's Manual

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    James, Scott Carlton; Roberts, Jesse D.

    2014-03-01

    This document describes the marine hydrokinetic (MHK) input file and subroutines for the Sandia National Laboratories Environmental Fluid Dynamics Code (SNL-EFDC), which is a combined hydrodynamic, sediment transport, and water quality model based on the Environmental Fluid Dynamics Code (EFDC) developed by John Hamrick [1], formerly sponsored by the U.S. Environmental Protection Agency, and now maintained by Tetra Tech, Inc. SNL-EFDC has been previously enhanced with the incorporation of the SEDZLJ sediment dynamics model developed by Ziegler, Lick, and Jones [2-4]. SNL-EFDC has also been upgraded to more accurately simulate algae growth with specific application to optimizing biomass in anmore » open-channel raceway for biofuels production [5]. A detailed description of the input file containing data describing the MHK device/array is provided, along with a description of the MHK FORTRAN routine. Both a theoretical description of the MHK dynamics as incorporated into SNL-EFDC and an explanation of the source code are provided. This user manual is meant to be used in conjunction with the original EFDC [6] and sediment dynamics SNL-EFDC manuals [7]. Through this document, the authors provide information for users who wish to model the effects of an MHK device (or array of devices) on a flow system with EFDC and who also seek a clear understanding of the source code, which is available from staff in the Water Power Technologies Department at Sandia National Laboratories, Albuquerque, New Mexico.« less

  13. Molecular Dynamics Simulations of Supramolecular Anticancer Nanotubes.

    PubMed

    Kang, Myungshim; Chakraborty, Kaushik; Loverde, Sharon M

    2018-06-25

    We report here on long-time all-atomistic molecular dynamics simulations of functional supramolecular nanotubes composed by the self-assembly of peptide-drug amphiphiles (DAs). These DAs have been shown to possess an inherently high drug loading of the hydrophobic anticancer drug camptothecin. We probe the self-assembly mechanism from random with ∼0.4 μs molecular dynamics simulations. Furthermore, we also computationally characterize the interfacial structure, directionality of π-π stacking, and water dynamics within several peptide-drug nanotubes with diameters consistent with the reported experimental nanotube diameter. Insight gained should inform the future design of these novel anticancer drug delivery systems.

  14. Simulation studies using multibody dynamics code DART

    NASA Technical Reports Server (NTRS)

    Keat, James E.

    1989-01-01

    DART is a multibody dynamics code developed by Photon Research Associates for the Air Force Astronautics Laboratory (AFAL). The code is intended primarily to simulate the dynamics of large space structures, particularly during the deployment phase of their missions. DART integrates nonlinear equations of motion numerically. The number of bodies in the system being simulated is arbitrary. The bodies' interconnection joints can have an arbitrary number of degrees of freedom between 0 and 6. Motions across the joints can be large. Provision for simulating on-board control systems is provided. Conservation of energy and momentum, when applicable, are used to evaluate DART's performance. After a brief description of DART, studies made to test the program prior to its delivery to AFAL are described. The first is a large angle reorientating of a flexible spacecraft consisting of a rigid central hub and four flexible booms. Reorientation was accomplished by a single-cycle sine wave shape torque input. In the second study, an appendage, mounted on a spacecraft, was slewed through a large angle. Four closed-loop control systems provided control of this appendage and of the spacecraft's attitude. The third study simulated the deployment of the rim of a bicycle wheel configuration large space structure. This system contained 18 bodies. An interesting and unexpected feature of the dynamics was a pulsing phenomena experienced by the stays whole playout was used to control the deployment. A short description of the current status of DART is given.

  15. Membrane Insertion Profiles of Peptides Probed by Molecular Dynamics Simulations

    DTIC Science & Technology

    2008-07-17

    Membrane insertion profiles of peptides probed by molecular dynamics simulations In-Chul Yeh,* Mark A. Olson,# Michael S. Lee,*#§ and Anders...a methodology based on molecular dynamics simulation techniques to probe the insertion profiles of small peptides across the membrane interface. The...profiles of peptides probed by molecular dynamics simulations 5a. CONTRACT NUMBER 5b. GRANT NUMBER 5c. PROGRAM ELEMENT NUMBER 6. AUTHOR(S) 5d

  16. Revisiting Molecular Dynamics on a CPU/GPU system: Water Kernel and SHAKE Parallelization.

    PubMed

    Ruymgaart, A Peter; Elber, Ron

    2012-11-13

    We report Graphics Processing Unit (GPU) and Open-MP parallel implementations of water-specific force calculations and of bond constraints for use in Molecular Dynamics simulations. We focus on a typical laboratory computing-environment in which a CPU with a few cores is attached to a GPU. We discuss in detail the design of the code and we illustrate performance comparable to highly optimized codes such as GROMACS. Beside speed our code shows excellent energy conservation. Utilization of water-specific lists allows the efficient calculations of non-bonded interactions that include water molecules and results in a speed-up factor of more than 40 on the GPU compared to code optimized on a single CPU core for systems larger than 20,000 atoms. This is up four-fold from a factor of 10 reported in our initial GPU implementation that did not include a water-specific code. Another optimization is the implementation of constrained dynamics entirely on the GPU. The routine, which enforces constraints of all bonds, runs in parallel on multiple Open-MP cores or entirely on the GPU. It is based on Conjugate Gradient solution of the Lagrange multipliers (CG SHAKE). The GPU implementation is partially in double precision and requires no communication with the CPU during the execution of the SHAKE algorithm. The (parallel) implementation of SHAKE allows an increase of the time step to 2.0fs while maintaining excellent energy conservation. Interestingly, CG SHAKE is faster than the usual bond relaxation algorithm even on a single core if high accuracy is expected. The significant speedup of the optimized components transfers the computational bottleneck of the MD calculation to the reciprocal part of Particle Mesh Ewald (PME).

  17. Source Authentication for Code Dissemination Supporting Dynamic Packet Size in Wireless Sensor Networks †

    PubMed Central

    Kim, Daehee; Kim, Dongwan; An, Sunshin

    2016-01-01

    Code dissemination in wireless sensor networks (WSNs) is a procedure for distributing a new code image over the air in order to update programs. Due to the fact that WSNs are mostly deployed in unattended and hostile environments, secure code dissemination ensuring authenticity and integrity is essential. Recent works on dynamic packet size control in WSNs allow enhancing the energy efficiency of code dissemination by dynamically changing the packet size on the basis of link quality. However, the authentication tokens attached by the base station become useless in the next hop where the packet size can vary according to the link quality of the next hop. In this paper, we propose three source authentication schemes for code dissemination supporting dynamic packet size. Compared to traditional source authentication schemes such as μTESLA and digital signatures, our schemes provide secure source authentication under the environment, where the packet size changes in each hop, with smaller energy consumption. PMID:27409616

  18. Molecular Dynamics Analysis of Lysozyme Protein in Ethanol-Water Mixed Solvent Environment

    NASA Astrophysics Data System (ADS)

    Ochije, Henry Ikechukwu

    Effect of protein-solvent interaction on the protein structure is widely studied using both experimental and computational techniques. Despite such extensive studies molecular level understanding of proteins and some simple solvents is still not fully understood. This work focuses on detailed molecular dynamics simulations to study of solvent effect on lysozyme protein, using water, alcohol and different concentrations of water-alcohol mixtures as solvents. The lysozyme protein structure in water, alcohol and alcohol-water mixture (0-12% alcohol) was studied using GROMACS molecular dynamics simulation code. Compared to water environment, the lysozome structure showed remarkable changes in solvents with increasing alcohol concentration. In particular, significant changes were observed in the protein secondary structure involving alpha helices. The influence of alcohol on the lysozyme protein was investigated by studying thermodynamic and structural properties. With increasing ethanol concentration we observed a systematic increase in total energy, enthalpy, root mean square deviation (RMSD), and radius of gyration. a polynomial interpolation approach. Using the resulting polynomial equation, we could determine above quantities for any intermediate alcohol percentage. In order to validate this approach, we selected an intermediate ethanol percentage and carried out full MD simulation. The results from MD simulation were in reasonably good agreement with that obtained using polynomial approach. Hence, the polynomial approach based method proposed here eliminates the need for computationally intensive full MD analysis for the concentrations within the range (0-12%) studied in this work.

  19. Clustering Molecular Dynamics Trajectories for Optimizing Docking Experiments

    PubMed Central

    De Paris, Renata; Quevedo, Christian V.; Ruiz, Duncan D.; Norberto de Souza, Osmar; Barros, Rodrigo C.

    2015-01-01

    Molecular dynamics simulations of protein receptors have become an attractive tool for rational drug discovery. However, the high computational cost of employing molecular dynamics trajectories in virtual screening of large repositories threats the feasibility of this task. Computational intelligence techniques have been applied in this context, with the ultimate goal of reducing the overall computational cost so the task can become feasible. Particularly, clustering algorithms have been widely used as a means to reduce the dimensionality of molecular dynamics trajectories. In this paper, we develop a novel methodology for clustering entire trajectories using structural features from the substrate-binding cavity of the receptor in order to optimize docking experiments on a cloud-based environment. The resulting partition was selected based on three clustering validity criteria, and it was further validated by analyzing the interactions between 20 ligands and a fully flexible receptor (FFR) model containing a 20 ns molecular dynamics simulation trajectory. Our proposed methodology shows that taking into account features of the substrate-binding cavity as input for the k-means algorithm is a promising technique for accurately selecting ensembles of representative structures tailored to a specific ligand. PMID:25873944

  20. Clustering molecular dynamics trajectories for optimizing docking experiments.

    PubMed

    De Paris, Renata; Quevedo, Christian V; Ruiz, Duncan D; Norberto de Souza, Osmar; Barros, Rodrigo C

    2015-01-01

    Molecular dynamics simulations of protein receptors have become an attractive tool for rational drug discovery. However, the high computational cost of employing molecular dynamics trajectories in virtual screening of large repositories threats the feasibility of this task. Computational intelligence techniques have been applied in this context, with the ultimate goal of reducing the overall computational cost so the task can become feasible. Particularly, clustering algorithms have been widely used as a means to reduce the dimensionality of molecular dynamics trajectories. In this paper, we develop a novel methodology for clustering entire trajectories using structural features from the substrate-binding cavity of the receptor in order to optimize docking experiments on a cloud-based environment. The resulting partition was selected based on three clustering validity criteria, and it was further validated by analyzing the interactions between 20 ligands and a fully flexible receptor (FFR) model containing a 20 ns molecular dynamics simulation trajectory. Our proposed methodology shows that taking into account features of the substrate-binding cavity as input for the k-means algorithm is a promising technique for accurately selecting ensembles of representative structures tailored to a specific ligand.

  1. The study on dynamic cadastral coding rules based on kinship relationship

    NASA Astrophysics Data System (ADS)

    Xu, Huan; Liu, Nan; Liu, Renyi; Lu, Jingfeng

    2007-06-01

    Cadastral coding rules are an important supplement to the existing national and local standard specifications for building cadastral database. After analyzing the course of cadastral change, especially the parcel change with the method of object-oriented analysis, a set of dynamic cadastral coding rules based on kinship relationship corresponding to the cadastral change is put forward and a coding format composed of street code, block code, father parcel code, child parcel code and grandchild parcel code is worked out within the county administrative area. The coding rule has been applied to the development of an urban cadastral information system called "ReGIS", which is not only able to figure out the cadastral code automatically according to both the type of parcel change and the coding rules, but also capable of checking out whether the code is spatiotemporally unique before the parcel is stored in the database. The system has been used in several cities of Zhejiang Province and got a favorable response. This verifies the feasibility and effectiveness of the coding rules to some extent.

  2. Random Matrix Theory in molecular dynamics analysis.

    PubMed

    Palese, Luigi Leonardo

    2015-01-01

    It is well known that, in some situations, principal component analysis (PCA) carried out on molecular dynamics data results in the appearance of cosine-shaped low index projections. Because this is reminiscent of the results obtained by performing PCA on a multidimensional Brownian dynamics, it has been suggested that short-time protein dynamics is essentially nothing more than a noisy signal. Here we use Random Matrix Theory to analyze a series of short-time molecular dynamics experiments which are specifically designed to be simulations with high cosine content. We use as a model system the protein apoCox17, a mitochondrial copper chaperone. Spectral analysis on correlation matrices allows to easily differentiate random correlations, simply deriving from the finite length of the process, from non-random signals reflecting the intrinsic system properties. Our results clearly show that protein dynamics is not really Brownian also in presence of the cosine-shaped low index projections on principal axes. Copyright © 2014 Elsevier B.V. All rights reserved.

  3. Molecular dynamics at low time resolution.

    PubMed

    Faccioli, P

    2010-10-28

    The internal dynamics of macromolecular systems is characterized by widely separated time scales, ranging from fraction of picoseconds to nanoseconds. In ordinary molecular dynamics simulations, the elementary time step Δt used to integrate the equation of motion needs to be chosen much smaller of the shortest time scale in order not to cut-off physical effects. We show that in systems obeying the overdamped Langevin equation, it is possible to systematically correct for such discretization errors. This is done by analytically averaging out the fast molecular dynamics which occurs at time scales smaller than Δt, using a renormalization group based technique. Such a procedure gives raise to a time-dependent calculable correction to the diffusion coefficient. The resulting effective Langevin equation describes by construction the same long-time dynamics, but has a lower time resolution power, hence it can be integrated using larger time steps Δt. We illustrate and validate this method by studying the diffusion of a point-particle in a one-dimensional toy model and the denaturation of a protein.

  4. Protocols for Molecular Dynamics Simulations of RNA Nanostructures.

    PubMed

    Kim, Taejin; Kasprzak, Wojciech K; Shapiro, Bruce A

    2017-01-01

    Molecular dynamics (MD) simulations have been used as one of the main research tools to study a wide range of biological systems and bridge the gap between X-ray crystallography or NMR structures and biological mechanism. In the field of RNA nanostructures, MD simulations have been used to fix steric clashes in computationally designed RNA nanostructures, characterize the dynamics, and investigate the interaction between RNA and other biomolecules such as delivery agents and membranes.In this chapter we present examples of computational protocols for molecular dynamics simulations in explicit and implicit solvent using the Amber Molecular Dynamics Package. We also show examples of post-simulation analysis steps and briefly mention selected tools beyond the Amber package. Limitations of the methods, tools, and protocols are also discussed. Most of the examples are illustrated for a small RNA duplex (helix), but the protocols are applicable to any nucleic acid structure, subject only to the computational speed and memory limitations of the hardware available to the user.

  5. Electron-phonon interaction within classical molecular dynamics

    DOE PAGES

    Tamm, A.; Samolyuk, G.; Correa, A. A.; ...

    2016-07-14

    Here, we present a model for nonadiabatic classical molecular dynamics simulations that captures with high accuracy the wave-vector q dependence of the phonon lifetimes, in agreement with quantum mechanics calculations. It is based on a local view of the e-ph interaction where individual atom dynamics couples to electrons via a damping term that is obtained as the low-velocity limit of the stopping power of a moving ion in a host. The model is parameter free, as its components are derived from ab initio-type calculations, is readily extended to the case of alloys, and is adequate for large-scale molecular dynamics computermore » simulations. We also show how this model removes some oversimplifications of the traditional ionic damped dynamics commonly used to describe situations beyond the Born-Oppenheimer approximation.« less

  6. Algorithms for GPU-based molecular dynamics simulations of complex fluids: Applications to water, mixtures, and liquid crystals.

    PubMed

    Kazachenko, Sergey; Giovinazzo, Mark; Hall, Kyle Wm; Cann, Natalie M

    2015-09-15

    A custom code for molecular dynamics simulations has been designed to run on CUDA-enabled NVIDIA graphics processing units (GPUs). The double-precision code simulates multicomponent fluids, with intramolecular and intermolecular forces, coarse-grained and atomistic models, holonomic constraints, Nosé-Hoover thermostats, and the generation of distribution functions. Algorithms to compute Lennard-Jones and Gay-Berne interactions, and the electrostatic force using Ewald summations, are discussed. A neighbor list is introduced to improve scaling with respect to system size. Three test systems are examined: SPC/E water; an n-hexane/2-propanol mixture; and a liquid crystal mesogen, 2-(4-butyloxyphenyl)-5-octyloxypyrimidine. Code performance is analyzed for each system. With one GPU, a 33-119 fold increase in performance is achieved compared with the serial code while the use of two GPUs leads to a 69-287 fold improvement and three GPUs yield a 101-377 fold speedup. © 2015 Wiley Periodicals, Inc.

  7. Dynamical photo-induced electronic properties of molecular junctions

    NASA Astrophysics Data System (ADS)

    Beltako, K.; Michelini, F.; Cavassilas, N.; Raymond, L.

    2018-03-01

    Nanoscale molecular-electronic devices and machines are emerging as promising functional elements, naturally flexible and efficient, for next-generation technologies. A deeper understanding of carrier dynamics in molecular junctions is expected to benefit many fields of nanoelectronics and power devices. We determine time-resolved charge current flowing at the donor-acceptor interface in molecular junctions connected to metallic electrodes by means of quantum transport simulations. The current is induced by the interaction of the donor with a Gaussian-shape femtosecond laser pulse. Effects of the molecular internal coupling, metal-molecule tunneling, and light-donor coupling on photocurrent are discussed. We then define the time-resolved local density of states which is proposed as an efficient tool to describe the absorbing molecule in contact with metallic electrodes. Non-equilibrium reorganization of hybridized molecular orbitals through the light-donor interaction gives rise to two phenomena: the dynamical Rabi shift and the appearance of Floquet-like states. Such insights into the dynamical photoelectronic structure of molecules are of strong interest for ultrafast spectroscopy and open avenues toward the possibility of analyzing and controlling the internal properties of quantum nanodevices with pump-push photocurrent spectroscopy.

  8. ALEGRA -- A massively parallel h-adaptive code for solid dynamics

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Summers, R.M.; Wong, M.K.; Boucheron, E.A.

    1997-12-31

    ALEGRA is a multi-material, arbitrary-Lagrangian-Eulerian (ALE) code for solid dynamics designed to run on massively parallel (MP) computers. It combines the features of modern Eulerian shock codes, such as CTH, with modern Lagrangian structural analysis codes using an unstructured grid. ALEGRA is being developed for use on the teraflop supercomputers to conduct advanced three-dimensional (3D) simulations of shock phenomena important to a variety of systems. ALEGRA was designed with the Single Program Multiple Data (SPMD) paradigm, in which the mesh is decomposed into sub-meshes so that each processor gets a single sub-mesh with approximately the same number of elements. Usingmore » this approach the authors have been able to produce a single code that can scale from one processor to thousands of processors. A current major effort is to develop efficient, high precision simulation capabilities for ALEGRA, without the computational cost of using a global highly resolved mesh, through flexible, robust h-adaptivity of finite elements. H-adaptivity is the dynamic refinement of the mesh by subdividing elements, thus changing the characteristic element size and reducing numerical error. The authors are working on several major technical challenges that must be met to make effective use of HAMMER on MP computers.« less

  9. Adaptively restrained molecular dynamics in LAMMPS

    NASA Astrophysics Data System (ADS)

    Kant Singh, Krishna; Redon, Stephane

    2017-07-01

    Adaptively restrained molecular dynamics (ARMD) is a recently introduced particles simulation method that switches positional degrees of freedom on and off during simulation in order to speed up calculations. In the NVE ensemble, ARMD allows users to trade between precision and speed while, in the NVT ensemble, it makes it possible to compute statistical averages faster. Despite the conceptual simplicity of the approach, however, integrating it in existing molecular dynamics packages is non-trivial, in particular since implemented potentials should a priori be rewritten to take advantage of frozen particles and achieve a speed-up. In this paper, we present novel algorithms for integrating ARMD in LAMMPS, a popular multi-purpose molecular simulation package. In particular, we demonstrate how to enable ARMD in LAMMPS without having to re-implement all available force fields. The proposed algorithms are assessed on four different benchmarks, and show how they allow us to speed up simulations up to one order of magnitude.

  10. Multiple time step integrators in ab initio molecular dynamics.

    PubMed

    Luehr, Nathan; Markland, Thomas E; Martínez, Todd J

    2014-02-28

    Multiple time-scale algorithms exploit the natural separation of time-scales in chemical systems to greatly accelerate the efficiency of molecular dynamics simulations. Although the utility of these methods in systems where the interactions are described by empirical potentials is now well established, their application to ab initio molecular dynamics calculations has been limited by difficulties associated with splitting the ab initio potential into fast and slowly varying components. Here we present two schemes that enable efficient time-scale separation in ab initio calculations: one based on fragment decomposition and the other on range separation of the Coulomb operator in the electronic Hamiltonian. We demonstrate for both water clusters and a solvated hydroxide ion that multiple time-scale molecular dynamics allows for outer time steps of 2.5 fs, which are as large as those obtained when such schemes are applied to empirical potentials, while still allowing for bonds to be broken and reformed throughout the dynamics. This permits computational speedups of up to 4.4x, compared to standard Born-Oppenheimer ab initio molecular dynamics with a 0.5 fs time step, while maintaining the same energy conservation and accuracy.

  11. Application of JAERI quantum molecular dynamics model for collisions of heavy nuclei

    NASA Astrophysics Data System (ADS)

    Ogawa, Tatsuhiko; Hashimoto, Shintaro; Sato, Tatsuhiko; Niita, Koji

    2016-06-01

    The quantum molecular dynamics (QMD) model incorporated into the general-purpose radiation transport code PHITS was revised for accurate prediction of fragment yields in peripheral collisions. For more accurate simulation of peripheral collisions, stability of the nuclei at their ground state was improved and the algorithm to reject invalid events was modified. In-medium correction on nucleon-nucleon cross sections was also considered. To clarify the effect of this improvement on fragmentation of heavy nuclei, the new QMD model coupled with a statistical decay model was used to calculate fragment production cross sections of Ag and Au targets and compared with the data of earlier measurement. It is shown that the revised version can predict cross section more accurately.

  12. OpenMM 7: Rapid development of high performance algorithms for molecular dynamics

    PubMed Central

    Swails, Jason; Zhao, Yutong; Beauchamp, Kyle A.; Wang, Lee-Ping; Stern, Chaya D.; Brooks, Bernard R.; Pande, Vijay S.

    2017-01-01

    OpenMM is a molecular dynamics simulation toolkit with a unique focus on extensibility. It allows users to easily add new features, including forces with novel functional forms, new integration algorithms, and new simulation protocols. Those features automatically work on all supported hardware types (including both CPUs and GPUs) and perform well on all of them. In many cases they require minimal coding, just a mathematical description of the desired function. They also require no modification to OpenMM itself and can be distributed independently of OpenMM. This makes it an ideal tool for researchers developing new simulation methods, and also allows those new methods to be immediately available to the larger community. PMID:28746339

  13. Multi-code analysis of scrape-off layer filament dynamics in MAST

    NASA Astrophysics Data System (ADS)

    Militello, F.; Walkden, N. R.; Farley, T.; Gracias, W. A.; Olsen, J.; Riva, F.; Easy, L.; Fedorczak, N.; Lupelli, I.; Madsen, J.; Nielsen, A. H.; Ricci, P.; Tamain, P.; Young, J.

    2016-11-01

    Four numerical codes are employed to investigate the dynamics of scrape-off layer filaments in tokamak relevant conditions. Experimental measurements were taken in the MAST device using visual camera imaging, which allows the evaluation of the perpendicular size and velocity of the filaments, as well as the combination of density and temperature associated with the perturbation. A new algorithm based on the light emission integrated along the field lines associated with the position of the filament is developed to ensure that it is properly detected and tracked. The filaments are found to have velocities of the order of 1~\\text{km}~{{\\text{s}}-1} , a perpendicular diameter of around 2-3 cm and a density amplitude 2-3.5 times the background plasma. 3D and 2D numerical codes (the STORM module of BOUT++, GBS, HESEL and TOKAM3X) are used to reproduce the motion of the observed filaments with the purpose of validating the codes and of better understanding the experimental data. Good agreement is found between the 3D codes. The seeded filament simulations are also able to reproduce the dynamics observed in experiments with accuracy up to the experimental errorbar levels. In addition, the numerical results showed that filaments characterised by similar size and light emission intensity can have quite different dynamics if the pressure perturbation is distributed differently between density and temperature components. As an additional benefit, several observations on the dynamics of the filaments in the presence of evolving temperature fields were made and led to a better understanding of the behaviour of these coherent structures.

  14. Neural dynamics of reward probability coding: a Magnetoencephalographic study in humans

    PubMed Central

    Thomas, Julie; Vanni-Mercier, Giovanna; Dreher, Jean-Claude

    2013-01-01

    Prediction of future rewards and discrepancy between actual and expected outcomes (prediction error) are crucial signals for adaptive behavior. In humans, a number of fMRI studies demonstrated that reward probability modulates these two signals in a large brain network. Yet, the spatio-temporal dynamics underlying the neural coding of reward probability remains unknown. Here, using magnetoencephalography, we investigated the neural dynamics of prediction and reward prediction error computations while subjects learned to associate cues of slot machines with monetary rewards with different probabilities. We showed that event-related magnetic fields (ERFs) arising from the visual cortex coded the expected reward value 155 ms after the cue, demonstrating that reward value signals emerge early in the visual stream. Moreover, a prediction error was reflected in ERF peaking 300 ms after the rewarded outcome and showing decreasing amplitude with higher reward probability. This prediction error signal was generated in a network including the anterior and posterior cingulate cortex. These findings pinpoint the spatio-temporal characteristics underlying reward probability coding. Together, our results provide insights into the neural dynamics underlying the ability to learn probabilistic stimuli-reward contingencies. PMID:24302894

  15. Modeling the Hydrogen Bond within Molecular Dynamics

    ERIC Educational Resources Information Center

    Lykos, Peter

    2004-01-01

    The structure of a hydrogen bond is elucidated within the framework of molecular dynamics based on the model of Rahman and Stillinger (R-S) liquid water treatment. Thus, undergraduates are exposed to the powerful but simple use of classical mechanics to solid objects from a molecular viewpoint.

  16. Visualizing global properties of a molecular dynamics trajectory.

    PubMed

    Zhou, Hao; Li, Shangyang; Makowski, Lee

    2016-01-01

    Molecular dynamics (MD) trajectories are very large data sets that contain substantial information about the dynamic behavior of a protein. Condensing these data into a form that can provide intuitively useful understanding of the molecular behavior during the trajectory is a substantial challenge that has received relatively little attention. Here, we introduce the sigma-r plot, a plot of the standard deviation of intermolecular distances as a function of that distance. This representation of global dynamics contains within a single, one-dimensional plot, the average range of motion between pairs of atoms within a macromolecule. Comparison of sigma-r plots calculated from 10 ns trajectories of proteins representing the four major SCOP fold classes indicates diversity of dynamic behaviors which are recognizably different among the four classes. Differences in domain structure and molecular weight also produce recognizable features in sigma-r plots, reflective of differences in global dynamics. Plots generated from trajectories with progressively increasing simulation time reflect the increased sampling of the structural ensemble as a function of time. Single amino acid replacements can give rise to changes in global dynamics detectable through comparison of sigma-r plots. Dynamic behavior of substructures can be monitored by careful choice of interatomic vectors included in the calculation. These examples provide demonstrations of the utility of the sigma-r plot to provide a simple measure of the global dynamics of a macromolecule. © 2015 Wiley Periodicals, Inc.

  17. Quantum dynamics of light-driven chiral molecular motors.

    PubMed

    Yamaki, Masahiro; Nakayama, Shin-ichiro; Hoki, Kunihito; Kono, Hirohiko; Fujimura, Yuichi

    2009-03-21

    The results of theoretical studies on quantum dynamics of light-driven molecular motors with internal rotation are presented. Characteristic features of chiral motors driven by a non-helical, linearly polarized electric field of light are explained on the basis of symmetry argument. The rotational potential of the chiral motor is characterized by a ratchet form. The asymmetric potential determines the directional motion: the rotational direction is toward the gentle slope of the asymmetric potential. This direction is called the intuitive direction. To confirm the unidirectional rotational motion, results of quantum dynamical calculations of randomly-oriented molecular motors are presented. A theoretical design of the smallest light-driven molecular machine is presented. The smallest chiral molecular machine has an optically driven engine and a running propeller on its body. The mechanisms of transmission of driving forces from the engine to the propeller are elucidated by using a quantum dynamical treatment. The results provide a principle for control of optically-driven molecular bevel gears. Temperature effects are discussed using the density operator formalism. An effective method for ultrafast control of rotational motions in any desired direction is presented with the help of a quantum control theory. In this method, visible or UV light pulses are applied to drive the motor via an electronic excited state. A method for driving a large molecular motor consisting of an aromatic hydrocarbon is presented. The molecular motor is operated by interactions between the induced dipole of the molecular motor and the electric field of light pulses.

  18. Ultrafast spectroscopy reveals subnanosecond peptide conformational dynamics and validates molecular dynamics simulation

    NASA Astrophysics Data System (ADS)

    Spörlein, Sebastian; Carstens, Heiko; Satzger, Helmut; Renner, Christian; Behrendt, Raymond; Moroder, Luis; Tavan, Paul; Zinth, Wolfgang; Wachtveitl, Josef

    2002-06-01

    Femtosecond time-resolved spectroscopy on model peptides with built-in light switches combined with computer simulation of light-triggered motions offers an attractive integrated approach toward the understanding of peptide conformational dynamics. It was applied to monitor the light-induced relaxation dynamics occurring on subnanosecond time scales in a peptide that was backbone-cyclized with an azobenzene derivative as optical switch and spectroscopic probe. The femtosecond spectra permit the clear distinguishing and characterization of the subpicosecond photoisomerization of the chromophore, the subsequent dissipation of vibrational energy, and the subnanosecond conformational relaxation of the peptide. The photochemical cis/trans-isomerization of the chromophore and the resulting peptide relaxations have been simulated with molecular dynamics calculations. The calculated reaction kinetics, as monitored by the energy content of the peptide, were found to match the spectroscopic data. Thus we verify that all-atom molecular dynamics simulations can quantitatively describe the subnanosecond conformational dynamics of peptides, strengthening confidence in corresponding predictions for longer time scales.

  19. Rotational Dynamics of Proteins from Spin Relaxation Times and Molecular Dynamics Simulations.

    PubMed

    Ollila, O H Samuli; Heikkinen, Harri A; Iwaï, Hideo

    2018-06-14

    Conformational fluctuations and rotational tumbling of proteins can be experimentally accessed with nuclear spin relaxation experiments. However, interpretation of molecular dynamics from the experimental data is often complicated, especially for molecules with anisotropic shape. Here, we apply classical molecular dynamics simulations to interpret the conformational fluctuations and rotational tumbling of proteins with arbitrarily anisotropic shape. The direct calculation of spin relaxation times from simulation data did not reproduce the experimental data. This was successfully corrected by scaling the overall rotational diffusion coefficients around the protein inertia axes with a constant factor. The achieved good agreement with experiments allowed the interpretation of the internal and overall dynamics of proteins with significantly anisotropic shape. The overall rotational diffusion was found to be Brownian, having only a short subdiffusive region below 0.12 ns. The presented methodology can be applied to interpret rotational dynamics and conformation fluctuations of proteins with arbitrary anisotropic shape. However, a water model with more realistic dynamical properties is probably required for intrinsically disordered proteins.

  20. Molecular dynamics simulations of collision-induced absorption: Implementation in LAMMPS

    NASA Astrophysics Data System (ADS)

    Fakhardji, W.; Gustafsson, M.

    2017-02-01

    We pursue simulations of collision-induced absorption in a mixture of argon and xenon gas at room temperature by means of classical molecular dynamics. The established theoretical approach (Hartmann et al. 2011 J. Chem. Phys. 134 094316) is implemented with the molecular dynamics package LAMMPS. The bound state features in the absorption spectrum are well reproduced with the molecular dynamics simulation in comparison with a laboratory measurement. The magnitude of the computed absorption, however, is underestimated in a large part of the spectrum. We suggest some aspects of the simulation that could be improved.

  1. Diffusive molecular dynamics simulations of lithiation of silicon nanopillars

    NASA Astrophysics Data System (ADS)

    Mendez, J. P.; Ponga, M.; Ortiz, M.

    2018-06-01

    We report diffusive molecular dynamics simulations concerned with the lithiation of Si nano-pillars, i.e., nano-sized Si rods held at both ends by rigid supports. The duration of the lithiation process is of the order of milliseconds, well outside the range of molecular dynamics but readily accessible to diffusive molecular dynamics. The simulations predict an alloy Li15Si4 at the fully lithiated phase, exceedingly large and transient volume increments up to 300% due to the weakening of Sisbnd Si iterations, a crystalline-to-amorphous-to-lithiation phase transition governed by interface kinetics, high misfit strains and residual stresses resulting in surface cracks and severe structural degradation in the form of extensive porosity, among other effects.

  2. Multitasking the code ARC3D. [for computational fluid dynamics

    NASA Technical Reports Server (NTRS)

    Barton, John T.; Hsiung, Christopher C.

    1986-01-01

    The CRAY multitasking system was developed in order to utilize all four processors and sharply reduce the wall clock run time. This paper describes the techniques used to modify the computational fluid dynamics code ARC3D for this run and analyzes the achieved speedup. The ARC3D code solves either the Euler or thin-layer N-S equations using an implicit approximate factorization scheme. Results indicate that multitask processing can be used to achieve wall clock speedup factors of over three times, depending on the nature of the program code being used. Multitasking appears to be particularly advantageous for large-memory problems running on multiple CPU computers.

  3. Multiscale equation-free algorithms for molecular dynamics

    NASA Astrophysics Data System (ADS)

    Abi Mansour, Andrew

    Molecular dynamics is a physics-based computational tool that has been widely employed to study the dynamics and structure of macromolecules and their assemblies at the atomic scale. However, the efficiency of molecular dynamics simulation is limited because of the broad spectrum of timescales involved. To overcome this limitation, an equation-free algorithm is presented for simulating these systems using a multiscale model cast in terms of atomistic and coarse-grained variables. Both variables are evolved in time in such a way that the cross-talk between short and long scales is preserved. In this way, the coarse-grained variables guide the evolution of the atom-resolved states, while the latter provide the Newtonian physics for the former. While the atomistic variables are evolved using short molecular dynamics runs, time advancement at the coarse-grained level is achieved with a scheme that uses information from past and future states of the system while accounting for both the stochastic and deterministic features of the coarse-grained dynamics. To complete the multiscale cycle, an atom-resolved state consistent with the updated coarse-grained variables is recovered using algorithms from mathematical optimization. This multiscale paradigm is extended to nanofluidics using concepts from hydrodynamics, and it is demonstrated for macromolecular and nanofluidic systems. A toolkit is developed for prototyping these algorithms, which are then implemented within the GROMACS simulation package and released as an open source multiscale simulator.

  4. Trajectory NG: portable, compressed, general molecular dynamics trajectories.

    PubMed

    Spångberg, Daniel; Larsson, Daniel S D; van der Spoel, David

    2011-10-01

    We present general algorithms for the compression of molecular dynamics trajectories. The standard ways to store MD trajectories as text or as raw binary floating point numbers result in very large files when efficient simulation programs are used on supercomputers. Our algorithms are based on the observation that differences in atomic coordinates/velocities, in either time or space, are generally smaller than the absolute values of the coordinates/velocities. Also, it is often possible to store values at a lower precision. We apply several compression schemes to compress the resulting differences further. The most efficient algorithms developed here use a block sorting algorithm in combination with Huffman coding. Depending on the frequency of storage of frames in the trajectory, either space, time, or combinations of space and time differences are usually the most efficient. We compare the efficiency of our algorithms with each other and with other algorithms present in the literature for various systems: liquid argon, water, a virus capsid solvated in 15 mM aqueous NaCl, and solid magnesium oxide. We perform tests to determine how much precision is necessary to obtain accurate structural and dynamic properties, as well as benchmark a parallelized implementation of the algorithms. We obtain compression ratios (compared to single precision floating point) of 1:3.3-1:35 depending on the frequency of storage of frames and the system studied.

  5. Modeling radiation belt dynamics using a 3-D layer method code

    NASA Astrophysics Data System (ADS)

    Wang, C.; Ma, Q.; Tao, X.; Zhang, Y.; Teng, S.; Albert, J. M.; Chan, A. A.; Li, W.; Ni, B.; Lu, Q.; Wang, S.

    2017-08-01

    A new 3-D diffusion code using a recently published layer method has been developed to analyze radiation belt electron dynamics. The code guarantees the positivity of the solution even when mixed diffusion terms are included. Unlike most of the previous codes, our 3-D code is developed directly in equatorial pitch angle (α0), momentum (p), and L shell coordinates; this eliminates the need to transform back and forth between (α0,p) coordinates and adiabatic invariant coordinates. Using (α0,p,L) is also convenient for direct comparison with satellite data. The new code has been validated by various numerical tests, and we apply the 3-D code to model the rapid electron flux enhancement following the geomagnetic storm on 17 March 2013, which is one of the Geospace Environment Modeling Focus Group challenge events. An event-specific global chorus wave model, an AL-dependent statistical plasmaspheric hiss wave model, and a recently published radial diffusion coefficient formula from Time History of Events and Macroscale Interactions during Substorms (THEMIS) statistics are used. The simulation results show good agreement with satellite observations, in general, supporting the scenario that the rapid enhancement of radiation belt electron flux for this event results from an increased level of the seed population by radial diffusion, with subsequent acceleration by chorus waves. Our results prove that the layer method can be readily used to model global radiation belt dynamics in three dimensions.

  6. ORBIT: A Code for Collective Beam Dynamics in High-Intensity Rings

    NASA Astrophysics Data System (ADS)

    Holmes, J. A.; Danilov, V.; Galambos, J.; Shishlo, A.; Cousineau, S.; Chou, W.; Michelotti, L.; Ostiguy, J.-F.; Wei, J.

    2002-12-01

    We are developing a computer code, ORBIT, specifically for beam dynamics calculations in high-intensity rings. Our approach allows detailed simulation of realistic accelerator problems. ORBIT is a particle-in-cell tracking code that transports bunches of interacting particles through a series of nodes representing elements, effects, or diagnostics that occur in the accelerator lattice. At present, ORBIT contains detailed models for strip-foil injection, including painting and foil scattering; rf focusing and acceleration; transport through various magnetic elements; longitudinal and transverse impedances; longitudinal, transverse, and three-dimensional space charge forces; collimation and limiting apertures; and the calculation of many useful diagnostic quantities. ORBIT is an object-oriented code, written in C++ and utilizing a scripting interface for the convenience of the user. Ongoing improvements include the addition of a library of accelerator maps, BEAMLINE/MXYZPTLK; the introduction of a treatment of magnet errors and fringe fields; the conversion of the scripting interface to the standard scripting language, Python; and the parallelization of the computations using MPI. The ORBIT code is an open source, powerful, and convenient tool for studying beam dynamics in high-intensity rings.

  7. Overcoming free energy barriers using unconstrained molecular dynamics simulations

    NASA Astrophysics Data System (ADS)

    Hénin, Jérôme; Chipot, Christophe

    2004-08-01

    Association of unconstrained molecular dynamics (MD) and the formalisms of thermodynamic integration and average force [Darve and Pohorille, J. Chem. Phys. 115, 9169 (2001)] have been employed to determine potentials of mean force. When implemented in a general MD code, the additional computational effort, compared to other standard, unconstrained simulations, is marginal. The force acting along a chosen reaction coordinate ξ is estimated from the individual forces exerted on the chemical system and accumulated as the simulation progresses. The estimated free energy derivative computed for small intervals of ξ is canceled by an adaptive bias to overcome the barriers of the free energy landscape. Evolution of the system along the reaction coordinate is, thus, limited by its sole self-diffusion properties. The illustrative examples of the reversible unfolding of deca-L-alanine, the association of acetate and guanidinium ions in water, the dimerization of methane in water, and its transfer across the water liquid-vapor interface are examined to probe the efficiency of the method.

  8. Molecular mechanisms of cryoprotection in aqueous proline: light scattering and molecular dynamics simulations.

    PubMed

    Troitzsch, R Z; Vass, H; Hossack, W J; Martyna, G J; Crain, J

    2008-04-10

    Free proline amino acid is a natural cryoprotectant expressed by numerous organisms under low-temperature stress. Previous reports have suggested that complex assemblies underlie its functional properties. We investigate here aqueous proline solutions as a function of temperature using combinations of Raman spectroscopy, Rayleigh-Brillouin light scattering, and molecular dynamics simulations with the view to revealing the molecular origins of the mixtures' functionality as a cryoprotectant. The evolution of the Brillouin frequency shifts and line widths with temperature shows that, above a critical proline concentration, the water-like dynamics is suppressed and viscoelastic behavior emerges: Here, the Landau-Placzek ratio also shows a temperature-independent maximum arising from concentration fluctuations. Molecular dynamics simulations reveal that the water-water correlations in the mixtures depend much more weakly on temperature than does bulk water. By contrast, the water OH Raman bands exhibit strong red-shifts on cooling similar to those seen in ices; however, no evidence of ice lattice phonons is observed in the low-frequency spectrum. We attribute this primarily to enhanced proline-water hydrogen bonding. In general, the picture that emerges is that aqueous proline is a heterogeneous mixture on molecular length scales (characterized by significant concentration fluctuations rather than well-defined aggregates). Simulations reveal that proline also appears to suppress the normal dependence of water structure on temperature and preserves the ambient-temperature correlations even in very cold solutions. The water structure in cold proline solutions therefore appears to be similar to that at a higher effective temperature. This, coupled with the emergence of glassy dynamics offers a molecular explanation for the functional properties of proline as a cryoprotectant without the need to invoke previously proposed complex aggregates.

  9. Molecular dynamics: deciphering the data.

    PubMed

    Dauber-Osguthorpe, P; Maunder, C M; Osguthorpe, D J

    1996-06-01

    The dynamic behaviour of molecules is important in determining their activity. Molecular dynamics (MD) simulations give a detailed description of motion, from small fluctuations to conformational transitions, and can include solvent effects. However, extracting useful information about conformational motion from a trajectory is not trivial. We have used digital signal-processing techniques to characterise the motion in MD simulations, including: calculating the frequency distribution, applying filtering functions, and extraction of vectors defining the characteristic motion for each frequency in an MD simulation. We describe here some typical results obtained for peptides and proteins. The nature of the low-frequency modes of motion, as obtained from MD and normal mode (NM) analysis, of Ace-(Ala)31-Nma and of a proline mutant is discussed. Low-frequency modes extracted from the MD trajectories of Rop protein and phospholipase A2 reveal characteristic motions of secondary structure elements, as well as concerned motions that are of significance to the protein's biological activity. MD simulations are also used frequently as a tool for conformational searches and for investigating protein folding/unfolding. We have developed a novel method that uses time-domain filtering to channel energy into conformational motion and thus enhance conformational transitions. The selectively enhanced molecular dynamics method is tested on the small molecule hexane.

  10. Molecular dynamics: Deciphering the data

    NASA Astrophysics Data System (ADS)

    Dauber-Osguthorpe, Pnina; Maunder, Colette M.; Osguthorpe, David J.

    1996-06-01

    The dynamic behaviour of molecules is important in determining their activity. Molecular dynamics (MD) simulations give a detailed description of motion, from small fluctuations to conformational transitions, and can include solvent effects. However, extracting useful information about conformational motion from a trajectory is not trivial. We have used digital signal-processing techniques to characterise the motion in MD simulations, including: calculating the frequency distribution, applying filtering functions, and extraction of vectors defining the characteristic motion for each frequency in an MD simulation. We describe here some typical results obtained for peptides and proteins. The nature of the low-frequency modes of motion, as obtained from MD and normal mode (NM) analysis, of Ace-(Ala)31-Nma and of a proline mutant is discussed. Low-frequency modes extracted from the MD trajectories of Rop protein and phospholipase A2 reveal characteristic motions of secondary structure elements, as well as concerted motions that are of significance to the protein's biological activity. MD simulations are also used frequently as a tool for conformational searches and for investigating protein folding/unfolding. We have developed a novel method that uses time-domain filtering to channel energy into conformational motion and thus enhance conformational transitions. The selectively enhanced molecular dynamics method is tested on the small molecule hexane.

  11. Assessment of Molecular Modeling & Simulation

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    None

    2002-01-03

    This report reviews the development and applications of molecular and materials modeling in Europe and Japan in comparison to those in the United States. Topics covered include computational quantum chemistry, molecular simulations by molecular dynamics and Monte Carlo methods, mesoscale modeling of material domains, molecular-structure/macroscale property correlations like QSARs and QSPRs, and related information technologies like informatics and special-purpose molecular-modeling computers. The panel's findings include the following: The United States leads this field in many scientific areas. However, Canada has particular strengths in DFT methods and homogeneous catalysis; Europe in heterogeneous catalysis, mesoscale, and materials modeling; and Japan in materialsmore » modeling and special-purpose computing. Major government-industry initiatives are underway in Europe and Japan, notably in multi-scale materials modeling and in development of chemistry-capable ab-initio molecular dynamics codes.« less

  12. Three-dimensional ordering of cold ion beams in a storage ring: A molecular-dynamics simulation study

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Yuri, Yosuke, E-mail: yuri.yosuke@jaea.go.jp

    Three-dimensional (3D) ordering of a charged-particle beams circulating in a storage ring is systematically studied with a molecular-dynamics simulation code. An ion beam can exhibit a 3D ordered configuration at ultralow temperature as a result of powerful 3D laser cooling. Various unique characteristics of the ordered beams, different from those of crystalline beams, are revealed in detail, such as the single-particle motion in the transverse and longitudinal directions, and the dependence of the tune depression and the Coulomb coupling constant on the operating points.

  13. Biological Information Transfer Beyond the Genetic Code: The Sugar Code

    NASA Astrophysics Data System (ADS)

    Gabius, H.-J.

    In the era of genetic engineering, cloning, and genome sequencing the focus of research on the genetic code has received an even further accentuation in the public eye. In attempting, however, to understand intra- and intercellular recognition processes comprehensively, the two biochemical dimensions established by nucleic acids and proteins are not sufficient to satisfactorily explain all molecular events in, for example, cell adhesion or routing. The consideration of further code systems is essential to bridge this gap. A third biochemical alphabet forming code words with an information storage capacity second to no other substance class in rather small units (words, sentences) is established by monosaccharides (letters). As hardware oligosaccharides surpass peptides by more than seven orders of magnitude in the theoretical ability to build isomers, when the total of conceivable hexamers is calculated. In addition to the sequence complexity, the use of magnetic resonance spectroscopy and molecular modeling has been instrumental in discovering that even small glycans can often reside in not only one but several distinct low-energy conformations (keys). Intriguingly, conformers can display notably different capacities to fit snugly into the binding site of nonhomologous receptors (locks). This process, experimentally verified for two classes of lectins, is termed "differential conformer selection." It adds potential for shifts of the conformer equilibrium to modulate ligand properties dynamically and reversibly to the well-known changes in sequence (including anomeric positioning and linkage points) and in pattern of substitution, for example, by sulfation. In the intimate interplay with sugar receptors (lectins, enzymes, and antibodies) the message of coding units of the sugar code is deciphered. Their recognition will trigger postbinding signaling and the intended biological response. Knowledge about the driving forces for the molecular rendezvous, i

  14. Crystalline molecular machines: Encoding supramolecular dynamics into molecular structure

    PubMed Central

    Garcia-Garibay, Miguel A.

    2005-01-01

    Crystalline molecular machines represent an exciting new branch of crystal engineering and materials science with important implications to nanotechnology. Crystalline molecular machines are crystals built with molecules that are structurally programmed to respond collectively to mechanic, electric, magnetic, or photonic stimuli to fulfill specific functions. One of the main challenges in their construction derives from the picometric precision required for their mechanic operation within the close-packed, self-assembled environment of crystalline solids. In this article, we outline some of the general guidelines for their design and apply them for the construction of molecular crystals with units intended to emulate macroscopic gyroscopes and compasses. Recent advances in the preparation, crystallization, and dynamic characterization of these interesting systems offer a foothold to the possibilities and help highlight some avenues for future experimentation. PMID:16046543

  15. A suite of exercises for verifying dynamic earthquake rupture codes

    USGS Publications Warehouse

    Harris, Ruth A.; Barall, Michael; Aagaard, Brad T.; Ma, Shuo; Roten, Daniel; Olsen, Kim B.; Duan, Benchun; Liu, Dunyu; Luo, Bin; Bai, Kangchen; Ampuero, Jean-Paul; Kaneko, Yoshihiro; Gabriel, Alice-Agnes; Duru, Kenneth; Ulrich, Thomas; Wollherr, Stephanie; Shi, Zheqiang; Dunham, Eric; Bydlon, Sam; Zhang, Zhenguo; Chen, Xiaofei; Somala, Surendra N.; Pelties, Christian; Tago, Josue; Cruz-Atienza, Victor Manuel; Kozdon, Jeremy; Daub, Eric; Aslam, Khurram; Kase, Yuko; Withers, Kyle; Dalguer, Luis

    2018-01-01

    We describe a set of benchmark exercises that are designed to test if computer codes that simulate dynamic earthquake rupture are working as intended. These types of computer codes are often used to understand how earthquakes operate, and they produce simulation results that include earthquake size, amounts of fault slip, and the patterns of ground shaking and crustal deformation. The benchmark exercises examine a range of features that scientists incorporate in their dynamic earthquake rupture simulations. These include implementations of simple or complex fault geometry, off‐fault rock response to an earthquake, stress conditions, and a variety of formulations for fault friction. Many of the benchmarks were designed to investigate scientific problems at the forefronts of earthquake physics and strong ground motions research. The exercises are freely available on our website for use by the scientific community.

  16. Thermostating extended Lagrangian Born-Oppenheimer molecular dynamics.

    PubMed

    Martínez, Enrique; Cawkwell, Marc J; Voter, Arthur F; Niklasson, Anders M N

    2015-04-21

    Extended Lagrangian Born-Oppenheimer molecular dynamics is developed and analyzed for applications in canonical (NVT) simulations. Three different approaches are considered: the Nosé and Andersen thermostats and Langevin dynamics. We have tested the temperature distribution under different conditions of self-consistent field (SCF) convergence and time step and compared the results to analytical predictions. We find that the simulations based on the extended Lagrangian Born-Oppenheimer framework provide accurate canonical distributions even under approximate SCF convergence, often requiring only a single diagonalization per time step, whereas regular Born-Oppenheimer formulations exhibit unphysical fluctuations unless a sufficiently high degree of convergence is reached at each time step. The thermostated extended Lagrangian framework thus offers an accurate approach to sample processes in the canonical ensemble at a fraction of the computational cost of regular Born-Oppenheimer molecular dynamics simulations.

  17. Molecular dynamics simulations using temperature-enhanced essential dynamics replica exchange.

    PubMed

    Kubitzki, Marcus B; de Groot, Bert L

    2007-06-15

    Today's standard molecular dynamics simulations of moderately sized biomolecular systems at full atomic resolution are typically limited to the nanosecond timescale and therefore suffer from limited conformational sampling. Efficient ensemble-preserving algorithms like replica exchange (REX) may alleviate this problem somewhat but are still computationally prohibitive due to the large number of degrees of freedom involved. Aiming at increased sampling efficiency, we present a novel simulation method combining the ideas of essential dynamics and REX. Unlike standard REX, in each replica only a selection of essential collective modes of a subsystem of interest (essential subspace) is coupled to a higher temperature, with the remainder of the system staying at a reference temperature, T(0). This selective excitation along with the replica framework permits efficient approximate ensemble-preserving conformational sampling and allows much larger temperature differences between replicas, thereby considerably enhancing sampling efficiency. Ensemble properties and sampling performance of the method are discussed using dialanine and guanylin test systems, with multi-microsecond molecular dynamics simulations of these test systems serving as references.

  18. Mechanic: The MPI/HDF code framework for dynamical astronomy

    NASA Astrophysics Data System (ADS)

    Słonina, Mariusz; Goździewski, Krzysztof; Migaszewski, Cezary

    2015-01-01

    We introduce the Mechanic, a new open-source code framework. It is designed to reduce the development effort of scientific applications by providing unified API (Application Programming Interface) for configuration, data storage and task management. The communication layer is based on the well-established Message Passing Interface (MPI) standard, which is widely used on variety of parallel computers and CPU-clusters. The data storage is performed within the Hierarchical Data Format (HDF5). The design of the code follows core-module approach which allows to reduce the user’s codebase and makes it portable for single- and multi-CPU environments. The framework may be used in a local user’s environment, without administrative access to the cluster, under the PBS or Slurm job schedulers. It may become a helper tool for a wide range of astronomical applications, particularly focused on processing large data sets, such as dynamical studies of long-term orbital evolution of planetary systems with Monte Carlo methods, dynamical maps or evolutionary algorithms. It has been already applied in numerical experiments conducted for Kepler-11 (Migaszewski et al., 2012) and νOctantis planetary systems (Goździewski et al., 2013). In this paper we describe the basics of the framework, including code listings for the implementation of a sample user’s module. The code is illustrated on a model Hamiltonian introduced by (Froeschlé et al., 2000) presenting the Arnold diffusion. The Arnold web is shown with the help of the MEGNO (Mean Exponential Growth of Nearby Orbits) fast indicator (Goździewski et al., 2008a) applied onto symplectic SABAn integrators family (Laskar and Robutel, 2001).

  19. A reduced basis method for molecular dynamics simulation

    NASA Astrophysics Data System (ADS)

    Vincent-Finley, Rachel Elisabeth

    In this dissertation, we develop a method for molecular simulation based on principal component analysis (PCA) of a molecular dynamics trajectory and least squares approximation of a potential energy function. Molecular dynamics (MD) simulation is a computational tool used to study molecular systems as they evolve through time. With respect to protein dynamics, local motions, such as bond stretching, occur within femtoseconds, while rigid body and large-scale motions, occur within a range of nanoseconds to seconds. To capture motion at all levels, time steps on the order of a femtosecond are employed when solving the equations of motion and simulations must continue long enough to capture the desired large-scale motion. To date, simulations of solvated proteins on the order of nanoseconds have been reported. It is typically the case that simulations of a few nanoseconds do not provide adequate information for the study of large-scale motions. Thus, the development of techniques that allow longer simulation times can advance the study of protein function and dynamics. In this dissertation we use principal component analysis (PCA) to identify the dominant characteristics of an MD trajectory and to represent the coordinates with respect to these characteristics. We augment PCA with an updating scheme based on a reduced representation of a molecule and consider equations of motion with respect to the reduced representation. We apply our method to butane and BPTI and compare the results to standard MD simulations of these molecules. Our results indicate that the molecular activity with respect to our simulation method is analogous to that observed in the standard MD simulation with simulations on the order of picoseconds.

  20. METAGUI. A VMD interface for analyzing metadynamics and molecular dynamics simulations

    NASA Astrophysics Data System (ADS)

    Biarnés, Xevi; Pietrucci, Fabio; Marinelli, Fabrizio; Laio, Alessandro

    2012-01-01

    We present a new computational tool, METAGUI, which extends the VMD program with a graphical user interface that allows constructing a thermodynamic and kinetic model of a given process simulated by large-scale molecular dynamics. The tool is specially designed for analyzing metadynamics based simulations. The huge amount of diverse structures generated during such a simulation is partitioned into a set of microstates (i.e. structures with similar values of the collective variables). Their relative free energies are then computed by a weighted-histogram procedure and the most relevant free energy wells are identified by diagonalization of the rate matrix followed by a commitor analysis. All this procedure leads to a convenient representation of the metastable states and long-time kinetics of the system which can be compared with experimental data. The tool allows to seamlessly switch between a collective variables space representation of microstates and their atomic structure representation, which greatly facilitates the set-up and analysis of molecular dynamics simulations. METAGUI is based on the output format of the PLUMED plugin, making it compatible with a number of different molecular dynamics packages like AMBER, NAMD, GROMACS and several others. The METAGUI source files can be downloaded from the PLUMED web site ( http://www.plumed-code.org). Program summaryProgram title: METAGUI Catalogue identifier: AEKH_v1_0 Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEKH_v1_0.html Program obtainable from: CPC Program Library, Queen's University, Belfast, N. Ireland Licensing provisions: GNU General Public License version 3 No. of lines in distributed program, including test data, etc.: 117 545 No. of bytes in distributed program, including test data, etc.: 8 516 203 Distribution format: tar.gz Programming language: TK/TCL, Fortran Computer: Any computer with a VMD installation and capable of running an executable produced by a gfortran compiler Operating

  1. Multiscale molecular dynamics simulations of rotary motor proteins.

    PubMed

    Ekimoto, Toru; Ikeguchi, Mitsunori

    2018-04-01

    Protein functions require specific structures frequently coupled with conformational changes. The scale of the structural dynamics of proteins spans from the atomic to the molecular level. Theoretically, all-atom molecular dynamics (MD) simulation is a powerful tool to investigate protein dynamics because the MD simulation is capable of capturing conformational changes obeying the intrinsically structural features. However, to study long-timescale dynamics, efficient sampling techniques and coarse-grained (CG) approaches coupled with all-atom MD simulations, termed multiscale MD simulations, are required to overcome the timescale limitation in all-atom MD simulations. Here, we review two examples of rotary motor proteins examined using free energy landscape (FEL) analysis and CG-MD simulations. In the FEL analysis, FEL is calculated as a function of reaction coordinates, and the long-timescale dynamics corresponding to conformational changes is described as transitions on the FEL surface. Another approach is the utilization of the CG model, in which the CG parameters are tuned using the fluctuation matching methodology with all-atom MD simulations. The long-timespan dynamics is then elucidated straightforwardly by using CG-MD simulations.

  2. Accelerated molecular dynamics: A promising and efficient simulation method for biomolecules

    NASA Astrophysics Data System (ADS)

    Hamelberg, Donald; Mongan, John; McCammon, J. Andrew

    2004-06-01

    Many interesting dynamic properties of biological molecules cannot be simulated directly using molecular dynamics because of nanosecond time scale limitations. These systems are trapped in potential energy minima with high free energy barriers for large numbers of computational steps. The dynamic evolution of many molecular systems occurs through a series of rare events as the system moves from one potential energy basin to another. Therefore, we have proposed a robust bias potential function that can be used in an efficient accelerated molecular dynamics approach to simulate the transition of high energy barriers without any advance knowledge of the location of either the potential energy wells or saddle points. In this method, the potential energy landscape is altered by adding a bias potential to the true potential such that the escape rates from potential wells are enhanced, which accelerates and extends the time scale in molecular dynamics simulations. Our definition of the bias potential echoes the underlying shape of the potential energy landscape on the modified surface, thus allowing for the potential energy minima to be well defined, and hence properly sampled during the simulation. We have shown that our approach, which can be extended to biomolecules, samples the conformational space more efficiently than normal molecular dynamics simulations, and converges to the correct canonical distribution.

  3. Nonadiabatic molecular dynamics simulations: synergies between theory and experiments.

    PubMed

    Tavernelli, Ivano

    2015-03-17

    Recent developments in nonadiabatic dynamics enabled ab inito simulations of complex ultrafast processes in the condensed phase. These advances have opened new avenues in the study of many photophysical and photochemical reactions triggered by the absorption of electromagnetic radiation. In particular, theoretical investigations can be combined with the most sophisticated femtosecond experimental techniques to guide the interpretation of measured time-resolved observables. At the same time, the availability of experimental data at high (spatial and time) resolution offers a unique opportunity for the benchmarking and the improvement of those theoretical models used to describe complex molecular systems in their natural environment. The established synergy between theory and experiments can produce a better understanding of new ultrafast physical and chemical processes at atomistic scale resolution. Furthermore, reliable ab inito molecular dynamics simulations can already be successfully employed as predictive tools to guide new experiments as well as the design of novel and better performing materials. In this paper, I will give a concise account on the state of the art of molecular dynamics simulations of complex molecular systems in their excited states. The principal aim of this approach is the description of a given system of interest under the most realistic ambient conditions including all environmental effects that influence experiments, for instance, the interaction with the solvent and with external time-dependent electric fields, temperature, and pressure. To this end, time-dependent density functional theory (TDDFT) is among the most efficient and accurate methods for the representation of the electronic dynamics, while trajectory surface hopping gives a valuable representation of the nuclear quantum dynamics in the excited states (including nonadiabatic effects). Concerning the environment and its effects on the dynamics, the quantum mechanics/molecular

  4. Parallel Decomposition of the Fictitious Lagrangian Algorithm and its Accuracy for Molecular Dynamics Simulations of Semiconductors.

    NASA Astrophysics Data System (ADS)

    Yeh, Mei-Ling

    We have performed a parallel decomposition of the fictitious Lagrangian method for molecular dynamics with tight-binding total energy expression into the hypercube computer. This is the first time in literature that the dynamical simulation of semiconducting systems containing more than 512 silicon atoms has become possible with the electrons treated as quantum particles. With the utilization of the Intel Paragon system, our timing analysis predicts that our code is expected to perform realistic simulations on very large systems consisting of thousands of atoms with time requirements of the order of tens of hours. Timing results and performance analysis of our parallel code are presented in terms of calculation time, communication time, and setup time. The accuracy of the fictitious Lagrangian method in molecular dynamics simulation is also investigated, especially the energy conservation of the total energy of ions. We find that the accuracy of the fictitious Lagrangian scheme in small silicon cluster and very large silicon system simulations is good for as long as the simulations proceed, even though we quench the electronic coordinates to the Born-Oppenheimer surface only in the beginning of the run. The kinetic energy of electrons does not increase as time goes on, and the energy conservation of the ionic subsystem remains very good. This means that, as far as the ionic subsystem is concerned, the electrons are on the average in the true quantum ground states. We also tie up some odds and ends regarding a few remaining questions about the fictitious Lagrangian method, such as the difference between the results obtained from the Gram-Schmidt and SHAKE method of orthonormalization, and differences between simulations where the electrons are quenched to the Born -Oppenheimer surface only once compared with periodic quenching.

  5. The Development and Comparison of Molecular Dynamics Simulation and Monte Carlo Simulation

    NASA Astrophysics Data System (ADS)

    Chen, Jundong

    2018-03-01

    Molecular dynamics is an integrated technology that combines physics, mathematics and chemistry. Molecular dynamics method is a computer simulation experimental method, which is a powerful tool for studying condensed matter system. This technique not only can get the trajectory of the atom, but can also observe the microscopic details of the atomic motion. By studying the numerical integration algorithm in molecular dynamics simulation, we can not only analyze the microstructure, the motion of particles and the image of macroscopic relationship between them and the material, but can also study the relationship between the interaction and the macroscopic properties more conveniently. The Monte Carlo Simulation, similar to the molecular dynamics, is a tool for studying the micro-molecular and particle nature. In this paper, the theoretical background of computer numerical simulation is introduced, and the specific methods of numerical integration are summarized, including Verlet method, Leap-frog method and Velocity Verlet method. At the same time, the method and principle of Monte Carlo Simulation are introduced. Finally, similarities and differences of Monte Carlo Simulation and the molecular dynamics simulation are discussed.

  6. Kinetics from Replica Exchange Molecular Dynamics Simulations.

    PubMed

    Stelzl, Lukas S; Hummer, Gerhard

    2017-08-08

    Transitions between metastable states govern many fundamental processes in physics, chemistry and biology, from nucleation events in phase transitions to the folding of proteins. The free energy surfaces underlying these processes can be obtained from simulations using enhanced sampling methods. However, their altered dynamics makes kinetic and mechanistic information difficult or impossible to extract. Here, we show that, with replica exchange molecular dynamics (REMD), one can not only sample equilibrium properties but also extract kinetic information. For systems that strictly obey first-order kinetics, the procedure to extract rates is rigorous. For actual molecular systems whose long-time dynamics are captured by kinetic rate models, accurate rate coefficients can be determined from the statistics of the transitions between the metastable states at each replica temperature. We demonstrate the practical applicability of the procedure by constructing master equation (Markov state) models of peptide and RNA folding from REMD simulations.

  7. Thermostating extended Lagrangian Born-Oppenheimer molecular dynamics

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Martínez, Enrique; Cawkwell, Marc J.; Voter, Arthur F.

    Here, Extended Lagrangian Born-Oppenheimer molecular dynamics is developed and analyzed for applications in canonical (NVT) simulations. Three different approaches are considered: the Nosé and Andersen thermostats and Langevin dynamics. We have tested the temperature distribution under different conditions of self-consistent field (SCF) convergence and time step and compared the results to analytical predictions. We find that the simulations based on the extended Lagrangian Born-Oppenheimer framework provide accurate canonical distributions even under approximate SCF convergence, often requiring only a single diagonalization per time step, whereas regular Born-Oppenheimer formulations exhibit unphysical fluctuations unless a sufficiently high degree of convergence is reached atmore » each time step. Lastly, the thermostated extended Lagrangian framework thus offers an accurate approach to sample processes in the canonical ensemble at a fraction of the computational cost of regular Born-Oppenheimer molecular dynamics simulations.« less

  8. Thermostating extended Lagrangian Born-Oppenheimer molecular dynamics

    DOE PAGES

    Martínez, Enrique; Cawkwell, Marc J.; Voter, Arthur F.; ...

    2015-04-21

    Here, Extended Lagrangian Born-Oppenheimer molecular dynamics is developed and analyzed for applications in canonical (NVT) simulations. Three different approaches are considered: the Nosé and Andersen thermostats and Langevin dynamics. We have tested the temperature distribution under different conditions of self-consistent field (SCF) convergence and time step and compared the results to analytical predictions. We find that the simulations based on the extended Lagrangian Born-Oppenheimer framework provide accurate canonical distributions even under approximate SCF convergence, often requiring only a single diagonalization per time step, whereas regular Born-Oppenheimer formulations exhibit unphysical fluctuations unless a sufficiently high degree of convergence is reached atmore » each time step. Lastly, the thermostated extended Lagrangian framework thus offers an accurate approach to sample processes in the canonical ensemble at a fraction of the computational cost of regular Born-Oppenheimer molecular dynamics simulations.« less

  9. AceCloud: Molecular Dynamics Simulations in the Cloud.

    PubMed

    Harvey, M J; De Fabritiis, G

    2015-05-26

    We present AceCloud, an on-demand service for molecular dynamics simulations. AceCloud is designed to facilitate the secure execution of large ensembles of simulations on an external cloud computing service (currently Amazon Web Services). The AceCloud client, integrated into the ACEMD molecular dynamics package, provides an easy-to-use interface that abstracts all aspects of interaction with the cloud services. This gives the user the experience that all simulations are running on their local machine, minimizing the learning curve typically associated with the transition to using high performance computing services.

  10. N-MODY: a code for collisionless N-body simulations in modified Newtonian dynamics.

    NASA Astrophysics Data System (ADS)

    Londrillo, P.; Nipoti, C.

    We describe the numerical code N-MODY, a parallel particle-mesh code for collisionless N-body simulations in modified Newtonian dynamics (MOND). N-MODY is based on a numerical potential solver in spherical coordinates that solves the non-linear MOND field equation, and is ideally suited to simulate isolated stellar systems. N-MODY can be used also to compute the MOND potential of arbitrary static density distributions. A few applications of N-MODY indicate that some astrophysically relevant dynamical processes are profoundly different in MOND and in Newtonian gravity with dark matter.

  11. Molecular dynamics simulations of high energy cascade in ordered alloys: Defect production and subcascade division

    NASA Astrophysics Data System (ADS)

    Crocombette, Jean-Paul; Van Brutzel, Laurent; Simeone, David; Luneville, Laurence

    2016-06-01

    Displacement cascades have been calculated in two ordered alloys (Ni3Al and UO2) in the molecular dynamics framework using the CMDC (Cell Molecular Dynamics for Cascade) code (J.-P. Crocombette and T. Jourdan, Nucl. Instrum. Meth. B 352, 9 (2015)) for energies ranking between 0.1 and 580 keV. The defect production has been compared to the prediction of the NRT (Norgett, Robinson and Torrens) standard. One observes a decrease with energy of the number of defects compared to the NRT prediction at intermediate energies but, unlike what is commonly observed in elemental solids, the number of produced defects does not always turn to a linear variation with ballistic energy at high energies. The fragmentation of the cascade into subcascades has been studied through the analysis of surviving defect pockets. It appears that the common knowledge equivalence of linearity of defect production and subcascades division does not hold in general for alloys. We calculate the average number of subcascades and average number of defects per subcascades as a function of ballistic energy. We find an unexpected variety of behaviors for these two average quantities above the threshold for subcascade formation.

  12. How to differentiate collective variables in free energy codes: Computer-algebra code generation and automatic differentiation

    NASA Astrophysics Data System (ADS)

    Giorgino, Toni

    2018-07-01

    The proper choice of collective variables (CVs) is central to biased-sampling free energy reconstruction methods in molecular dynamics simulations. The PLUMED 2 library, for instance, provides several sophisticated CV choices, implemented in a C++ framework; however, developing new CVs is still time consuming due to the need to provide code for the analytical derivatives of all functions with respect to atomic coordinates. We present two solutions to this problem, namely (a) symbolic differentiation and code generation, and (b) automatic code differentiation, in both cases leveraging open-source libraries (SymPy and Stan Math, respectively). The two approaches are demonstrated and discussed in detail implementing a realistic example CV, the local radius of curvature of a polymer. Users may use the code as a template to streamline the implementation of their own CVs using high-level constructs and automatic gradient computation.

  13. Molecular dynamics studies of polyurethane nanocomposite hydrogels

    NASA Astrophysics Data System (ADS)

    Strankowska, J.; Piszczyk, Ł.; Strankowski, M.; Danowska, M.; Szutkowski, K.; Jurga, S.; Kwela, J.

    2013-10-01

    Polyurethane PEO-based hydrogels have a broad range of biomedical applicability. They are attractive for drug-controlled delivery systems, surgical implants and wound healing dressings. In this study, a PEO based polyurethane hydrogels containing Cloisite® 30B, an organically modified clay mineral, was synthesized. Structure of nanocomposite hydrogels was determined using XRD technique. Its molecular dynamics was studied by means of NMR spectroscopy, DMA and DSC analysis. The mechanical properties and thermal stability of the systems were improved by incorporation of clay and controlled by varying the clay content in polymeric matrix. Molecular dynamics of polymer chains depends on interaction of Cloisite® 30B nanoparticles with soft segments of polyurethanes. The characteristic nanosize effect is observed.

  14. Learning to Estimate Dynamical State with Probabilistic Population Codes.

    PubMed

    Makin, Joseph G; Dichter, Benjamin K; Sabes, Philip N

    2015-11-01

    Tracking moving objects, including one's own body, is a fundamental ability of higher organisms, playing a central role in many perceptual and motor tasks. While it is unknown how the brain learns to follow and predict the dynamics of objects, it is known that this process of state estimation can be learned purely from the statistics of noisy observations. When the dynamics are simply linear with additive Gaussian noise, the optimal solution is the well known Kalman filter (KF), the parameters of which can be learned via latent-variable density estimation (the EM algorithm). The brain does not, however, directly manipulate matrices and vectors, but instead appears to represent probability distributions with the firing rates of population of neurons, "probabilistic population codes." We show that a recurrent neural network-a modified form of an exponential family harmonium (EFH)-that takes a linear probabilistic population code as input can learn, without supervision, to estimate the state of a linear dynamical system. After observing a series of population responses (spike counts) to the position of a moving object, the network learns to represent the velocity of the object and forms nearly optimal predictions about the position at the next time-step. This result builds on our previous work showing that a similar network can learn to perform multisensory integration and coordinate transformations for static stimuli. The receptive fields of the trained network also make qualitative predictions about the developing and learning brain: tuning gradually emerges for higher-order dynamical states not explicitly present in the inputs, appearing as delayed tuning for the lower-order states.

  15. Sialyldisaccharide conformations: a molecular dynamics perspective

    NASA Astrophysics Data System (ADS)

    Selvin, Jeyasigamani F. A.; Priyadarzini, Thanu R. K.; Veluraja, Kasinadar

    2012-04-01

    Sialyldisaccharides are significant terminal components of glycoconjugates and their negative charge and conformation are extensively utilized in molecular recognition processes. The conformation and flexibility of four biologically important sialyldisaccharides [Neu5Acα(2-3)Gal, Neu5Acα(2-6)Gal, Neu5Acα(2-8)Neu5Ac and Neu5Acα(2-9)Neu5Ac] are studied using Molecular Dynamics simulations of 20 ns duration to deduce the conformational preferences of the sialyldisaccharides and the interactions which stabilize the conformations. This study clearly describes the possible conformational models of sialyldisaccharides deduced from 20 ns Molecular Dynamics simulations and our results confirm the role of water in the structural stabilization of sialyldisaccharides. An extensive analysis on the sialyldisaccharide structures available in PDB also confirms the conformational regions found by experiments are detected in MD simulations of 20 ns duration. The three dimensional structural coordinates for all the MD derived sialyldisaccharide conformations are deposited in the 3DSDSCAR database and these conformational models will be useful for glycobiologists and biotechnologists to understand the biological functions of sialic acid containing glycoconjugates.

  16. Enhanced sampling techniques in molecular dynamics simulations of biological systems.

    PubMed

    Bernardi, Rafael C; Melo, Marcelo C R; Schulten, Klaus

    2015-05-01

    Molecular dynamics has emerged as an important research methodology covering systems to the level of millions of atoms. However, insufficient sampling often limits its application. The limitation is due to rough energy landscapes, with many local minima separated by high-energy barriers, which govern the biomolecular motion. In the past few decades methods have been developed that address the sampling problem, such as replica-exchange molecular dynamics, metadynamics and simulated annealing. Here we present an overview over theses sampling methods in an attempt to shed light on which should be selected depending on the type of system property studied. Enhanced sampling methods have been employed for a broad range of biological systems and the choice of a suitable method is connected to biological and physical characteristics of the system, in particular system size. While metadynamics and replica-exchange molecular dynamics are the most adopted sampling methods to study biomolecular dynamics, simulated annealing is well suited to characterize very flexible systems. The use of annealing methods for a long time was restricted to simulation of small proteins; however, a variant of the method, generalized simulated annealing, can be employed at a relatively low computational cost to large macromolecular complexes. Molecular dynamics trajectories frequently do not reach all relevant conformational substates, for example those connected with biological function, a problem that can be addressed by employing enhanced sampling algorithms. This article is part of a Special Issue entitled Recent developments of molecular dynamics. Copyright © 2014 Elsevier B.V. All rights reserved.

  17. Molecular dynamics simulations of metallic friction and of its dependence on electric currents - development and first results

    NASA Astrophysics Data System (ADS)

    Meintanis, Evangelos Anastasios

    We have extended the HOLA molecular dynamics (MD) code to run slider-on-block friction experiments for Al and Cu. Both objects are allowed to evolve freely and show marked deformation despite the hardness difference. We recover realistic coefficients of friction and verify the importance of cold-welding and plastic deformations in dry sliding friction. Our first data also show a mechanism for decoupling between load and friction at high velocities. Such a mechanism can explain an increase in the coefficient of friction of metals with velocity. The study of the effects of currents on our system required the development of a suitable electrodynamic (ED) solver, as the disparity of MD and ED time scales threatened the efficiency of our code. Our first simulations combining ED and MD are presented.

  18. Coarse-Grained Molecular Dynamics Simulation of Ionic Polymer Networks

    DTIC Science & Technology

    2008-07-01

    AFRL-RX-WP-TP-2009-4198 COARSE-GRAINED MOLECULAR DYNAMICS SIMULATION OF IONIC POLYMER NETWORKS (Postprint) T.E. Dirama, V. Varshney, K.L...GRAINED MOLECULAR DYNAMICS SIMULATION OF IONIC POLYMER NETWORKS (Postprint) 5a. CONTRACT NUMBER FA8650-05-D-5807-0052 5b. GRANT NUMBER 5c...We studied two types of networks which differ only by one containing ionic pairs that amount to 7% of the total number of bonds present. The stress

  19. GANDALF - Graphical Astrophysics code for N-body Dynamics And Lagrangian Fluids

    NASA Astrophysics Data System (ADS)

    Hubber, D. A.; Rosotti, G. P.; Booth, R. A.

    2018-01-01

    GANDALF is a new hydrodynamics and N-body dynamics code designed for investigating planet formation, star formation and star cluster problems. GANDALF is written in C++, parallelized with both OPENMP and MPI and contains a PYTHON library for analysis and visualization. The code has been written with a fully object-oriented approach to easily allow user-defined implementations of physics modules or other algorithms. The code currently contains implementations of smoothed particle hydrodynamics, meshless finite-volume and collisional N-body schemes, but can easily be adapted to include additional particle schemes. We present in this paper the details of its implementation, results from the test suite, serial and parallel performance results and discuss the planned future development. The code is freely available as an open source project on the code-hosting website github at https://github.com/gandalfcode/gandalf and is available under the GPLv2 license.

  20. Thermostatted molecular dynamics: How to avoid the Toda demon hidden in Nose-Hoover dynamics

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Holian, B.L.; Voter, A.F.; Ravelo, R.

    The Nose-Hoover thermostat, which is often used in the hope of modifying molecular dynamics trajectories in order to achieve canonical-ensemble averages, has hidden in it a Toda ``demon,`` which can give rise to unwanted, noncanonical undulations in the instantaneous kinetic temperature. We show how these long-lived oscillations arise from insufficient coupling of the thermostat to the atoms, and give straightforward, practical procedures for avoiding this weak-coupling pathology in isothermal molecular dynamics simulations.

  1. Molecular dynamics studies of a hexameric purine nucleoside phosphorylase.

    PubMed

    Zanchi, Fernando Berton; Caceres, Rafael Andrade; Stabeli, Rodrigo Guerino; de Azevedo, Walter Filgueira

    2010-03-01

    Purine nucleoside phosphorylase (PNP) (EC.2.4.2.1) is an enzyme that catalyzes the cleavage of N-ribosidic bonds of the purine ribonucleosides and 2-deoxyribonucleosides in the presence of inorganic orthophosphate as a second substrate. This enzyme is involved in purine-salvage pathway and has been proposed as a promising target for design and development of antimalarial and antibacterial drugs. Recent elucidation of the three-dimensional structure of PNP by X-ray protein crystallography left open the possibility of structure-based virtual screening initiatives in combination with molecular dynamics simulations focused on identification of potential new antimalarial drugs. Most of the previously published molecular dynamics simulations of PNP were carried out on human PNP, a trimeric PNP. The present article describes for the first time molecular dynamics simulations of hexameric PNP from Plasmodium falciparum (PfPNP). Two systems were simulated in the present work, PfPNP in ligand free form, and in complex with immucillin and sulfate. Based on the dynamical behavior of both systems the main results related to structural stability and protein-drug interactions are discussed.

  2. The Computer Simulation of Liquids by Molecular Dynamics.

    ERIC Educational Resources Information Center

    Smith, W.

    1987-01-01

    Proposes a mathematical computer model for the behavior of liquids using the classical dynamic principles of Sir Isaac Newton and the molecular dynamics method invented by other scientists. Concludes that other applications will be successful using supercomputers to go beyond simple Newtonian physics. (CW)

  3. GPCRs: What Can We Learn from Molecular Dynamics Simulations?

    PubMed

    Velgy, Naushad; Hedger, George; Biggin, Philip C

    2018-01-01

    Advances in the structural biology of G-protein Coupled Receptors have resulted in a significant step forward in our understanding of how this important class of drug targets function at the molecular level. However, it has also become apparent that they are very dynamic molecules, and moreover, that the underlying dynamics is crucial in shaping the response to different ligands. Molecular dynamics simulations can provide unique insight into the dynamic properties of GPCRs in a way that is complementary to many experimental approaches. In this chapter, we describe progress in three distinct areas that are particularly difficult to study with other techniques: atomic level investigation of the conformational changes that occur when moving between the various states that GPCRs can exist in, the pathways that ligands adopt during binding/unbinding events and finally, the influence of lipids on the conformational dynamics of GPCRs.

  4. Molecular codes for neuronal individuality and cell assembly in the brain

    PubMed Central

    Yagi, Takeshi

    2012-01-01

    The brain contains an enormous, but finite, number of neurons. The ability of this limited number of neurons to produce nearly limitless neural information over a lifetime is typically explained by combinatorial explosion; that is, by the exponential amplification of each neuron's contribution through its incorporation into “cell assemblies” and neural networks. In development, each neuron expresses diverse cellular recognition molecules that permit the formation of the appropriate neural cell assemblies to elicit various brain functions. The mechanism for generating neuronal assemblies and networks must involve molecular codes that give neurons individuality and allow them to recognize one another and join appropriate networks. The extensive molecular diversity of cell-surface proteins on neurons is likely to contribute to their individual identities. The clustered protocadherins (Pcdh) is a large subfamily within the diverse cadherin superfamily. The clustered Pcdh genes are encoded in tandem by three gene clusters, and are present in all known vertebrate genomes. The set of clustered Pcdh genes is expressed in a random and combinatorial manner in each neuron. In addition, cis-tetramers composed of heteromultimeric clustered Pcdh isoforms represent selective binding units for cell-cell interactions. Here I present the mathematical probabilities for neuronal individuality based on the random and combinatorial expression of clustered Pcdh isoforms and their formation of cis-tetramers in each neuron. Notably, clustered Pcdh gene products are known to play crucial roles in correct axonal projections, synaptic formation, and neuronal survival. Their molecular and biological features induce a hypothesis that the diverse clustered Pcdh molecules provide the molecular code by which neuronal individuality and cell assembly permit the combinatorial explosion of networks that supports enormous processing capability and plasticity of the brain. PMID:22518100

  5. Conformational Sampling and Nucleotide-Dependent Transitions of the GroEL Subunit Probed by Unbiased Molecular Dynamics Simulations

    PubMed Central

    Skjaerven, Lars; Grant, Barry; Muga, Arturo; Teigen, Knut; McCammon, J. Andrew; Reuter, Nathalie; Martinez, Aurora

    2011-01-01

    GroEL is an ATP dependent molecular chaperone that promotes the folding of a large number of substrate proteins in E. coli. Large-scale conformational transitions occurring during the reaction cycle have been characterized from extensive crystallographic studies. However, the link between the observed conformations and the mechanisms involved in the allosteric response to ATP and the nucleotide-driven reaction cycle are not completely established. Here we describe extensive (in total long) unbiased molecular dynamics (MD) simulations that probe the response of GroEL subunits to ATP binding. We observe nucleotide dependent conformational transitions, and show with multiple 100 ns long simulations that the ligand-induced shift in the conformational populations are intrinsically coded in the structure-dynamics relationship of the protein subunit. Thus, these simulations reveal a stabilization of the equatorial domain upon nucleotide binding and a concomitant “opening” of the subunit, which reaches a conformation close to that observed in the crystal structure of the subunits within the ADP-bound oligomer. Moreover, we identify changes in a set of unique intrasubunit interactions potentially important for the conformational transition. PMID:21423709

  6. Development of a CFD Code for Analysis of Fluid Dynamic Forces in Seals

    NASA Technical Reports Server (NTRS)

    Athavale, Mahesh M.; Przekwas, Andrzej J.; Singhal, Ashok K.

    1991-01-01

    The aim is to develop a 3-D computational fluid dynamics (CFD) code for the analysis of fluid flow in cylindrical seals and evaluation of the dynamic forces on the seals. This code is expected to serve as a scientific tool for detailed flow analysis as well as a check for the accuracy of the 2D industrial codes. The features necessary in the CFD code are outlined. The initial focus was to develop or modify and implement new techniques and physical models. These include collocated grid formulation, rotating coordinate frames and moving grid formulation. Other advanced numerical techniques include higher order spatial and temporal differencing and an efficient linear equation solver. These techniques were implemented in a 2D flow solver for initial testing. Several benchmark test cases were computed using the 2D code, and the results of these were compared to analytical solutions or experimental data to check the accuracy. Tests presented here include planar wedge flow, flow due to an enclosed rotor, and flow in a 2D seal with a whirling rotor. Comparisons between numerical and experimental results for an annular seal and a 7-cavity labyrinth seal are also included.

  7. Masses, luminosities and dynamics of galactic molecular clouds

    NASA Technical Reports Server (NTRS)

    Solomon, P. M.; Rivolo, A. R.; Mooney, T. J.; Barrett, J. W.; Sage, L. J.

    1987-01-01

    Star formation in galaxies takes place in molecular clouds and the Milky Way is the only galaxy in which it is possible to resolve and study the physical properties and star formation activity of individual clouds. The masses, luminosities, dynamics, and distribution of molecular clouds, primarily giant molecular clouds in the Milky Way are described and analyzed. The observational data sets are the Massachusetts-Stony Brook CO Galactic Plane Survey and the IRAS far IR images. The molecular mass and infrared luminosities of glactic clouds are then compared with the molecular mass and infrared luminosities of external galaxies.

  8. A Force Balanced Fragmentation Method for ab Initio Molecular Dynamic Simulation of Protein.

    PubMed

    Xu, Mingyuan; Zhu, Tong; Zhang, John Z H

    2018-01-01

    A force balanced generalized molecular fractionation with conjugate caps (FB-GMFCC) method is proposed for ab initio molecular dynamic simulation of proteins. In this approach, the energy of the protein is computed by a linear combination of the QM energies of individual residues and molecular fragments that account for the two-body interaction of hydrogen bond between backbone peptides. The atomic forces on the caped H atoms were corrected to conserve the total force of the protein. Using this approach, ab initio molecular dynamic simulation of an Ace-(ALA) 9 -NME linear peptide showed the conservation of the total energy of the system throughout the simulation. Further a more robust 110 ps ab initio molecular dynamic simulation was performed for a protein with 56 residues and 862 atoms in explicit water. Compared with the classical force field, the ab initio molecular dynamic simulations gave better description of the geometry of peptide bonds. Although further development is still needed, the current approach is highly efficient, trivially parallel, and can be applied to ab initio molecular dynamic simulation study of large proteins.

  9. Energy conserving, linear scaling Born-Oppenheimer molecular dynamics.

    PubMed

    Cawkwell, M J; Niklasson, Anders M N

    2012-10-07

    Born-Oppenheimer molecular dynamics simulations with long-term conservation of the total energy and a computational cost that scales linearly with system size have been obtained simultaneously. Linear scaling with a low pre-factor is achieved using density matrix purification with sparse matrix algebra and a numerical threshold on matrix elements. The extended Lagrangian Born-Oppenheimer molecular dynamics formalism [A. M. N. Niklasson, Phys. Rev. Lett. 100, 123004 (2008)] yields microcanonical trajectories with the approximate forces obtained from the linear scaling method that exhibit no systematic drift over hundreds of picoseconds and which are indistinguishable from trajectories computed using exact forces.

  10. General framework for constraints in molecular dynamics simulations

    NASA Astrophysics Data System (ADS)

    Kneller, Gerald R.

    2017-06-01

    The article presents a theoretical framework for molecular dynamics simulations of complex systems subject to any combination of holonomic and non-holonomic constraints. Using the concept of constrained inverse matrices both the particle accelerations and the associated constraint forces can be determined from given external forces and kinematical conditions. The formalism enables in particular the construction of explicit kinematical conditions which lead to the well-known Nosé-Hoover type equations of motion for the simulation of non-standard molecular dynamics ensembles. Illustrations are given for a few examples and an outline is presented for a numerical implementation of the method.

  11. Better, Cheaper, Faster Molecular Dynamics

    NASA Technical Reports Server (NTRS)

    Pohorille, Andrew; DeVincenzi, Donald L. (Technical Monitor)

    2001-01-01

    Recent, revolutionary progress in genomics and structural, molecular and cellular biology has created new opportunities for molecular-level computer simulations of biological systems by providing vast amounts of data that require interpretation. These opportunities are further enhanced by the increasing availability of massively parallel computers. For many problems, the method of choice is classical molecular dynamics (iterative solving of Newton's equations of motion). It focuses on two main objectives. One is to calculate the relative stability of different states of the system. A typical problem that has' such an objective is computer-aided drug design. Another common objective is to describe evolution of the system towards a low energy (possibly the global minimum energy), "native" state. Perhaps the best example of such a problem is protein folding. Both types of problems share the same difficulty. Often, different states of the system are separated by high energy barriers, which implies that transitions between these states are rare events. This, in turn, can greatly impede exploration of phase space. In some instances this can lead to "quasi non-ergodicity", whereby a part of phase space is inaccessible on time scales of the simulation. To overcome this difficulty and to extend molecular dynamics to "biological" time scales (millisecond or longer) new physical formulations and new algorithmic developments are required. To be efficient they should account for natural limitations of multi-processor computer architecture. I will present work along these lines done in my group. In particular, I will focus on a new approach to calculating the free energies (stability) of different states and to overcoming "the curse of rare events". I will also discuss algorithmic improvements to multiple time step methods and to the treatment of slowly decaying, log-ranged, electrostatic effects.

  12. CoCoNuT: General relativistic hydrodynamics code with dynamical space-time evolution

    NASA Astrophysics Data System (ADS)

    Dimmelmeier, Harald; Novak, Jérôme; Cerdá-Durán, Pablo

    2012-02-01

    CoCoNuT is a general relativistic hydrodynamics code with dynamical space-time evolution. The main aim of this numerical code is the study of several astrophysical scenarios in which general relativity can play an important role, namely the collapse of rapidly rotating stellar cores and the evolution of isolated neutron stars. The code has two flavors: CoCoA, the axisymmetric (2D) magnetized version, and CoCoNuT, the 3D non-magnetized version.

  13. Quantum Fragment Based ab Initio Molecular Dynamics for Proteins.

    PubMed

    Liu, Jinfeng; Zhu, Tong; Wang, Xianwei; He, Xiao; Zhang, John Z H

    2015-12-08

    Developing ab initio molecular dynamics (AIMD) methods for practical application in protein dynamics is of significant interest. Due to the large size of biomolecules, applying standard quantum chemical methods to compute energies for dynamic simulation is computationally prohibitive. In this work, a fragment based ab initio molecular dynamics approach is presented for practical application in protein dynamics study. In this approach, the energy and forces of the protein are calculated by a recently developed electrostatically embedded generalized molecular fractionation with conjugate caps (EE-GMFCC) method. For simulation in explicit solvent, mechanical embedding is introduced to treat protein interaction with explicit water molecules. This AIMD approach has been applied to MD simulations of a small benchmark protein Trpcage (with 20 residues and 304 atoms) in both the gas phase and in solution. Comparison to the simulation result using the AMBER force field shows that the AIMD gives a more stable protein structure in the simulation, indicating that quantum chemical energy is more reliable. Importantly, the present fragment-based AIMD simulation captures quantum effects including electrostatic polarization and charge transfer that are missing in standard classical MD simulations. The current approach is linear-scaling, trivially parallel, and applicable to performing the AIMD simulation of proteins with a large size.

  14. Laser-enhanced dynamics in molecular rate processes

    NASA Technical Reports Server (NTRS)

    George, T. F.; Zimmerman, I. H.; Devries, P. L.; Yuan, J.-M.; Lam, K.-S.; Bellum, J. C.; Lee, H.-W.; Slutsky, M. S.

    1978-01-01

    The present discussion deals with some theoretical aspects associated with the description of molecular rate processes in the presence of intense laser radiation, where the radiation actually interacts with the molecular dynamics. Whereas for weak and even moderately intense radiation, the absorption and stimulated emission of photons by a molecular system can be described by perturbative methods, for intense radiation, perturbation theory is usually not adequate. Limiting the analysis to the gas phase, an attempt is made to describe nonperturbative approaches applicable to the description of such processes (in the presence of intense laser radiation) as electronic energy transfer in molecular (in particular atom-atom) collisions; collision-induced ionization and emission; and unimolecular dissociation.

  15. Learning to Estimate Dynamical State with Probabilistic Population Codes

    PubMed Central

    Sabes, Philip N.

    2015-01-01

    Tracking moving objects, including one’s own body, is a fundamental ability of higher organisms, playing a central role in many perceptual and motor tasks. While it is unknown how the brain learns to follow and predict the dynamics of objects, it is known that this process of state estimation can be learned purely from the statistics of noisy observations. When the dynamics are simply linear with additive Gaussian noise, the optimal solution is the well known Kalman filter (KF), the parameters of which can be learned via latent-variable density estimation (the EM algorithm). The brain does not, however, directly manipulate matrices and vectors, but instead appears to represent probability distributions with the firing rates of population of neurons, “probabilistic population codes.” We show that a recurrent neural network—a modified form of an exponential family harmonium (EFH)—that takes a linear probabilistic population code as input can learn, without supervision, to estimate the state of a linear dynamical system. After observing a series of population responses (spike counts) to the position of a moving object, the network learns to represent the velocity of the object and forms nearly optimal predictions about the position at the next time-step. This result builds on our previous work showing that a similar network can learn to perform multisensory integration and coordinate transformations for static stimuli. The receptive fields of the trained network also make qualitative predictions about the developing and learning brain: tuning gradually emerges for higher-order dynamical states not explicitly present in the inputs, appearing as delayed tuning for the lower-order states. PMID:26540152

  16. Overcoming free energy barriers using unconstrained molecular dynamics simulations.

    PubMed

    Hénin, Jérôme; Chipot, Christophe

    2004-08-15

    Association of unconstrained molecular dynamics (MD) and the formalisms of thermodynamic integration and average force [Darve and Pohorille, J. Chem. Phys. 115, 9169 (2001)] have been employed to determine potentials of mean force. When implemented in a general MD code, the additional computational effort, compared to other standard, unconstrained simulations, is marginal. The force acting along a chosen reaction coordinate xi is estimated from the individual forces exerted on the chemical system and accumulated as the simulation progresses. The estimated free energy derivative computed for small intervals of xi is canceled by an adaptive bias to overcome the barriers of the free energy landscape. Evolution of the system along the reaction coordinate is, thus, limited by its sole self-diffusion properties. The illustrative examples of the reversible unfolding of deca-L-alanine, the association of acetate and guanidinium ions in water, the dimerization of methane in water, and its transfer across the water liquid-vapor interface are examined to probe the efficiency of the method. (c) 2004 American Institute of Physics.

  17. Structure and dynamics of complex liquid water: Molecular dynamics simulation

    NASA Astrophysics Data System (ADS)

    S, Indrajith V.; Natesan, Baskaran

    2015-06-01

    We have carried out detailed structure and dynamical studies of complex liquid water using molecular dynamics simulations. Three different model potentials, namely, TIP3P, TIP4P and SPC-E have been used in the simulations, in order to arrive at the best possible potential function that could reproduce the structure of experimental bulk water. All the simulations were performed in the NVE micro canonical ensemble using LAMMPS. The radial distribution functions, gOO, gOH and gHH and the self diffusion coefficient, Ds, were calculated for all three models. We conclude from our results that the structure and dynamical parameters obtained for SPC-E model matched well with the experimental values, suggesting that among the models studied here, the SPC-E model gives the best structure and dynamics of bulk water.

  18. Addressing the challenges of standalone multi-core simulations in molecular dynamics

    NASA Astrophysics Data System (ADS)

    Ocaya, R. O.; Terblans, J. J.

    2017-07-01

    Computational modelling in material science involves mathematical abstractions of force fields between particles with the aim to postulate, develop and understand materials by simulation. The aggregated pairwise interactions of the material's particles lead to a deduction of its macroscopic behaviours. For practically meaningful macroscopic scales, a large amount of data are generated, leading to vast execution times. Simulation times of hours, days or weeks for moderately sized problems are not uncommon. The reduction of simulation times, improved result accuracy and the associated software and hardware engineering challenges are the main motivations for many of the ongoing researches in the computational sciences. This contribution is concerned mainly with simulations that can be done on a "standalone" computer based on Message Passing Interfaces (MPI), parallel code running on hardware platforms with wide specifications, such as single/multi- processor, multi-core machines with minimal reconfiguration for upward scaling of computational power. The widely available, documented and standardized MPI library provides this functionality through the MPI_Comm_size (), MPI_Comm_rank () and MPI_Reduce () functions. A survey of the literature shows that relatively little is written with respect to the efficient extraction of the inherent computational power in a cluster. In this work, we discuss the main avenues available to tap into this extra power without compromising computational accuracy. We also present methods to overcome the high inertia encountered in single-node-based computational molecular dynamics. We begin by surveying the current state of the art and discuss what it takes to achieve parallelism, efficiency and enhanced computational accuracy through program threads and message passing interfaces. Several code illustrations are given. The pros and cons of writing raw code as opposed to using heuristic, third-party code are also discussed. The growing trend

  19. Investigation of neutral particle dynamics in Aditya tokamak plasma with DEGAS2 code

    NASA Astrophysics Data System (ADS)

    Dey, Ritu; Ghosh, Joydeep; Chowdhuri, M. B.; Manchanda, R.; Banerjee, S.; Ramaiya, N.; Sharma, Deepti; Srinivasan, R.; Stotler, D. P.; Aditya Team

    2017-08-01

    Neutral particle behavior in Aditya tokamak, which has a circular poloidal ring limiter at one particular toroidal location, has been investigated using DEGAS2 code. The code is based on the calculation using Monte Carlo algorithms and is mainly used in tokamaks with divertor configuration. This code has been successfully implemented in Aditya tokamak with limiter configuration. The penetration of neutral hydrogen atom is studied with various atomic and molecular contributions and it is found that the maximum contribution comes from the dissociation processes. For the same, H α spectrum is also simulated and matched with the experimental one. The dominant contribution around 64% comes from molecular dissociation processes and neutral particle is generated by those processes have energy of ~2.0 eV. Furthermore, the variation of neutral hydrogen density and H α emissivity profile are analysed for various edge temperature profiles and found that there is not much changes in H α emission at the plasma edge with the variation of edge temperature (7-40 eV).

  20. Investigation of neutral particle dynamics in Aditya tokamak plasma with DEGAS2 code

    DOE PAGES

    Dey, Ritu; Ghosh, Joydeep; Chowdhuri, M. B.; ...

    2017-06-09

    Neutral particle behavior in Aditya tokamak, which has a circular poloidal ring limiter at one particular toroidal location, has been investigated using DEGAS2 code. The code is based on the calculation using Monte Carlo algorithms and is mainly used in tokamaks with divertor configuration. This code has been successfully implemented in Aditya tokamak with limiter configuration. The penetration of neutral hydrogen atom is studied with various atomic and molecular contributions and it is found that the maximum contribution comes from the dissociation processes. For the same, H α spectrum is also simulated which was matched with the experimental one. Themore » dominant contribution around 64% comes from molecular dissociation processes and neutral particle is generated by those processes have energy of ~ 2.0 eV. Furthermore, the variation of neutral hydrogen density and H α emissivity profile are analysed for various edge temperature profiles and found that there is not much changes in H α emission at the plasma edge with the variation of edge temperature (7 to 40 eV).« less

  1. Phase synchronization motion and neural coding in dynamic transmission of neural information.

    PubMed

    Wang, Rubin; Zhang, Zhikang; Qu, Jingyi; Cao, Jianting

    2011-07-01

    In order to explore the dynamic characteristics of neural coding in the transmission of neural information in the brain, a model of neural network consisting of three neuronal populations is proposed in this paper using the theory of stochastic phase dynamics. Based on the model established, the neural phase synchronization motion and neural coding under spontaneous activity and stimulation are examined, for the case of varying network structure. Our analysis shows that, under the condition of spontaneous activity, the characteristics of phase neural coding are unrelated to the number of neurons participated in neural firing within the neuronal populations. The result of numerical simulation supports the existence of sparse coding within the brain, and verifies the crucial importance of the magnitudes of the coupling coefficients in neural information processing as well as the completely different information processing capability of neural information transmission in both serial and parallel couplings. The result also testifies that under external stimulation, the bigger the number of neurons in a neuronal population, the more the stimulation influences the phase synchronization motion and neural coding evolution in other neuronal populations. We verify numerically the experimental result in neurobiology that the reduction of the coupling coefficient between neuronal populations implies the enhancement of lateral inhibition function in neural networks, with the enhancement equivalent to depressing neuronal excitability threshold. Thus, the neuronal populations tend to have a stronger reaction under the same stimulation, and more neurons get excited, leading to more neurons participating in neural coding and phase synchronization motion.

  2. Modeling of crack growth under mixed-mode loading by a molecular dynamics method and a linear fracture mechanics approach

    NASA Astrophysics Data System (ADS)

    Stepanova, L. V.

    2017-12-01

    Atomistic simulations of the central crack growth process in an infinite plane medium under mixed-mode loading using Large-Scale Atomic/Molecular Massively Parallel Simulator (LAMMPS), a classical molecular dynamics code, are performed. The inter-atomic potential used in this investigation is the Embedded Atom Method (EAM) potential. Plane specimens with an initial central crack are subjected to mixed-mode loadings. The simulation cell contains 400,000 atoms. The crack propagation direction angles under different values of the mixity parameter in a wide range of values from pure tensile loading to pure shear loading in a wide range of temperatures (from 0.1 K to 800 K) are obtained and analyzed. It is shown that the crack propagation direction angles obtained by molecular dynamics coincide with the crack propagation direction angles given by the multi-parameter fracture criteria based on the strain energy density and the multi-parameter description of the crack-tip fields. The multi-parameter fracture criteria are based on the multi-parameter stress field description taking into account the higher order terms of the Williams series expansion of the crack tip fields.

  3. Dynamic properties of molecular motors in burnt-bridge models

    NASA Astrophysics Data System (ADS)

    Artyomov, Maxim N.; Morozov, Alexander Yu; Pronina, Ekaterina; Kolomeisky, Anatoly B.

    2007-08-01

    Dynamic properties of molecular motors that fuel their motion by actively interacting with underlying molecular tracks are studied theoretically via discrete-state stochastic 'burnt-bridge' models. The transport of the particles is viewed as an effective diffusion along one-dimensional lattices with periodically distributed weak links. When an unbiased random walker passes the weak link it can be destroyed ('burned') with probability p, providing a bias in the motion of the molecular motor. We present a theoretical approach that allows one to calculate exactly all dynamic properties of motor proteins, such as velocity and dispersion, under general conditions. It is found that dispersion is a decreasing function of the concentration of bridges, while the dependence of dispersion on the burning probability is more complex. Our calculations also show a gap in dispersion for very low concentrations of weak links or for very low burning probabilities which indicates a dynamic phase transition between unbiased and biased diffusion regimes. Theoretical findings are supported by Monte Carlo computer simulations.

  4. Extended Lagrangian Density Functional Tight-Binding Molecular Dynamics for Molecules and Solids.

    PubMed

    Aradi, Bálint; Niklasson, Anders M N; Frauenheim, Thomas

    2015-07-14

    A computationally fast quantum mechanical molecular dynamics scheme using an extended Lagrangian density functional tight-binding formulation has been developed and implemented in the DFTB+ electronic structure program package for simulations of solids and molecular systems. The scheme combines the computational speed of self-consistent density functional tight-binding theory with the efficiency and long-term accuracy of extended Lagrangian Born-Oppenheimer molecular dynamics. For systems without self-consistent charge instabilities, only a single diagonalization or construction of the single-particle density matrix is required in each time step. The molecular dynamics simulation scheme can be applied to a broad range of problems in materials science, chemistry, and biology.

  5. Easy GROMACS: A Graphical User Interface for GROMACS Molecular Dynamics Simulation Package

    NASA Astrophysics Data System (ADS)

    Dizkirici, Ayten; Tekpinar, Mustafa

    2015-03-01

    GROMACS is a widely used molecular dynamics simulation package. Since it is a command driven program, it is difficult to use this program for molecular biologists, biochemists, new graduate students and undergraduate researchers who are interested in molecular dynamics simulations. To alleviate the problem for those researchers, we wrote a graphical user interface that simplifies protein preparation for a classical molecular dynamics simulation. Our program can work with various GROMACS versions and it can perform essential analyses of GROMACS trajectories as well as protein preparation. We named our open source program `Easy GROMACS'. Easy GROMACS can give researchers more time for scientific research instead of dealing with technical intricacies.

  6. NMR investigations of molecular dynamics

    NASA Astrophysics Data System (ADS)

    Palmer, Arthur

    2011-03-01

    NMR spectroscopy is a powerful experimental approach for characterizing protein conformational dynamics on multiple time scales. The insights obtained from NMR studies are complemented and by molecular dynamics (MD) simulations, which provide full atomistic details of protein dynamics. Homologous mesophilic (E. coli) and thermophilic (T. thermophilus) ribonuclease H (RNase H) enzymes serve to illustrate how changes in protein sequence and structure that affect conformational dynamic processes can be monitored and characterized by joint analysis of NMR spectroscopy and MD simulations. A Gly residue inserted within a putative hinge between helices B and C is conserved among thermophilic RNases H, but absent in mesophilic RNases H. Experimental spin relaxation measurements show that the dynamic properties of T. thermophilus RNase H are recapitulated in E. coli RNase H by insertion of a Gly residue between helices B and C. Additional specific intramolecular interactions that modulate backbone and sidechain dynamical properties of the Gly-rich loop and of the conserved Trp residue flanking the Gly insertion site have been identified using MD simulations and subsequently confirmed by NMR spin relaxation measurements. These results emphasize the importance of hydrogen bonds and local steric interactions in restricting conformational fluctuations, and the absence of such interactions in allowing conformational adaptation to substrate binding.

  7. Design and implementation of a scene-dependent dynamically selfadaptable wavefront coding imaging system

    NASA Astrophysics Data System (ADS)

    Carles, Guillem; Ferran, Carme; Carnicer, Artur; Bosch, Salvador

    2012-01-01

    A computational imaging system based on wavefront coding is presented. Wavefront coding provides an extension of the depth-of-field at the expense of a slight reduction of image quality. This trade-off results from the amount of coding used. By using spatial light modulators, a flexible coding is achieved which permits it to be increased or decreased as needed. In this paper a computational method is proposed for evaluating the output of a wavefront coding imaging system equipped with a spatial light modulator, with the aim of thus making it possible to implement the most suitable coding strength for a given scene. This is achieved in an unsupervised manner, thus the whole system acts as a dynamically selfadaptable imaging system. The program presented here controls the spatial light modulator and the camera, and also processes the images in a synchronised way in order to implement the dynamic system in real time. A prototype of the system was implemented in the laboratory and illustrative examples of the performance are reported in this paper. Program summaryProgram title: DynWFC (Dynamic WaveFront Coding) Catalogue identifier: AEKC_v1_0 Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AEKC_v1_0.html Program obtainable from: CPC Program Library, Queen's University, Belfast, N. Ireland Licensing provisions: Standard CPC licence, http://cpc.cs.qub.ac.uk/licence/licence.html No. of lines in distributed program, including test data, etc.: 10 483 No. of bytes in distributed program, including test data, etc.: 2 437 713 Distribution format: tar.gz Programming language: Labview 8.5 and NI Vision and MinGW C Compiler Computer: Tested on PC Intel ® Pentium ® Operating system: Tested on Windows XP Classification: 18 Nature of problem: The program implements an enhanced wavefront coding imaging system able to adapt the degree of coding to the requirements of a specific scene. The program controls the acquisition by a camera, the display of a spatial light modulator

  8. Electronic Spectra from Molecular Dynamics: A Simple Approach.

    DTIC Science & Technology

    1983-10-01

    82.30.Cr. 33.20K. S2.40.1s The authors provided phototypeset copy for this paper using REFER TlL EON, TOFF On UNIX I ELECTRONIC SPECTRA FROM MOLECULAR...Alamos National Laboratory Los Alamos, NM 87545 I. INTRODUCTION In this paper we show how molecular dynamics can be used in a simple manner to com...could equally use Monte Carlo or explicit integration over coordinates to compute equilibrium electronic absorption bands. How- ever, molecular

  9. Gaussian Accelerated Molecular Dynamics: Theory, Implementation, and Applications

    PubMed Central

    Miao, Yinglong; McCammon, J. Andrew

    2018-01-01

    A novel Gaussian Accelerated Molecular Dynamics (GaMD) method has been developed for simultaneous unconstrained enhanced sampling and free energy calculation of biomolecules. Without the need to set predefined reaction coordinates, GaMD enables unconstrained enhanced sampling of the biomolecules. Furthermore, by constructing a boost potential that follows a Gaussian distribution, accurate reweighting of GaMD simulations is achieved via cumulant expansion to the second order. The free energy profiles obtained from GaMD simulations allow us to identify distinct low energy states of the biomolecules and characterize biomolecular structural dynamics quantitatively. In this chapter, we present the theory of GaMD, its implementation in the widely used molecular dynamics software packages (AMBER and NAMD), and applications to the alanine dipeptide biomolecular model system, protein folding, biomolecular large-scale conformational transitions and biomolecular recognition. PMID:29720925

  10. Molecular dynamics study of the conformational properties of cyclohexadecane

    NASA Astrophysics Data System (ADS)

    Zhang, Renshi; Mattice, Wayne L.

    1993-06-01

    Molecular dynamics has been used for the first time for the study of the conformational properties of cyclohexadecane, c-C16H32. By analyzing a long molecular dynamics trajectory (14.5 ns) at 450 K, equilibrium statistics such as the relative populations of different isomeric conformers and the probability ratios, p(gt)/p(tt), p(gg)/p(tt), and p(gg)/p(gtg), of different conformational segments, have been studied. The dynamic properties including the transition modes of gauche migration and gauche-pair creation, which have been reported before in n-alkanes, and the auto- and cross-correlations of the bond dihedral angles, have also been obtained. It was possible to make direct comparisons on some of the statistics with theory and experiment. Most of the results extracted from the molecular dynamics trajectory lie in between previously reported experimental and theoretical values. Many previously predicted conformers have been confirmed by our simulations. The results of the population probability of the most populated conformer seems to suggest that an earlier discrepancy between the theoretical works and an experimental work originates from insufficient samplings in earlier theoretical works, rather than from their inaccurate force field.

  11. Fast and flexible gpu accelerated binding free energy calculations within the amber molecular dynamics package.

    PubMed

    Mermelstein, Daniel J; Lin, Charles; Nelson, Gard; Kretsch, Rachael; McCammon, J Andrew; Walker, Ross C

    2018-07-15

    Alchemical free energy (AFE) calculations based on molecular dynamics (MD) simulations are key tools in both improving our understanding of a wide variety of biological processes and accelerating the design and optimization of therapeutics for numerous diseases. Computing power and theory have, however, long been insufficient to enable AFE calculations to be routinely applied in early stage drug discovery. One of the major difficulties in performing AFE calculations is the length of time required for calculations to converge to an ensemble average. CPU implementations of MD-based free energy algorithms can effectively only reach tens of nanoseconds per day for systems on the order of 50,000 atoms, even running on massively parallel supercomputers. Therefore, converged free energy calculations on large numbers of potential lead compounds are often untenable, preventing researchers from gaining crucial insight into molecular recognition, potential druggability and other crucial areas of interest. Graphics Processing Units (GPUs) can help address this. We present here a seamless GPU implementation, within the PMEMD module of the AMBER molecular dynamics package, of thermodynamic integration (TI) capable of reaching speeds of >140 ns/day for a 44,907-atom system, with accuracy equivalent to the existing CPU implementation in AMBER. The implementation described here is currently part of the AMBER 18 beta code and will be an integral part of the upcoming version 18 release of AMBER. © 2018 Wiley Periodicals, Inc. © 2018 Wiley Periodicals, Inc.

  12. Coarse-grained molecular dynamics simulations for giant protein-DNA complexes

    NASA Astrophysics Data System (ADS)

    Takada, Shoji

    Biomolecules are highly hierarchic and intrinsically flexible. Thus, computational modeling calls for multi-scale methodologies. We have been developing a coarse-grained biomolecular model where on-average 10-20 atoms are grouped into one coarse-grained (CG) particle. Interactions among CG particles are tuned based on atomistic interactions and the fluctuation matching algorithm. CG molecular dynamics methods enable us to simulate much longer time scale motions of much larger molecular systems than fully atomistic models. After broad sampling of structures with CG models, we can easily reconstruct atomistic models, from which one can continue conventional molecular dynamics simulations if desired. Here, we describe our CG modeling methodology for protein-DNA complexes, together with various biological applications, such as the DNA duplication initiation complex, model chromatins, and transcription factor dynamics on chromatin-like environment.

  13. EDITORIAL: 18th European Conference on Dynamics of Molecular Systems 18th European Conference on Dynamics of Molecular Systems

    NASA Astrophysics Data System (ADS)

    Varandas, A. J. C.

    2011-08-01

    This special section of Comments on Atomic, Molecular and Optical Physics (CAMOP) in Physica Scripta collects some of the papers that have been presented at the 18th European Conference on Dynamics of Molecular Systems MOLEC 2010 held in September 2010 in Curia, Portugal, as part of a series of biennial MOLEC conferences. This started in 1976 in Trento, Italy, and has continued, visiting 17 cities in 11 countries, namely Denmark, The Netherlands, Israel, France, Italy, Germany, Czech Republic, Spain, United Kingdom, Turkey and Russia. Following the MOLEC tradition, the scientific programme of the Curia meeting focused on experimental and theoretical studies of molecular interactions, collision dynamics, spectroscopy, and related fields. It included invited speakers from 22 countries, who were asked to summarize the problems reported in their presentations with the objective of revealing the current thinking of leading researchers in atomic, molecular and optical physics. It is hoped that their authoritative contributions presented in this CAMOP special section will also appeal to non-specialists through their clear and broad introductions to the field as well as references to the accessible literature. This CAMOP special section comprises ten contributions, which cover theoretical studies on the electronic structure of molecules and clusters as well as dynamics of elastic, inelastic and reactive encounters between atoms, molecules, ions, clusters and surfaces. Specifically, it includes electronic structure calculations using the traditional coupled-cluster method (Barreto et al 028111), the electron-attached equation-of-motion coupled cluster method (Hansen et al 028110), the diffusion Monte Carlo method (López-Durán et al 028107) and the path-integral Monte Carlo method (Barragán et al 028109). The contributions on molecular dynamics include on-the-fly quasi-classical trajectories on a five-atom molecule (Yu 028104), quantum reaction dynamics on triatomics

  14. Modelling and enhanced molecular dynamics to steer structure-based drug discovery.

    PubMed

    Kalyaanamoorthy, Subha; Chen, Yi-Ping Phoebe

    2014-05-01

    The ever-increasing gap between the availabilities of the genome sequences and the crystal structures of proteins remains one of the significant challenges to the modern drug discovery efforts. The knowledge of structure-dynamics-functionalities of proteins is important in order to understand several key aspects of structure-based drug discovery, such as drug-protein interactions, drug binding and unbinding mechanisms and protein-protein interactions. This review presents a brief overview on the different state of the art computational approaches that are applied for protein structure modelling and molecular dynamics simulations of biological systems. We give an essence of how different enhanced sampling molecular dynamics approaches, together with regular molecular dynamics methods, assist in steering the structure based drug discovery processes. Copyright © 2013 Elsevier Ltd. All rights reserved.

  15. Gaussian Accelerated Molecular Dynamics in NAMD

    PubMed Central

    2016-01-01

    Gaussian accelerated molecular dynamics (GaMD) is a recently developed enhanced sampling technique that provides efficient free energy calculations of biomolecules. Like the previous accelerated molecular dynamics (aMD), GaMD allows for “unconstrained” enhanced sampling without the need to set predefined collective variables and so is useful for studying complex biomolecular conformational changes such as protein folding and ligand binding. Furthermore, because the boost potential is constructed using a harmonic function that follows Gaussian distribution in GaMD, cumulant expansion to the second order can be applied to recover the original free energy profiles of proteins and other large biomolecules, which solves a long-standing energetic reweighting problem of the previous aMD method. Taken together, GaMD offers major advantages for both unconstrained enhanced sampling and free energy calculations of large biomolecules. Here, we have implemented GaMD in the NAMD package on top of the existing aMD feature and validated it on three model systems: alanine dipeptide, the chignolin fast-folding protein, and the M3 muscarinic G protein-coupled receptor (GPCR). For alanine dipeptide, while conventional molecular dynamics (cMD) simulations performed for 30 ns are poorly converged, GaMD simulations of the same length yield free energy profiles that agree quantitatively with those of 1000 ns cMD simulation. Further GaMD simulations have captured folding of the chignolin and binding of the acetylcholine (ACh) endogenous agonist to the M3 muscarinic receptor. The reweighted free energy profiles are used to characterize the protein folding and ligand binding pathways quantitatively. GaMD implemented in the scalable NAMD is widely applicable to enhanced sampling and free energy calculations of large biomolecules. PMID:28034310

  16. Gaussian Accelerated Molecular Dynamics in NAMD.

    PubMed

    Pang, Yui Tik; Miao, Yinglong; Wang, Yi; McCammon, J Andrew

    2017-01-10

    Gaussian accelerated molecular dynamics (GaMD) is a recently developed enhanced sampling technique that provides efficient free energy calculations of biomolecules. Like the previous accelerated molecular dynamics (aMD), GaMD allows for "unconstrained" enhanced sampling without the need to set predefined collective variables and so is useful for studying complex biomolecular conformational changes such as protein folding and ligand binding. Furthermore, because the boost potential is constructed using a harmonic function that follows Gaussian distribution in GaMD, cumulant expansion to the second order can be applied to recover the original free energy profiles of proteins and other large biomolecules, which solves a long-standing energetic reweighting problem of the previous aMD method. Taken together, GaMD offers major advantages for both unconstrained enhanced sampling and free energy calculations of large biomolecules. Here, we have implemented GaMD in the NAMD package on top of the existing aMD feature and validated it on three model systems: alanine dipeptide, the chignolin fast-folding protein, and the M 3 muscarinic G protein-coupled receptor (GPCR). For alanine dipeptide, while conventional molecular dynamics (cMD) simulations performed for 30 ns are poorly converged, GaMD simulations of the same length yield free energy profiles that agree quantitatively with those of 1000 ns cMD simulation. Further GaMD simulations have captured folding of the chignolin and binding of the acetylcholine (ACh) endogenous agonist to the M 3 muscarinic receptor. The reweighted free energy profiles are used to characterize the protein folding and ligand binding pathways quantitatively. GaMD implemented in the scalable NAMD is widely applicable to enhanced sampling and free energy calculations of large biomolecules.

  17. Extended Lagrangian Density Functional Tight-Binding Molecular Dynamics for Molecules and Solids

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Aradi, Bálint; Niklasson, Anders M. N.; Frauenheim, Thomas

    A computationally fast quantum mechanical molecular dynamics scheme using an extended Lagrangian density functional tight-binding formulation has been developed and implemented in the DFTB+ electronic structure program package for simulations of solids and molecular systems. The scheme combines the computational speed of self-consistent density functional tight-binding theory with the efficiency and long-term accuracy of extended Lagrangian Born–Oppenheimer molecular dynamics. Furthermore, for systems without self-consistent charge instabilities, only a single diagonalization or construction of the single-particle density matrix is required in each time step. The molecular dynamics simulation scheme can also be applied to a broad range of problems in materialsmore » science, chemistry, and biology.« less

  18. Extended Lagrangian Density Functional Tight-Binding Molecular Dynamics for Molecules and Solids

    DOE PAGES

    Aradi, Bálint; Niklasson, Anders M. N.; Frauenheim, Thomas

    2015-06-26

    A computationally fast quantum mechanical molecular dynamics scheme using an extended Lagrangian density functional tight-binding formulation has been developed and implemented in the DFTB+ electronic structure program package for simulations of solids and molecular systems. The scheme combines the computational speed of self-consistent density functional tight-binding theory with the efficiency and long-term accuracy of extended Lagrangian Born–Oppenheimer molecular dynamics. Furthermore, for systems without self-consistent charge instabilities, only a single diagonalization or construction of the single-particle density matrix is required in each time step. The molecular dynamics simulation scheme can also be applied to a broad range of problems in materialsmore » science, chemistry, and biology.« less

  19. Fast analysis of molecular dynamics trajectories with graphics processing units-Radial distribution function histogramming

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Levine, Benjamin G., E-mail: ben.levine@temple.ed; Stone, John E., E-mail: johns@ks.uiuc.ed; Kohlmeyer, Axel, E-mail: akohlmey@temple.ed

    2011-05-01

    The calculation of radial distribution functions (RDFs) from molecular dynamics trajectory data is a common and computationally expensive analysis task. The rate limiting step in the calculation of the RDF is building a histogram of the distance between atom pairs in each trajectory frame. Here we present an implementation of this histogramming scheme for multiple graphics processing units (GPUs). The algorithm features a tiling scheme to maximize the reuse of data at the fastest levels of the GPU's memory hierarchy and dynamic load balancing to allow high performance on heterogeneous configurations of GPUs. Several versions of the RDF algorithm aremore » presented, utilizing the specific hardware features found on different generations of GPUs. We take advantage of larger shared memory and atomic memory operations available on state-of-the-art GPUs to accelerate the code significantly. The use of atomic memory operations allows the fast, limited-capacity on-chip memory to be used much more efficiently, resulting in a fivefold increase in performance compared to the version of the algorithm without atomic operations. The ultimate version of the algorithm running in parallel on four NVIDIA GeForce GTX 480 (Fermi) GPUs was found to be 92 times faster than a multithreaded implementation running on an Intel Xeon 5550 CPU. On this multi-GPU hardware, the RDF between two selections of 1,000,000 atoms each can be calculated in 26.9 s per frame. The multi-GPU RDF algorithms described here are implemented in VMD, a widely used and freely available software package for molecular dynamics visualization and analysis.« less

  20. Fast Analysis of Molecular Dynamics Trajectories with Graphics Processing Units—Radial Distribution Function Histogramming

    PubMed Central

    Stone, John E.; Kohlmeyer, Axel

    2011-01-01

    The calculation of radial distribution functions (RDFs) from molecular dynamics trajectory data is a common and computationally expensive analysis task. The rate limiting step in the calculation of the RDF is building a histogram of the distance between atom pairs in each trajectory frame. Here we present an implementation of this histogramming scheme for multiple graphics processing units (GPUs). The algorithm features a tiling scheme to maximize the reuse of data at the fastest levels of the GPU’s memory hierarchy and dynamic load balancing to allow high performance on heterogeneous configurations of GPUs. Several versions of the RDF algorithm are presented, utilizing the specific hardware features found on different generations of GPUs. We take advantage of larger shared memory and atomic memory operations available on state-of-the-art GPUs to accelerate the code significantly. The use of atomic memory operations allows the fast, limited-capacity on-chip memory to be used much more efficiently, resulting in a fivefold increase in performance compared to the version of the algorithm without atomic operations. The ultimate version of the algorithm running in parallel on four NVIDIA GeForce GTX 480 (Fermi) GPUs was found to be 92 times faster than a multithreaded implementation running on an Intel Xeon 5550 CPU. On this multi-GPU hardware, the RDF between two selections of 1,000,000 atoms each can be calculated in 26.9 seconds per frame. The multi-GPU RDF algorithms described here are implemented in VMD, a widely used and freely available software package for molecular dynamics visualization and analysis. PMID:21547007

  1. Ab initio molecular dynamics in a finite homogeneous electric field.

    PubMed

    Umari, P; Pasquarello, Alfredo

    2002-10-07

    We treat homogeneous electric fields within density functional calculations with periodic boundary conditions. A nonlocal energy functional depending on the applied field is used within an ab initio molecular dynamics scheme. The reliability of the method is demonstrated in the case of bulk MgO for the Born effective charges, and the high- and low-frequency dielectric constants. We evaluate the static dielectric constant by performing a damped molecular dynamics in an electric field and avoiding the calculation of the dynamical matrix. Application of this method to vitreous silica shows good agreement with experiment and illustrates its potential for systems of large size.

  2. A combined molecular dynamics/micromechanics/finite element approach for multiscale constitutive modeling of nanocomposites with interface effects

    NASA Astrophysics Data System (ADS)

    Yang, B. J.; Shin, H.; Lee, H. K.; Kim, H.

    2013-12-01

    We introduce a multiscale framework based on molecular dynamic (MD) simulation, micromechanics, and finite element method (FEM). A micromechanical model, which considers influences of the interface properties, nanoparticle (NP) size, and microcracks, is developed. Then, we perform MD simulations to characterize the mechanical properties of the nanocomposite system (silica/nylon 6) with varying volume fraction and size of NPs. By comparing the MD with micromechanics results, intrinsic physical properties at interfacial region are derived. Finally, we implement the developed model in the FEM code with the derived interfacial parameters, and predict the mechanical behavior of the nanocomposite at the macroscopic scale.

  3. Solute Dynamics In Liquid Systems: Experiments and Molecular Dynamics Simulations

    NASA Astrophysics Data System (ADS)

    Rumble, Christopher A.

    This work reports on explorations into the effect of the liquid environment on the dynamics and kinetics of a range solute processes. The first study (Chapter 3) explores the photoisomerization of the rotor probe 9-(2-carboxy-2-cyanovinyl)julolidine, or CCVJ. Rotor probes are a class of fluorophores that undergo photo-induced isomerization reactions resulting in non-radiative relaxation out of the excited state. Literature reports had suggested that CCVJ exhibited a 'flow effect,' in which the emission intensity of CCVJ increases when the fluorophore solution is flowed at modest rates. Using steady-state and time-resolved fluorescence and 1H-NMR spectroscopy we show that the flow effect can be attributed to creation of a mixture of fluorescent and non-fluorescent CCVJ isomers by the excitation. The next study, Chapter 4, examines the the fluorescence of DNA G-quadruplex structures (GQSs), non-helical single-stranded DNA structures that exhibit quantum yields significantly higher than helical DNA or its constituent bases. By using a constant GQS core sequence we show that the addition of 'dangling' nucleotides can modulate emission from the GQS whereas conventional quenchers do not. The emission can also be altered by changes in temperature and addition of crowding reagents such as poly(ethylene glycol). Using time-resolved emission spectroscopy we show that GQS emission can be approximately dissected into two emitting populations with distinct kinetics. Chapters 5 and 6 report on the effects of solvation on charge transfer reactions in conventional molecular solvents and ionic liquid/conventional solvent mixtures. In Chapter 5 the excited state intramolecular proton transfer reaction of 40-N,N-diethylamino-3-hydroxyflavone (DEAHF) is studied using sub-picosecond Kerr-gated emission spectroscopy in mixtures of acetonitrile and propylene carbonate. Previous studies of DEAHF tautomerization had shown that the proton transfer rate and equilibrium constant are highly

  4. Implementation of metal-friendly EAM/FS-type semi-empirical potentials in HOOMD-blue: A GPU-accelerated molecular dynamics software

    NASA Astrophysics Data System (ADS)

    Yang, Lin; Zhang, Feng; Wang, Cai-Zhuang; Ho, Kai-Ming; Travesset, Alex

    2018-04-01

    We present an implementation of EAM and FS interatomic potentials, which are widely used in simulating metallic systems, in HOOMD-blue, a software designed to perform classical molecular dynamics simulations using GPU accelerations. We first discuss the details of our implementation and then report extensive benchmark tests. We demonstrate that single-precision floating point operations efficiently implemented on GPUs can produce sufficient accuracy when compared against double-precision codes, as demonstrated in test simulations of calculations of the glass-transition temperature of Cu64.5Zr35.5, and pair correlation function g (r) of liquid Ni3Al. Our code scales well with the size of the simulating system on NVIDIA Tesla M40 and P100 GPUs. Compared with another popular software LAMMPS running on 32 cores of AMD Opteron 6220 processors, the GPU/CPU performance ratio can reach as high as 4.6. The source code can be accessed through the HOOMD-blue web page for free by any interested user.

  5. Dynamics of photoionization from molecular electronic wavepacket states in intense pulse laser fields: A nonadiabatic electron wavepacket study.

    PubMed

    Matsuoka, Takahide; Takatsuka, Kazuo

    2017-04-07

    A theory for dynamics of molecular photoionization from nonadiabatic electron wavepackets driven by intense pulse lasers is proposed. Time evolution of photoelectron distribution is evaluated in terms of out-going electron flux (current of the probability density of electrons) that has kinetic energy high enough to recede from the molecular system. The relevant electron flux is in turn evaluated with the complex-valued electronic wavefunctions that are time evolved in nonadiabatic electron wavepacket dynamics in laser fields. To uniquely rebuild such wavefunctions with its electronic population being lost by ionization, we adopt the complex-valued natural orbitals emerging from the electron density as building blocks of the total wavefunction. The method has been implemented into a quantum chemistry code, which is based on configuration state mixing for polyatomic molecules. Some of the practical aspects needed for its application will be presented. As a first illustrative example, we show the results of hydrogen molecule and its isotope substitutes (HD and DD), which are photoionized by a two-cycle pulse laser. Photon emission spectrum associated with above threshold ionization is also shown. Another example is taken from photoionization dynamics from an excited state of a water molecule. Qualitatively significant effects of nonadiabatic interaction on the photoelectron spectrum are demonstrated.

  6. Molecular dynamics simulation of β₂-microglobulin in denaturing and stabilizing conditions.

    PubMed

    Fogolari, Federico; Corazza, Alessandra; Varini, Nicola; Rotter, Matteo; Gumral, Devrim; Codutti, Luca; Rennella, Enrico; Viglino, Paolo; Bellotti, Vittorio; Esposito, Gennaro

    2011-03-01

    β₂-Microglobulin has been a model system for the study of fibril formation for 20 years. The experimental study of β₂-microglobulin structure, dynamics, and thermodynamics in solution, at atomic detail, along the pathway leading to fibril formation is difficult because the onset of disorder and aggregation prevents signal resolution in Nuclear Magnetic Resonance experiments. Moreover, it is difficult to characterize conformers in exchange equilibrium. To gain insight (at atomic level) on processes for which experimental information is available at molecular or supramolecular level, molecular dynamics simulations have been widely used in the last decade. Here, we use molecular dynamics to address three key aspects of β₂-microglobulin, which are known to be relevant to amyloid formation: (1) 60 ns molecular dynamics simulations of β₂-microglobulin in trifluoroethanol and in conditions mimicking low pH are used to study the behavior of the protein in environmental conditions that are able to trigger amyloid formation; (2) adaptive biasing force molecular dynamics simulation is used to force cis-trans isomerization at Proline 32 and to calculate the relative free energy in the folded and unfolded state. The native-like trans-conformer (known as intermediate 2 and determining the slow phase of refolding), is simulated for 10 ns, detailing the possible link between cis-trans isomerization and conformational disorder; (3) molecular dynamics simulation of highly concentrated doxycycline (a molecule able to suppress fibril formation) in the presence of β₂-microglobulin provides details of the binding modes of the drug and a rationale for its effect. Copyright © 2010 Wiley-Liss, Inc.

  7. Evaluation of a grid based molecular dynamics approach for polypeptide simulations.

    PubMed

    Merelli, Ivan; Morra, Giulia; Milanesi, Luciano

    2007-09-01

    Molecular dynamics is very important for biomedical research because it makes possible simulation of the behavior of a biological macromolecule in silico. However, molecular dynamics is computationally rather expensive: the simulation of some nanoseconds of dynamics for a large macromolecule such as a protein takes very long time, due to the high number of operations that are needed for solving the Newton's equations in the case of a system of thousands of atoms. In order to obtain biologically significant data, it is desirable to use high-performance computation resources to perform these simulations. Recently, a distributed computing approach based on replacing a single long simulation with many independent short trajectories has been introduced, which in many cases provides valuable results. This study concerns the development of an infrastructure to run molecular dynamics simulations on a grid platform in a distributed way. The implemented software allows the parallel submission of different simulations that are singularly short but together bring important biological information. Moreover, each simulation is divided into a chain of jobs to avoid data loss in case of system failure and to contain the dimension of each data transfer from the grid. The results confirm that the distributed approach on grid computing is particularly suitable for molecular dynamics simulations thanks to the elevated scalability.

  8. Preserving the Boltzmann ensemble in replica-exchange molecular dynamics.

    PubMed

    Cooke, Ben; Schmidler, Scott C

    2008-10-28

    We consider the convergence behavior of replica-exchange molecular dynamics (REMD) [Sugita and Okamoto, Chem. Phys. Lett. 314, 141 (1999)] based on properties of the numerical integrators in the underlying isothermal molecular dynamics (MD) simulations. We show that a variety of deterministic algorithms favored by molecular dynamics practitioners for constant-temperature simulation of biomolecules fail either to be measure invariant or irreducible, and are therefore not ergodic. We then show that REMD using these algorithms also fails to be ergodic. As a result, the entire configuration space may not be explored even in an infinitely long simulation, and the simulation may not converge to the desired equilibrium Boltzmann ensemble. Moreover, our analysis shows that for initial configurations with unfavorable energy, it may be impossible for the system to reach a region surrounding the minimum energy configuration. We demonstrate these failures of REMD algorithms for three small systems: a Gaussian distribution (simple harmonic oscillator dynamics), a bimodal mixture of Gaussians distribution, and the alanine dipeptide. Examination of the resulting phase plots and equilibrium configuration densities indicates significant errors in the ensemble generated by REMD simulation. We describe a simple modification to address these failures based on a stochastic hybrid Monte Carlo correction, and prove that this is ergodic.

  9. Convergence and reproducibility in molecular dynamics simulations of the DNA duplex d(GCACGAACGAACGAACGC).

    PubMed

    Galindo-Murillo, Rodrigo; Roe, Daniel R; Cheatham, Thomas E

    2015-05-01

    The structure and dynamics of DNA are critically related to its function. Molecular dynamics simulations augment experiment by providing detailed information about the atomic motions. However, to date the simulations have not been long enough for convergence of the dynamics and structural properties of DNA. Molecular dynamics simulations performed with AMBER using the ff99SB force field with the parmbsc0 modifications, including ensembles of independent simulations, were compared to long timescale molecular dynamics performed with the specialized Anton MD engine on the B-DNA structure d(GCACGAACGAACGAACGC). To assess convergence, the decay of the average RMSD values over longer and longer time intervals was evaluated in addition to assessing convergence of the dynamics via the Kullback-Leibler divergence of principal component projection histograms. These molecular dynamics simulations-including one of the longest simulations of DNA published to date at ~44μs-surprisingly suggest that the structure and dynamics of the DNA helix, neglecting the terminal base pairs, are essentially fully converged on the ~1-5μs timescale. We can now reproducibly converge the structure and dynamics of B-DNA helices, omitting the terminal base pairs, on the μs time scale with both the AMBER and CHARMM C36 nucleic acid force fields. Results from independent ensembles of simulations starting from different initial conditions, when aggregated, match the results from long timescale simulations on the specialized Anton MD engine. With access to large-scale GPU resources or the specialized MD engine "Anton" it is possible for a variety of molecular systems to reproducibly and reliably converge the conformational ensemble of sampled structures. This article is part of a Special Issue entitled: Recent developments of molecular dynamics. Copyright © 2014. Published by Elsevier B.V.

  10. Molecular-level dynamics of refractory dissolved organic matter

    NASA Astrophysics Data System (ADS)

    Niggemann, J.; Gerdts, G.; Dittmar, T.

    2012-04-01

    Refractory dissolved organic matter (DOM) accounts for most of the global oceanic organic carbon inventory. Processes leading to its formation and factors determining its stability are still largely unknown. We hypothesize that refractory DOM carries a universal molecular signature. Characterizing spatial and temporal variability in this universal signature is a key to understanding dynamics of refractory DOM. We present results from a long-term study of the DOM geo-metabolome in the open North Sea. Geo-metabolomics considers the entity of DOM as a population of compounds, each characterized by a specific function and reactivity in the cycling of energy and elements. Ten-thousands of molecular formulae were identified in DOM by ultrahigh resolution mass spectrometry analysis (FT-ICR-MS, Fourier-Transform Ion Cyclotron Resonance Mass Spectrometry). The DOM pool in the North Sea was influenced by a complex interplay of processes that produced, transformed and degraded dissolved molecules. We identified a stable fraction in North Sea DOM with a molecular composition similar to deep ocean DOM. Molecular-level changes in this stable fraction provide novel information on dynamics and interactions of refractory DOM.

  11. Molecular Dynamics Simulations of Hydrophobic Residues

    NASA Astrophysics Data System (ADS)

    Caballero, Diego; Zhou, Alice; Regan, Lynne; O'Hern, Corey

    2013-03-01

    Molecular recognition and protein-protein interactions are involved in important biological processes. However, despite recent improvements in computational methods for protein design, we still lack a predictive understanding of protein structure and interactions. To begin to address these shortcomings, we performed molecular dynamics simulations of hydrophobic residues modeled as hard spheres with stereo-chemical constraints initially at high temperature, and then quenched to low temperature to obtain local energy minima. We find that there is a range of quench rates over which the probabilities of side-chain dihedral angles for hydrophobic residues match the probabilities obtained for known protein structures. In addition, we predict the side-chain dihedral angle propensities in the core region of the proteins T4, ROP, and several mutants. These studies serve as a first step in developing the ability to quantitatively rank the energies of designed protein constructs. The success of these studies suggests that only hard-sphere dynamics with geometrical constraints are needed for accurate protein structure prediction in hydrophobic cavities and binding interfaces. NSF Grant PHY-1019147

  12. Classical Molecular Dynamics with Mobile Protons.

    PubMed

    Lazaridis, Themis; Hummer, Gerhard

    2017-11-27

    An important limitation of standard classical molecular dynamics simulations is the inability to make or break chemical bonds. This restricts severely our ability to study processes that involve even the simplest of chemical reactions, the transfer of a proton. Existing approaches for allowing proton transfer in the context of classical mechanics are rather cumbersome and have not achieved widespread use and routine status. Here we reconsider the combination of molecular dynamics with periodic stochastic proton hops. To ensure computational efficiency, we propose a non-Boltzmann acceptance criterion that is heuristically adjusted to maintain the correct or desirable thermodynamic equilibria between different protonation states and proton transfer rates. Parameters are proposed for hydronium, Asp, Glu, and His. The algorithm is implemented in the program CHARMM and tested on proton diffusion in bulk water and carbon nanotubes and on proton conductance in the gramicidin A channel. Using hopping parameters determined from proton diffusion in bulk water, the model reproduces the enhanced proton diffusivity in carbon nanotubes and gives a reasonable estimate of the proton conductance in gramicidin A.

  13. AWE-WQ: fast-forwarding molecular dynamics using the accelerated weighted ensemble.

    PubMed

    Abdul-Wahid, Badi'; Feng, Haoyun; Rajan, Dinesh; Costaouec, Ronan; Darve, Eric; Thain, Douglas; Izaguirre, Jesús A

    2014-10-27

    A limitation of traditional molecular dynamics (MD) is that reaction rates are difficult to compute. This is due to the rarity of observing transitions between metastable states since high energy barriers trap the system in these states. Recently the weighted ensemble (WE) family of methods have emerged which can flexibly and efficiently sample conformational space without being trapped and allow calculation of unbiased rates. However, while WE can sample correctly and efficiently, a scalable implementation applicable to interesting biomolecular systems is not available. We provide here a GPLv2 implementation called AWE-WQ of a WE algorithm using the master/worker distributed computing WorkQueue (WQ) framework. AWE-WQ is scalable to thousands of nodes and supports dynamic allocation of computer resources, heterogeneous resource usage (such as central processing units (CPU) and graphical processing units (GPUs) concurrently), seamless heterogeneous cluster usage (i.e., campus grids and cloud providers), and support for arbitrary MD codes such as GROMACS, while ensuring that all statistics are unbiased. We applied AWE-WQ to a 34 residue protein which simulated 1.5 ms over 8 months with peak aggregate performance of 1000 ns/h. Comparison was done with a 200 μs simulation collected on a GPU over a similar timespan. The folding and unfolded rates were of comparable accuracy.

  14. Elucidation of molecular dynamics of invasive species of rice

    USDA-ARS?s Scientific Manuscript database

    Cultivated rice fields are aggressively invaded by weedy rice in the U.S. and worldwide. Weedy rice results in loss of yield and seed contamination. The molecular dynamics of the evolutionary adaptive traits of weedy rice are not fully understood. To understand the molecular basis and identify the i...

  15. Parallel Discrete Molecular Dynamics Simulation With Speculation and In-Order Commitment.

    PubMed

    Khan, Md Ashfaquzzaman; Herbordt, Martin C

    2011-07-20

    Discrete molecular dynamics simulation (DMD) uses simplified and discretized models enabling simulations to advance by event rather than by timestep. DMD is an instance of discrete event simulation and so is difficult to scale: even in this multi-core era, all reported DMD codes are serial. In this paper we discuss the inherent difficulties of scaling DMD and present our method of parallelizing DMD through event-based decomposition. Our method is microarchitecture inspired: speculative processing of events exposes parallelism, while in-order commitment ensures correctness. We analyze the potential of this parallelization method for shared-memory multiprocessors. Achieving scalability required extensive experimentation with scheduling and synchronization methods to mitigate serialization. The speed-up achieved for a variety of system sizes and complexities is nearly 6× on an 8-core and over 9× on a 12-core processor. We present and verify analytical models that account for the achieved performance as a function of available concurrency and architectural limitations.

  16. Coupled binding-bending-folding: The complex conformational dynamics of protein-DNA binding studied by atomistic molecular dynamics simulations.

    PubMed

    van der Vaart, Arjan

    2015-05-01

    Protein-DNA binding often involves dramatic conformational changes such as protein folding and DNA bending. While thermodynamic aspects of this behavior are understood, and its biological function is often known, the mechanism by which the conformational changes occur is generally unclear. By providing detailed structural and energetic data, molecular dynamics simulations have been helpful in elucidating and rationalizing protein-DNA binding. This review will summarize recent atomistic molecular dynamics simulations of the conformational dynamics of DNA and protein-DNA binding. A brief overview of recent developments in DNA force fields is given as well. Simulations have been crucial in rationalizing the intrinsic flexibility of DNA, and have been instrumental in identifying the sequence of binding events, the triggers for the conformational motion, and the mechanism of binding for a number of important DNA-binding proteins. Molecular dynamics simulations are an important tool for understanding the complex binding behavior of DNA-binding proteins. With recent advances in force fields and rapid increases in simulation time scales, simulations will become even more important for future studies. This article is part of a Special Issue entitled Recent developments of molecular dynamics. Copyright © 2014. Published by Elsevier B.V.

  17. Molecular dynamics simulations on PGLa using NMR orientational constraints.

    PubMed

    Sternberg, Ulrich; Witter, Raiker

    2015-11-01

    NMR data obtained by solid state NMR from anisotropic samples are used as orientational constraints in molecular dynamics simulations for determining the structure and dynamics of the PGLa peptide within a membrane environment. For the simulation the recently developed molecular dynamics with orientational constraints technique (MDOC) is used. This method introduces orientation dependent pseudo-forces into the COSMOS-NMR force field. Acting during a molecular dynamics simulation these forces drive molecular rotations, re-orientations and folding in such a way that the motional time-averages of the tensorial NMR properties are consistent with the experimentally measured NMR parameters. This MDOC strategy does not depend on the initial choice of atomic coordinates, and is in principle suitable for any flexible and mobile kind of molecule; and it is of course possible to account for flexible parts of peptides or their side-chains. MDOC has been applied to the antimicrobial peptide PGLa and a related dimer model. With these simulations it was possible to reproduce most NMR parameters within the experimental error bounds. The alignment, conformation and order parameters of the membrane-bound molecule and its dimer were directly derived with MDOC from the NMR data. Furthermore, this new approach yielded for the first time the distribution of segmental orientations with respect to the membrane and the order parameter tensors of the dimer systems. It was demonstrated the deuterium splittings measured at the peptide to lipid ratio of 1/50 are consistent with a membrane spanning orientation of the peptide.

  18. A dynamic code for economic object valuation in prefrontal cortex neurons

    PubMed Central

    Tsutsui, Ken-Ichiro; Grabenhorst, Fabian; Kobayashi, Shunsuke; Schultz, Wolfram

    2016-01-01

    Neuronal reward valuations provide the physiological basis for economic behaviour. Yet, how such valuations are converted to economic decisions remains unclear. Here we show that the dorsolateral prefrontal cortex (DLPFC) implements a flexible value code based on object-specific valuations by single neurons. As monkeys perform a reward-based foraging task, individual DLPFC neurons signal the value of specific choice objects derived from recent experience. These neuronal object values satisfy principles of competitive choice mechanisms, track performance fluctuations and follow predictions of a classical behavioural model (Herrnstein’s matching law). Individual neurons dynamically encode both, the updating of object values from recently experienced rewards, and their subsequent conversion to object choices during decision-making. Decoding from unselected populations enables a read-out of motivational and decision variables not emphasized by individual neurons. These findings suggest a dynamic single-neuron and population value code in DLPFC that advances from reward experiences to economic object values and future choices. PMID:27618960

  19. Molecular Dynamics Modeling and Simulation of Diamond Cutting of Cerium.

    PubMed

    Zhang, Junjie; Zheng, Haibing; Shuai, Maobing; Li, Yao; Yang, Yang; Sun, Tao

    2017-12-01

    The coupling between structural phase transformations and dislocations induces challenges in understanding the deformation behavior of metallic cerium at the nanoscale. In the present work, we elucidate the underlying mechanism of cerium under ultra-precision diamond cutting by means of molecular dynamics modeling and simulations. The molecular dynamics model of diamond cutting of cerium is established by assigning empirical potentials to describe atomic interactions and evaluating properties of two face-centered cubic cerium phases. Subsequent molecular dynamics simulations reveal that dislocation slip dominates the plastic deformation of cerium under the cutting process. In addition, the analysis based on atomic radial distribution functions demonstrates that there are trivial phase transformations from the γ-Ce to the δ-Ce occurred in both machined surface and formed chip. Following investigations on machining parameter dependence reveal the optimal machining conditions for achieving high quality of machined surface of cerium.

  20. Molecular Dynamics Modeling and Simulation of Diamond Cutting of Cerium

    NASA Astrophysics Data System (ADS)

    Zhang, Junjie; Zheng, Haibing; Shuai, Maobing; Li, Yao; Yang, Yang; Sun, Tao

    2017-07-01

    The coupling between structural phase transformations and dislocations induces challenges in understanding the deformation behavior of metallic cerium at the nanoscale. In the present work, we elucidate the underlying mechanism of cerium under ultra-precision diamond cutting by means of molecular dynamics modeling and simulations. The molecular dynamics model of diamond cutting of cerium is established by assigning empirical potentials to describe atomic interactions and evaluating properties of two face-centered cubic cerium phases. Subsequent molecular dynamics simulations reveal that dislocation slip dominates the plastic deformation of cerium under the cutting process. In addition, the analysis based on atomic radial distribution functions demonstrates that there are trivial phase transformations from the γ-Ce to the δ-Ce occurred in both machined surface and formed chip. Following investigations on machining parameter dependence reveal the optimal machining conditions for achieving high quality of machined surface of cerium.

  1. Molecular Dynamics Methodologies for Probing Cannabinoid Ligand/Receptor Interaction

    PubMed Central

    Lynch, Diane L.; Hurst, Dow P.; Shore, Derek M.; Pitman, Mike C.; Reggio, Patricia H.

    2018-01-01

    The cannabinoid type 1 and 2 G-protein-coupled receptors are currently important pharmacological targets with significant drug discovery potential. These receptors have been shown to display functional selectivity or biased agonism, a property currently thought to have substantial therapeutic potential. Although recent advances in crystallization techniques have provided a wealth of structural information about this important class of membrane-embedded proteins, these structures lack dynamical information. In order to fully understand the interplay of structure and function for this important class of proteins, complementary techniques that address the dynamical aspects of their function are required such as NMR as well as a variety of other spectroscopies. Complimentary to these experimental approaches is molecular dynamics, which has been effectively used to help unravel, at the atomic level, the dynamics of ligand binding and activation of these membrane-bound receptors. Here, we discuss and present several representative examples of the application of molecular dynamics simulations to the understanding of the signatures of ligand-binding and -biased signaling at the cannabinoid type 1 and 2 receptors. PMID:28750815

  2. Sampling of Protein Folding Transitions: Multicanonical Versus Replica Exchange Molecular Dynamics.

    PubMed

    Jiang, Ping; Yaşar, Fatih; Hansmann, Ulrich H E

    2013-08-13

    We compare the efficiency of multicanonical and replica exchange molecular dynamics for the sampling of folding/unfolding events in simulations of proteins with end-to-end β -sheet. In Go-model simulations of the 75-residue MNK6, we observe improvement factors of 30 in the number of folding/unfolding events of multicanonical molecular dynamics over replica exchange molecular dynamics. As an application, we use this enhanced sampling to study the folding landscape of the 36-residue DS119 with an all-atom physical force field and implicit solvent. Here, we find that the rate-limiting step is the formation of the central helix that then provides a scaffold for the parallel β -sheet formed by the two chain ends.

  3. PuReMD-GPU: A reactive molecular dynamics simulation package for GPUs

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Kylasa, S.B., E-mail: skylasa@purdue.edu; Aktulga, H.M., E-mail: hmaktulga@lbl.gov; Grama, A.Y., E-mail: ayg@cs.purdue.edu

    2014-09-01

    We present an efficient and highly accurate GP-GPU implementation of our community code, PuReMD, for reactive molecular dynamics simulations using the ReaxFF force field. PuReMD and its incorporation into LAMMPS (Reax/C) is used by a large number of research groups worldwide for simulating diverse systems ranging from biomembranes to explosives (RDX) at atomistic level of detail. The sub-femtosecond time-steps associated with ReaxFF strongly motivate significant improvements to per-timestep simulation time through effective use of GPUs. This paper presents, in detail, the design and implementation of PuReMD-GPU, which enables ReaxFF simulations on GPUs, as well as various performance optimization techniques wemore » developed to obtain high performance on state-of-the-art hardware. Comprehensive experiments on model systems (bulk water and amorphous silica) are presented to quantify the performance improvements achieved by PuReMD-GPU and to verify its accuracy. In particular, our experiments show up to 16× improvement in runtime compared to our highly optimized CPU-only single-core ReaxFF implementation. PuReMD-GPU is a unique production code, and is currently available on request from the authors.« less

  4. Adaptively biased molecular dynamics for free energy calculations

    NASA Astrophysics Data System (ADS)

    Babin, Volodymyr; Roland, Christopher; Sagui, Celeste

    2008-04-01

    We present an adaptively biased molecular dynamics (ABMD) method for the computation of the free energy surface of a reaction coordinate using nonequilibrium dynamics. The ABMD method belongs to the general category of umbrella sampling methods with an evolving biasing potential and is inspired by the metadynamics method. The ABMD method has several useful features, including a small number of control parameters and an O(t ) numerical cost with molecular dynamics time t. The ABMD method naturally allows for extensions based on multiple walkers and replica exchange, where different replicas can have different temperatures and/or collective variables. This is beneficial not only in terms of the speed and accuracy of a calculation, but also in terms of the amount of useful information that may be obtained from a given simulation. The workings of the ABMD method are illustrated via a study of the folding of the Ace-GGPGGG-Nme peptide in a gaseous and solvated environment.

  5. Molecular cancer classification using a meta-sample-based regularized robust coding method.

    PubMed

    Wang, Shu-Lin; Sun, Liuchao; Fang, Jianwen

    2014-01-01

    Previous studies have demonstrated that machine learning based molecular cancer classification using gene expression profiling (GEP) data is promising for the clinic diagnosis and treatment of cancer. Novel classification methods with high efficiency and prediction accuracy are still needed to deal with high dimensionality and small sample size of typical GEP data. Recently the sparse representation (SR) method has been successfully applied to the cancer classification. Nevertheless, its efficiency needs to be improved when analyzing large-scale GEP data. In this paper we present the meta-sample-based regularized robust coding classification (MRRCC), a novel effective cancer classification technique that combines the idea of meta-sample-based cluster method with regularized robust coding (RRC) method. It assumes that the coding residual and the coding coefficient are respectively independent and identically distributed. Similar to meta-sample-based SR classification (MSRC), MRRCC extracts a set of meta-samples from the training samples, and then encodes a testing sample as the sparse linear combination of these meta-samples. The representation fidelity is measured by the l2-norm or l1-norm of the coding residual. Extensive experiments on publicly available GEP datasets demonstrate that the proposed method is more efficient while its prediction accuracy is equivalent to existing MSRC-based methods and better than other state-of-the-art dimension reduction based methods.

  6. Solution NMR structure of a designed metalloprotein and complementary molecular dynamics refinement.

    PubMed

    Calhoun, Jennifer R; Liu, Weixia; Spiegel, Katrin; Dal Peraro, Matteo; Klein, Michael L; Valentine, Kathleen G; Wand, A Joshua; DeGrado, William F

    2008-02-01

    We report the solution NMR structure of a designed dimetal-binding protein, di-Zn(II) DFsc, along with a secondary refinement step employing molecular dynamics techniques. Calculation of the initial NMR structural ensemble by standard methods led to distortions in the metal-ligand geometries at the active site. Unrestrained molecular dynamics using a nonbonded force field for the metal shell, followed by quantum mechanical/molecular mechanical dynamics of DFsc, were used to relax local frustrations at the dimetal site that were apparent in the initial NMR structure and provide a more realistic description of the structure. The MD model is consistent with NMR restraints, and in good agreement with the structural and functional properties expected for DF proteins. This work demonstrates that NMR structures of metalloproteins can be further refined using classical and first-principles molecular dynamics methods in the presence of explicit solvent to provide otherwise unavailable insight into the geometry of the metal center.

  7. Nonadiabatic excited-state molecular dynamics modeling of photoinduced dynamics in conjugated molecules.

    PubMed

    Nelson, Tammie; Fernandez-Alberti, Sebastian; Chernyak, Vladimir; Roitberg, Adrian E; Tretiak, Sergei

    2011-05-12

    Nonadiabatic dynamics generally defines the entire evolution of electronic excitations in optically active molecular materials. It is commonly associated with a number of fundamental and complex processes such as intraband relaxation, energy transfer, and light harvesting influenced by the spatial evolution of excitations and transformation of photoexcitation energy into electrical energy via charge separation (e.g., charge injection at interfaces). To treat ultrafast excited-state dynamics and exciton/charge transport we have developed a nonadiabatic excited-state molecular dynamics (NA-ESMD) framework incorporating quantum transitions. Our calculations rely on the use of the Collective Electronic Oscillator (CEO) package accounting for many-body effects and actual potential energy surfaces of the excited states combined with Tully's fewest switches algorithm for surface hopping for probing nonadiabatic processes. This method is applied to model the photoinduced dynamics of distyrylbenzene (a small oligomer of polyphenylene vinylene, PPV). Our analysis shows intricate details of photoinduced vibronic relaxation and identifies specific slow and fast nuclear motions that are strongly coupled to the electronic degrees of freedom, namely, torsion and bond length alternation, respectively. Nonadiabatic relaxation of the highly excited mA(g) state is predicted to occur on a femtosecond time scale at room temperature and on a picosecond time scale at low temperature.

  8. Efficient Conformational Sampling in Explicit Solvent Using a Hybrid Replica Exchange Molecular Dynamics Method

    DTIC Science & Technology

    2011-12-01

    REMD while reproducing the energy landscape of explicit solvent simulations . ’ INTRODUCTION Molecular dynamics (MD) simulations of proteins can pro...Mongan, J.; McCammon, J. A. Accelerated molecular dynamics : a promising and efficient simulation method for biomolecules. J. Chem. Phys. 2004, 120 (24...Chemical Theory and Computation ARTICLE (8) Abraham,M. J.; Gready, J. E. Ensuringmixing efficiency of replica- exchange molecular dynamics simulations . J

  9. Molecular dynamics simulation of a needle-sphere binary mixture

    NASA Astrophysics Data System (ADS)

    Raghavan, Karthik

    This paper investigates the dynamic behaviour of a hard needle-sphere binary system using a novel numerical technique called the Newton homotopy continuation (NHC) method. This mixture is representative of a polymer melt where both long chain molecules and monomers coexist. Since the intermolecular forces are generated from hard body interactions, the consequence of missed collisions or incorrect collision sequences have a significant bearing on the dynamic properties of the fluid. To overcome this problem, in earlier work NHC was chosen over traditional Newton-Raphson methods to solve the hard body dynamics of a needle fluid in random media composed of overlapping spheres. Furthermore, the simplicity of interactions and dynamics allows us to focus our research directly on the effects of particle shape and density on the transport behaviour of the mixture. These studies are also compared with earlier works that examined molecular chains in porous media primarily to understand the differences in molecular transport in the bulk versus porous systems.

  10. Identification of promising DNA GyrB inhibitors for Tuberculosis using pharmacophore-based virtual screening, molecular docking and molecular dynamics studies.

    PubMed

    Islam, Md Ataul; Pillay, Tahir S

    2017-08-01

    In this study, we searched for potential DNA GyrB inhibitors using pharmacophore-based virtual screening followed by molecular docking and molecular dynamics simulation approaches. For this purpose, a set of 248 DNA GyrB inhibitors was collected from the literature and a well-validated pharmacophore model was generated. The best pharmacophore model explained that two each of hydrogen bond acceptors and hydrophobicity regions were critical for inhibition of DNA GyrB. Good statistical results of the pharmacophore model indicated that the model was robust in nature. Virtual screening of molecular databases revealed three molecules as potential antimycobacterial agents. The final screened promising compounds were evaluated in molecular docking and molecular dynamics simulation studies. In the molecular dynamics studies, RMSD and RMSF values undoubtedly explained that the screened compounds formed stable complexes with DNA GyrB. Therefore, it can be concluded that the compounds identified may have potential for the treatment of TB. © 2017 John Wiley & Sons A/S.

  11. Multipole Algorithms for Molecular Dynamics Simulation on High Performance Computers.

    NASA Astrophysics Data System (ADS)

    Elliott, William Dewey

    1995-01-01

    A fundamental problem in modeling large molecular systems with molecular dynamics (MD) simulations is the underlying N-body problem of computing the interactions between all pairs of N atoms. The simplest algorithm to compute pair-wise atomic interactions scales in runtime {cal O}(N^2), making it impractical for interesting biomolecular systems, which can contain millions of atoms. Recently, several algorithms have become available that solve the N-body problem by computing the effects of all pair-wise interactions while scaling in runtime less than {cal O}(N^2). One algorithm, which scales {cal O}(N) for a uniform distribution of particles, is called the Greengard-Rokhlin Fast Multipole Algorithm (FMA). This work describes an FMA-like algorithm called the Molecular Dynamics Multipole Algorithm (MDMA). The algorithm contains several features that are new to N-body algorithms. MDMA uses new, efficient series expansion equations to compute general 1/r^{n } potentials to arbitrary accuracy. In particular, the 1/r Coulomb potential and the 1/r^6 portion of the Lennard-Jones potential are implemented. The new equations are based on multivariate Taylor series expansions. In addition, MDMA uses a cell-to-cell interaction region of cells that is closely tied to worst case error bounds. The worst case error bounds for MDMA are derived in this work also. These bounds apply to other multipole algorithms as well. Several implementation enhancements are described which apply to MDMA as well as other N-body algorithms such as FMA and tree codes. The mathematics of the cell -to-cell interactions are converted to the Fourier domain for reduced operation count and faster computation. A relative indexing scheme was devised to locate cells in the interaction region which allows efficient pre-computation of redundant information and prestorage of much of the cell-to-cell interaction. Also, MDMA was integrated into the MD program SIgMA to demonstrate the performance of the program over

  12. Application of Multiplexed Replica Exchange Molecular Dynamics to the UNRES Force Field: Tests with alpha and alpha+beta Proteins.

    PubMed

    Czaplewski, Cezary; Kalinowski, Sebastian; Liwo, Adam; Scheraga, Harold A

    2009-03-10

    The replica exchange (RE) method is increasingly used to improve sampling in molecular dynamics (MD) simulations of biomolecular systems. Recently, we implemented the united-residue UNRES force field for mesoscopic MD. Initial results from UNRES MD simulations show that we are able to simulate folding events that take place in a microsecond or even a millisecond time scale. To speed up the search further, we applied the multiplexing replica exchange molecular dynamics (MREMD) method. The multiplexed variant (MREMD) of the RE method, developed by Rhee and Pande, differs from the original RE method in that several trajectories are run at a given temperature. Each set of trajectories run at a different temperature constitutes a layer. Exchanges are attempted not only within a single layer but also between layers. The code has been parallelized and scales up to 4000 processors. We present a comparison of canonical MD, REMD, and MREMD simulations of protein folding with the UNRES force-field. We demonstrate that the multiplexed procedure increases the power of replica exchange MD considerably and convergence of the thermodynamic quantities is achieved much faster.

  13. Molecular dynamics investigation of dynamical properties of phosphatidylethanolamine lipid bilayers

    NASA Astrophysics Data System (ADS)

    Pitman, Michael C.; Suits, Frank; Gawrisch, Klaus; Feller, Scott E.

    2005-06-01

    We describe the dynamic behavior of a 1-stearoyl-2-oleoyl-phosphatidylethanolamine (SOPE) bilayer from a 20ns molecular dynamics simulation. The dynamics of individual molecules are characterized in terms of H2 spin-lattice relaxation rates, nuclear overhauser enhancement spectroscopy (NOESY) cross-relaxation rates, and lateral diffusion coefficients. Additionally, we describe the dynamics of hydrogen bonding through an analysis of hydrogen bond lifetimes and the time evolution of clusters of hydrogen bonded lipids. The simulated trajectory is shown to be consistent with experimental measures of internal, intermolecular, and diffusive motion. Consistent with our analysis of SOPE structure in the companion paper, we see hydrogen bonding dominating the dynamics of the interface region. Comparison of H2 T1 relaxation rates for chain methylene segments in phosphatidylcholine and phosphatidylethanolamine bilayers indicates that slower motion resulting from hydrogen bonding extends at least three carbons into the hydrophobic core. NOESY cross-relaxation rates compare well with experimental values, indicating the observed hydrogen bonding dynamics are realistic. Calculated lateral diffusion rates (4±1×10-8cm2/s) are comparable, though somewhat lower than, those determined by pulsed field gradient NMR methods.

  14. Molecular dynamics coupled with a virtual system for effective conformational sampling.

    PubMed

    Hayami, Tomonori; Kasahara, Kota; Nakamura, Haruki; Higo, Junichi

    2018-07-15

    An enhanced conformational sampling method is proposed: virtual-system coupled canonical molecular dynamics (VcMD). Although VcMD enhances sampling along a reaction coordinate, this method is free from estimation of a canonical distribution function along the reaction coordinate. This method introduces a virtual system that does not necessarily obey a physical law. To enhance sampling the virtual system couples with a molecular system to be studied. Resultant snapshots produce a canonical ensemble. This method was applied to a system consisting of two short peptides in an explicit solvent. Conventional molecular dynamics simulation, which is ten times longer than VcMD, was performed along with adaptive umbrella sampling. Free-energy landscapes computed from the three simulations mutually converged well. The VcMD provided quicker association/dissociation motions of peptides than the conventional molecular dynamics did. The VcMD method is applicable to various complicated systems because of its methodological simplicity. © 2018 Wiley Periodicals, Inc. © 2018 Wiley Periodicals, Inc.

  15. MDAnalysis: a toolkit for the analysis of molecular dynamics simulations.

    PubMed

    Michaud-Agrawal, Naveen; Denning, Elizabeth J; Woolf, Thomas B; Beckstein, Oliver

    2011-07-30

    MDAnalysis is an object-oriented library for structural and temporal analysis of molecular dynamics (MD) simulation trajectories and individual protein structures. It is written in the Python language with some performance-critical code in C. It uses the powerful NumPy package to expose trajectory data as fast and efficient NumPy arrays. It has been tested on systems of millions of particles. Many common file formats of simulation packages including CHARMM, Gromacs, Amber, and NAMD and the Protein Data Bank format can be read and written. Atoms can be selected with a syntax similar to CHARMM's powerful selection commands. MDAnalysis enables both novice and experienced programmers to rapidly write their own analytical tools and access data stored in trajectories in an easily accessible manner that facilitates interactive explorative analysis. MDAnalysis has been tested on and works for most Unix-based platforms such as Linux and Mac OS X. It is freely available under the GNU General Public License from http://mdanalysis.googlecode.com. Copyright © 2011 Wiley Periodicals, Inc.

  16. Molecular interferometer to decode attosecond electron-nuclear dynamics.

    PubMed

    Palacios, Alicia; González-Castrillo, Alberto; Martín, Fernando

    2014-03-18

    Understanding the coupled electronic and nuclear dynamics in molecules by using pump-probe schemes requires not only the use of short enough laser pulses but also wavelengths and intensities that do not modify the intrinsic behavior of the system. In this respect, extreme UV pulses of few-femtosecond and attosecond durations have been recognized as the ideal tool because their short wavelengths ensure a negligible distortion of the molecular potential. In this work, we propose the use of two twin extreme UV pulses to create a molecular interferometer from direct and sequential two-photon ionization processes that leave the molecule in the same final state. We theoretically demonstrate that such a scheme allows for a complete identification of both electronic and nuclear phases in the wave packet generated by the pump pulse. We also show that although total ionization yields reveal entangled electronic and nuclear dynamics in the bound states, doubly differential yields (differential in both electronic and nuclear energies) exhibit in addition the dynamics of autoionization, i.e., of electron correlation in the ionization continuum. Visualization of such dynamics is possible by varying the time delay between the pump and the probe pulses.

  17. Nanomaterials under extreme environments: A study of structural and dynamic properties using reactive molecular dynamics simulations

    NASA Astrophysics Data System (ADS)

    Shekhar, Adarsh

    Nanotechnology is becoming increasingly important with the continuing advances in experimental techniques. As researchers around the world are trying to expand the current understanding of the behavior of materials at the atomistic scale, the limited resolution of equipment, both in terms of time and space, act as roadblocks to a comprehensive study. Numerical methods, in general and molecular dynamics, in particular act as able compliment to the experiments in our quest for understanding material behavior. In this research work, large scale molecular dynamics simulations to gain insight into the mechano-chemical behavior under extreme conditions of a variety of systems with many real world applications. The body of this work is divided into three parts, each covering a particular system: 1) Aggregates of aluminum nanoparticles are good solid fuel due to high flame propagation rates. Multi-million atom molecular dynamics simulations reveal the mechanism underlying higher reaction rate in a chain of aluminum nanoparticles as compared to an isolated nanoparticle. This is due to the penetration of hot atoms from reacting nanoparticles to an adjacent, unreacted nanoparticle, which brings in external heat and initiates exothermic oxidation reactions. 2) Cavitation bubbles readily occur in fluids subjected to rapid changes in pressure. We use billion-atom reactive molecular dynamics simulations on a 163,840-processor BlueGene/P supercomputer to investigate chemical and mechanical damages caused by shock-induced collapse of nanobubbles in water near amorphous silica. Collapse of an empty nanobubble generates high-speed nanojet, resulting in the formation of a pit on the surface. The pit contains a large number of silanol groups and its volume is found to be directly proportional to the volume of the nanobubble. The gas-filled bubbles undergo partial collapse and consequently the damage on the silica surface is mitigated. 3) The structure and dynamics of water confined in

  18. Visualizing functional motions of membrane transporters with molecular dynamics simulations.

    PubMed

    Shaikh, Saher A; Li, Jing; Enkavi, Giray; Wen, Po-Chao; Huang, Zhijian; Tajkhorshid, Emad

    2013-01-29

    Computational modeling and molecular simulation techniques have become an integral part of modern molecular research. Various areas of molecular sciences continue to benefit from, indeed rely on, the unparalleled spatial and temporal resolutions offered by these technologies, to provide a more complete picture of the molecular problems at hand. Because of the continuous development of more efficient algorithms harvesting ever-expanding computational resources, and the emergence of more advanced and novel theories and methodologies, the scope of computational studies has expanded significantly over the past decade, now including much larger molecular systems and far more complex molecular phenomena. Among the various computer modeling techniques, the application of molecular dynamics (MD) simulation and related techniques has particularly drawn attention in biomolecular research, because of the ability of the method to describe the dynamical nature of the molecular systems and thereby to provide a more realistic representation, which is often needed for understanding fundamental molecular properties. The method has proven to be remarkably successful in capturing molecular events and structural transitions highly relevant to the function and/or physicochemical properties of biomolecular systems. Herein, after a brief introduction to the method of MD, we use a number of membrane transport proteins studied in our laboratory as examples to showcase the scope and applicability of the method and its power in characterizing molecular motions of various magnitudes and time scales that are involved in the function of this important class of membrane proteins.

  19. Visualizing Functional Motions of Membrane Transporters with Molecular Dynamics Simulations

    PubMed Central

    2013-01-01

    Computational modeling and molecular simulation techniques have become an integral part of modern molecular research. Various areas of molecular sciences continue to benefit from, indeed rely on, the unparalleled spatial and temporal resolutions offered by these technologies, to provide a more complete picture of the molecular problems at hand. Because of the continuous development of more efficient algorithms harvesting ever-expanding computational resources, and the emergence of more advanced and novel theories and methodologies, the scope of computational studies has expanded significantly over the past decade, now including much larger molecular systems and far more complex molecular phenomena. Among the various computer modeling techniques, the application of molecular dynamics (MD) simulation and related techniques has particularly drawn attention in biomolecular research, because of the ability of the method to describe the dynamical nature of the molecular systems and thereby to provide a more realistic representation, which is often needed for understanding fundamental molecular properties. The method has proven to be remarkably successful in capturing molecular events and structural transitions highly relevant to the function and/or physicochemical properties of biomolecular systems. Herein, after a brief introduction to the method of MD, we use a number of membrane transport proteins studied in our laboratory as examples to showcase the scope and applicability of the method and its power in characterizing molecular motions of various magnitudes and time scales that are involved in the function of this important class of membrane proteins. PMID:23298176

  20. Beyond Standard Molecular Dynamics: Investigating the Molecular Mechanisms of G Protein-Coupled Receptors with Enhanced Molecular Dynamics Methods

    PubMed Central

    Johnston, Jennifer M.

    2014-01-01

    The majority of biological processes mediated by G Protein-Coupled Receptors (GPCRs) take place on timescales that are not conveniently accessible to standard molecular dynamics (MD) approaches, notwithstanding the current availability of specialized parallel computer architectures, and efficient simulation algorithms. Enhanced MD-based methods have started to assume an important role in the study of the rugged energy landscape of GPCRs by providing mechanistic details of complex receptor processes such as ligand recognition, activation, and oligomerization. We provide here an overview of these methods in their most recent application to the field. PMID:24158803

  1. A hybrid numerical fluid dynamics code for resistive magnetohydrodynamics

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Johnson, Jeffrey

    2006-04-01

    Spasmos is a computational fluid dynamics code that uses two numerical methods to solve the equations of resistive magnetohydrodynamic (MHD) flows in compressible, inviscid, conducting media[1]. The code is implemented as a set of libraries for the Python programming language[2]. It represents conducting and non-conducting gases and materials with uncomplicated (analytic) equations of state. It supports calculations in 1D, 2D, and 3D geometry, though only the 1D configuation has received significant testing to date. Because it uses the Python interpreter as a front end, users can easily write test programs to model systems with a variety of different numerical andmore » physical parameters. Currently, the code includes 1D test programs for hydrodynamics (linear acoustic waves, the Sod weak shock[3], the Noh strong shock[4], the Sedov explosion[5], magnetic diffusion (decay of a magnetic pulse[6], a driven oscillatory "wine-cellar" problem[7], magnetic equilibrium), and magnetohydrodynamics (an advected magnetic pulse[8], linear MHD waves, a magnetized shock tube[9]). Spasmos current runs only in a serial configuration. In the future, it will use MPI for parallel computation.« less

  2. Pseudo-color coding method for high-dynamic single-polarization SAR images

    NASA Astrophysics Data System (ADS)

    Feng, Zicheng; Liu, Xiaolin; Pei, Bingzhi

    2018-04-01

    A raw synthetic aperture radar (SAR) image usually has a 16-bit or higher bit depth, which cannot be directly visualized on 8-bit displays. In this study, we propose a pseudo-color coding method for high-dynamic singlepolarization SAR images. The method considers the characteristics of both SAR images and human perception. In HSI (hue, saturation and intensity) color space, the method carries out high-dynamic range tone mapping and pseudo-color processing simultaneously in order to avoid loss of details and to improve object identifiability. It is a highly efficient global algorithm.

  3. Thermal Decomposition of Condensed-Phase Nitromethane from Molecular Dynamics from ReaxFF Reactive Dynamics

    DTIC Science & Technology

    2011-05-04

    pubs.acs.org/JPCB Thermal Decomposition of Condensed-Phase Nitromethane from Molecular Dynamics from ReaxFF Reactive Dynamics Si-ping Han,†,‡ Adri C. T. van...ABSTRACT: We studied the thermal decomposition and subsequent reaction of the energetic material nitromethane (CH3NO2) using molec- ular dynamics...with ReaxFF, a first principles-based reactive force field. We characterize the chemistry of liquid and solid nitromethane at high temperatures (2000

  4. Non-Adiabatic Molecular Dynamics Methods for Materials Discovery

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Furche, Filipp; Parker, Shane M.; Muuronen, Mikko J.

    2017-04-04

    The flow of radiative energy in light-driven materials such as photosensitizer dyes or photocatalysts is governed by non-adiabatic transitions between electronic states and cannot be described within the Born-Oppenheimer approximation commonly used in electronic structure theory. The non-adiabatic molecular dynamics (NAMD) methods based on Tully surface hopping and time-dependent density functional theory developed in this project have greatly extended the range of molecular materials that can be tackled by NAMD simulations. New algorithms to compute molecular excited state and response properties efficiently were developed. Fundamental limitations of common non-linear response methods were discovered and characterized. Methods for accurate computations ofmore » vibronic spectra of materials such as black absorbers were developed and applied. It was shown that open-shell TDDFT methods capture bond breaking in NAMD simulations, a longstanding challenge for single-reference molecular dynamics simulations. The methods developed in this project were applied to study the photodissociation of acetaldehyde and revealed that non-adiabatic effects are experimentally observable in fragment kinetic energy distributions. Finally, the project enabled the first detailed NAMD simulations of photocatalytic water oxidation by titania nanoclusters, uncovering the mechanism of this fundamentally important reaction for fuel generation and storage.« less

  5. The 2011 Dynamics of Molecular Collisions Conference

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Nesbitt, David J.

    The Dynamics of Molecular Collisions Conference focuses on all aspects of molecular collisions--experimental & theoretical studies of elastic, inelastic, & reactive encounters involving atoms, molecules, ions, clusters, & surfaces--as well as half collisions--photodissociation, photo-induced reaction, & photodesorption. The scientific program for the meeting in 2011 included exciting advances in both the core & multidisciplinary forefronts of the study of molecular collision processes. Following the format of the 2009 meeting, we also invited sessions in special topics that involve interfacial dynamics, novel emerging spectroscopies, chemical dynamics in atmospheric, combustion & interstellar environments, as well as a session devoted to theoretical &more » experimental advances in ultracold molecular samples. Researchers working inside & outside the traditional core topics of the meeting are encouraged to join the conference. We invite contributions of work that seeks understanding of how inter & intra-molecular forces determine the dynamics of the phenomena under study. In addition to invited oral sessions & contributed poster sessions, the scientific program included a formal session consisting of five contributed talks selected from the submitted poster abstracts. The DMC has distinguished itself by having the Herschbach Medal Symposium as part of the meeting format. This tradition of the Herschbach Medal was first started in the 2007 meeting chaired by David Chandler, based on a generous donation of funds & artwork design by Professor Dudley Herschbach himself. There are two such awards made, one for experimental & one for theoretical contributions to the field of Molecular Collision Dynamics, broadly defined. The symposium is always held on the last night of the meeting & has the awardees are asked to deliver an invited lecture on their work. The 2011 Herschbach Medal was dedicated to the contributions of two long standing leaders in Chemical Physics

  6. A centroid molecular dynamics study of liquid para-hydrogen and ortho-deuterium.

    PubMed

    Hone, Tyler D; Voth, Gregory A

    2004-10-01

    Centroid molecular dynamics (CMD) is applied to the study of collective and single-particle dynamics in liquid para-hydrogen at two state points and liquid ortho-deuterium at one state point. The CMD results are compared with the results of classical molecular dynamics, quantum mode coupling theory, a maximum entropy analytic continuation approach, pair-product forward- backward semiclassical dynamics, and available experimental results. The self-diffusion constants are in excellent agreement with the experimental measurements for all systems studied. Furthermore, it is shown that the method is able to adequately describe both the single-particle and collective dynamics of quantum liquids. (c) 2004 American Institute of Physics

  7. Implementation of molecular dynamics and its extensions with the coarse-grained UNRES force field on massively parallel systems; towards millisecond-scale simulations of protein structure, dynamics, and thermodynamics

    PubMed Central

    Liwo, Adam; Ołdziej, Stanisław; Czaplewski, Cezary; Kleinerman, Dana S.; Blood, Philip; Scheraga, Harold A.

    2010-01-01

    We report the implementation of our united-residue UNRES force field for simulations of protein structure and dynamics with massively parallel architectures. In addition to coarse-grained parallelism already implemented in our previous work, in which each conformation was treated by a different task, we introduce a fine-grained level in which energy and gradient evaluation are split between several tasks. The Message Passing Interface (MPI) libraries have been utilized to construct the parallel code. The parallel performance of the code has been tested on a professional Beowulf cluster (Xeon Quad Core), a Cray XT3 supercomputer, and two IBM BlueGene/P supercomputers with canonical and replica-exchange molecular dynamics. With IBM BlueGene/P, about 50 % efficiency and 120-fold speed-up of the fine-grained part was achieved for a single trajectory of a 767-residue protein with use of 256 processors/trajectory. Because of averaging over the fast degrees of freedom, UNRES provides an effective 1000-fold speed-up compared to the experimental time scale and, therefore, enables us to effectively carry out millisecond-scale simulations of proteins with 500 and more amino-acid residues in days of wall-clock time. PMID:20305729

  8. Interfacial Molecular Packing Determines Exciton Dynamics in Molecular Heterostructures: The Case of Pentacene-Perfluoropentacene.

    PubMed

    Rinn, Andre; Breuer, Tobias; Wiegand, Julia; Beck, Michael; Hübner, Jens; Döring, Robin C; Oestreich, Michael; Heimbrodt, Wolfram; Witte, Gregor; Chatterjee, Sangam

    2017-12-06

    The great majority of electronic and optoelectronic devices depend on interfaces between p-type and n-type semiconductors. Finding matching donor-acceptor systems in molecular semiconductors remains a challenging endeavor because structurally compatible molecules may not necessarily be suitable with respect to their optical and electronic properties, and the large exciton binding energy in these materials may favor bound electron-hole pairs rather than free carriers or charge transfer at an interface. Regardless, interfacial charge-transfer exciton states are commonly considered as an intermediate step to achieve exciton dissociation. The formation efficiency and decay dynamics of such states will strongly depend on the molecular makeup of the interface, especially the relative alignment of donor and acceptor molecules. Structurally well-defined pentacene-perfluoropentacene heterostructures of different molecular orientations are virtually ideal model systems to study the interrelation between molecular packing motifs at the interface and their electronic properties. Comparing the emission dynamics of the heterosystems and the corresponding unitary films enables accurate assignment of every observable emission signal in the heterosystems. These heterosystems feature two characteristic interface-specific luminescence channels at around 1.4 and 1.5 eV that are not observed in the unitary samples. Their emission strength strongly depends on the molecular alignment of the respective donor and acceptor molecules, emphasizing the importance of structural control for device construction.

  9. Force field development with GOMC, a fast new Monte Carlo molecular simulation code

    NASA Astrophysics Data System (ADS)

    Mick, Jason Richard

    In this work GOMC (GPU Optimized Monte Carlo) a new fast, flexible, and free molecular Monte Carlo code for the simulation atomistic chemical systems is presented. The results of a large Lennard-Jonesium simulation in the Gibbs ensemble is presented. Force fields developed using the code are also presented. To fit the models a quantitative fitting process is outlined using a scoring function and heat maps. The presented n-6 force fields include force fields for noble gases and branched alkanes. These force fields are shown to be the most accurate LJ or n-6 force fields to date for these compounds, capable of reproducing pure fluid behavior and binary mixture behavior to a high degree of accuracy.

  10. Exact dynamic properties of molecular motors

    NASA Astrophysics Data System (ADS)

    Boon, N. J.; Hoyle, R. B.

    2012-08-01

    Molecular motors play important roles within a biological cell, performing functions such as intracellular transport and gene transcription. Recent experimental work suggests that there are many plausible biochemical mechanisms that molecules such as myosin-V could use to achieve motion. To account for the abundance of possible discrete-stochastic frameworks that can arise when modeling molecular motor walks, a generalized and straightforward graphical method for calculating their dynamic properties is presented. It allows the calculation of the velocity, dispersion, and randomness ratio for any proposed system through analysis of its structure. This article extends work of King and Altman ["A schematic method of deriving the rate laws of enzyme-catalyzed reactions," J. Phys. Chem. 60, 1375-1378 (1956)], 10.1021/j150544a010 on networks of enzymatic reactions by calculating additional dynamic properties for spatially hopping systems. Results for n-state systems are presented: single chain, parallel pathway, divided pathway, and divided pathway with a chain. A novel technique for combining multiple system architectures coupled at a reference state is also demonstrated. Four-state examples illustrate the effectiveness and simplicity of these methods.

  11. Nonholonomic Hamiltonian Method for Molecular Dynamics Simulations of Reacting Shocks

    NASA Astrophysics Data System (ADS)

    Fahrenthold, Eric; Bass, Joseph

    2015-06-01

    Conventional molecular dynamics simulations of reacting shocks employ a holonomic Hamiltonian formulation: the breaking and forming of covalent bonds is described by potential functions. In general these potential functions: (a) are algebraically complex, (b) must satisfy strict smoothness requirements, and (c) contain many fitted parameters. In recent research the authors have developed a new noholonomic formulation of reacting molecular dynamics. In this formulation bond orders are determined by rate equations and the bonding-debonding process need not be described by differentiable functions. This simplifies the representation of complex chemistry and reduces the number of fitted model parameters. Example applications of the method show molecular level shock to detonation simulations in nitromethane and RDX. Research supported by the Defense Threat Reduction Agency.

  12. SCISEAL: A CFD code for analysis of fluid dynamic forces in seals

    NASA Technical Reports Server (NTRS)

    Athavale, Mahesh; Przekwas, Andrzej

    1994-01-01

    A viewgraph presentation is made of the objectives, capabilities, and test results of the computer code SCISEAL. Currently, the seal code has: a finite volume, pressure-based integration scheme; colocated variables with strong conservation approach; high-order spatial differencing, up to third-order; up to second-order temporal differencing; a comprehensive set of boundary conditions; a variety of turbulence models and surface roughness treatment; moving grid formulation for arbitrary rotor whirl; rotor dynamic coefficients calculated by the circular whirl and numerical shaker methods; and small perturbation capabilities to handle centered and eccentric seals.

  13. Natural image sequences constrain dynamic receptive fields and imply a sparse code.

    PubMed

    Häusler, Chris; Susemihl, Alex; Nawrot, Martin P

    2013-11-06

    In their natural environment, animals experience a complex and dynamic visual scenery. Under such natural stimulus conditions, neurons in the visual cortex employ a spatially and temporally sparse code. For the input scenario of natural still images, previous work demonstrated that unsupervised feature learning combined with the constraint of sparse coding can predict physiologically measured receptive fields of simple cells in the primary visual cortex. This convincingly indicated that the mammalian visual system is adapted to the natural spatial input statistics. Here, we extend this approach to the time domain in order to predict dynamic receptive fields that can account for both spatial and temporal sparse activation in biological neurons. We rely on temporal restricted Boltzmann machines and suggest a novel temporal autoencoding training procedure. When tested on a dynamic multi-variate benchmark dataset this method outperformed existing models of this class. Learning features on a large dataset of natural movies allowed us to model spatio-temporal receptive fields for single neurons. They resemble temporally smooth transformations of previously obtained static receptive fields and are thus consistent with existing theories. A neuronal spike response model demonstrates how the dynamic receptive field facilitates temporal and population sparseness. We discuss the potential mechanisms and benefits of a spatially and temporally sparse representation of natural visual input. Copyright © 2013 The Authors. Published by Elsevier B.V. All rights reserved.

  14. NanoString, a novel digital color-coded barcode technology: current and future applications in molecular diagnostics.

    PubMed

    Tsang, Hin-Fung; Xue, Vivian Weiwen; Koh, Su-Pin; Chiu, Ya-Ming; Ng, Lawrence Po-Wah; Wong, Sze-Chuen Cesar

    2017-01-01

    Formalin-fixed, paraffin-embedded (FFPE) tissue sample is a gold mine of resources for molecular diagnosis and retrospective clinical studies. Although molecular technologies have expanded the range of mutations identified in FFPE samples, the applications of existing technologies are limited by the low nucleic acids yield and poor extraction quality. As a result, the routine clinical applications of molecular diagnosis using FFPE samples has been associated with many practical challenges. NanoString technologies utilize a novel digital color-coded barcode technology based on direct multiplexed measurement of gene expression and offer high levels of precision and sensitivity. Each color-coded barcode is attached to a single target-specific probe corresponding to a single gene which can be individually counted without amplification. Therefore, NanoString is especially useful for measuring gene expression in degraded clinical specimens. Areas covered: This article describes the applications of NanoString technologies in molecular diagnostics and challenges associated with its applications and the future development. Expert commentary: Although NanoString technology is still in the early stages of clinical use, it is expected that NanoString-based cancer expression panels would play more important roles in the future in classifying cancer patients and in predicting the response to therapy for better personal therapeutic care.

  15. Dynamics and unfolding pathway of chimeric azurin variants: insights from molecular dynamics simulation.

    PubMed

    Evoli, Stefania; Guzzi, Rita; Rizzuti, Bruno

    2013-10-01

    The spectroscopic, thermal, and functional properties of blue copper proteins can be modulated by mutations in the metal binding loop. Molecular dynamics simulation was used to compare the conformational properties of azurin and two chimeric variants, which were obtained by inserting into the azurin scaffold the copper binding loop of amicyanin and plastocyanin, respectively. Simulations at room temperature show that the proteins retain their overall structure and exhibit concerted motions among specific inner regions, as revealed by principal component analysis. Molecular dynamics at high temperature indicates that the first events in the unfolding pathway are structurally similar in the three proteins and unfolding starts from the region of the α-helix that is far from the metal binding loop. The results provide details of the denaturation process that are consistent with experimental data and in close agreement with other computational approaches, suggesting a distinct mechanism of unfolding of azurin and its chimeric variants. Moreover, differences observed in the dynamics of specific regions in the three proteins correlate with their thermal behavior, contributing to the determination of the basic factors that influence the stability.

  16. Combined Molecular Dynamics Simulation-Molecular-Thermodynamic Theory Framework for Predicting Surface Tensions.

    PubMed

    Sresht, Vishnu; Lewandowski, Eric P; Blankschtein, Daniel; Jusufi, Arben

    2017-08-22

    A molecular modeling approach is presented with a focus on quantitative predictions of the surface tension of aqueous surfactant solutions. The approach combines classical Molecular Dynamics (MD) simulations with a molecular-thermodynamic theory (MTT) [ Y. J. Nikas, S. Puvvada, D. Blankschtein, Langmuir 1992 , 8 , 2680 ]. The MD component is used to calculate thermodynamic and molecular parameters that are needed in the MTT model to determine the surface tension isotherm. The MD/MTT approach provides the important link between the surfactant bulk concentration, the experimental control parameter, and the surfactant surface concentration, the MD control parameter. We demonstrate the capability of the MD/MTT modeling approach on nonionic alkyl polyethylene glycol surfactants at the air-water interface and observe reasonable agreement of the predicted surface tensions and the experimental surface tension data over a wide range of surfactant concentrations below the critical micelle concentration. Our modeling approach can be extended to ionic surfactants and their mixtures with both ionic and nonionic surfactants at liquid-liquid interfaces.

  17. Visualization and Analysis of Microtubule Dynamics Using Dual Color-Coded Display of Plus-End Labels

    PubMed Central

    Garrison, Amy K.; Xia, Caihong; Wang, Zheng; Ma, Le

    2012-01-01

    Investigating spatial and temporal control of microtubule dynamics in live cells is critical to understanding cell morphogenesis in development and disease. Tracking fluorescently labeled plus-end-tracking proteins over time has become a widely used method to study microtubule assembly. Here, we report a complementary approach that uses only two images of these labels to visualize and analyze microtubule dynamics at any given time. Using a simple color-coding scheme, labeled plus-ends from two sequential images are pseudocolored with different colors and then merged to display color-coded ends. Based on object recognition algorithms, these colored ends can be identified and segregated into dynamic groups corresponding to four events, including growth, rescue, catastrophe, and pause. Further analysis yields not only their spatial distribution throughout the cell but also provides measurements such as growth rate and direction for each labeled end. We have validated the method by comparing our results with ground-truth data derived from manual analysis as well as with data obtained using the tracking method. In addition, we have confirmed color-coded representation of different dynamic events by analyzing their history and fate. Finally, we have demonstrated the use of the method to investigate microtubule assembly in cells and provided guidance in selecting optimal image acquisition conditions. Thus, this simple computer vision method offers a unique and quantitative approach to study spatial regulation of microtubule dynamics in cells. PMID:23226282

  18. Structural, dynamic, and vibrational properties during heat transfer in Si/Ge superlattices: A Car-Parrinello molecular dynamics study

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Ji, Pengfei; Zhang, Yuwen, E-mail: zhangyu@missouri.edu; Yang, Mo

    The structural, dynamic, and vibrational properties during heat transfer process in Si/Ge superlattices are studied by analyzing the trajectories generated by the ab initio Car-Parrinello molecular dynamics simulation. The radial distribution functions and mean square displacements are calculated and further discussions are made to explain and probe the structural changes relating to the heat transfer phenomenon. Furthermore, the vibrational density of states of the two layers (Si/Ge) are computed and plotted to analyze the contributions of phonons with different frequencies to the heat conduction. Coherent heat conduction of the low frequency phonons is found and their contributions to facilitate heatmore » transfer are confirmed. The Car-Parrinello molecular dynamics simulation outputs in the work show reasonable thermophysical results of the thermal energy transport process and shed light on the potential applications of treating the heat transfer in the superlattices of semiconductor materials from a quantum mechanical molecular dynamics simulation perspective.« less

  19. Structural, dynamic, and vibrational properties during heat transfer in Si/Ge superlattices: A Car-Parrinello molecular dynamics study

    NASA Astrophysics Data System (ADS)

    Ji, Pengfei; Zhang, Yuwen; Yang, Mo

    2013-12-01

    The structural, dynamic, and vibrational properties during heat transfer process in Si/Ge superlattices are studied by analyzing the trajectories generated by the ab initio Car-Parrinello molecular dynamics simulation. The radial distribution functions and mean square displacements are calculated and further discussions are made to explain and probe the structural changes relating to the heat transfer phenomenon. Furthermore, the vibrational density of states of the two layers (Si/Ge) are computed and plotted to analyze the contributions of phonons with different frequencies to the heat conduction. Coherent heat conduction of the low frequency phonons is found and their contributions to facilitate heat transfer are confirmed. The Car-Parrinello molecular dynamics simulation outputs in the work show reasonable thermophysical results of the thermal energy transport process and shed light on the potential applications of treating the heat transfer in the superlattices of semiconductor materials from a quantum mechanical molecular dynamics simulation perspective.

  20. Molecular dynamics study of some non-hydrogen-bonding base pair DNA strands

    NASA Astrophysics Data System (ADS)

    Tiwari, Rakesh K.; Ojha, Rajendra P.; Tiwari, Gargi; Pandey, Vishnudatt; Mall, Vijaysree

    2018-05-01

    In order to elucidate the structural activity of hydrophobic modified DNA, the DMMO2-D5SICS, base pair is introduced as a constituent in different set of 12-mer and 14-mer DNA sequences for the molecular dynamics (MD) simulation in explicit water solvent. AMBER 14 force field was employed for each set of duplex during the 200ns production-dynamics simulation in orthogonal-box-water solvent by the Particle-Mesh-Ewald (PME) method in infinite periodic boundary conditions (PBC) to determine conformational parameters of the complex. The force-field parameters of modified base-pair were calculated by Gaussian-code using Hartree-Fock /ab-initio methodology. RMSD Results reveal that the conformation of the duplex is sequence dependent and the binding energy of the complex depends on the position of the modified base-pair in the nucleic acid strand. We found that non-bonding energy had a significant contribution to stabilising such type of duplex in comparison to electrostatic energy. The distortion produced within strands by such type of base-pair was local and destabilised the duplex integrity near to substitution, moreover the binding energy of duplex depends on the position of substitution of hydrophobic base-pair and the DNA sequence and strongly supports the corresponding experimental study.

  1. Implementation of metal-friendly EAM/FS-type semi-empirical potentials in HOOMD-blue: A GPU-accelerated molecular dynamics software

    DOE PAGES

    Yang, Lin; Zhang, Feng; Wang, Cai-Zhuang; ...

    2018-01-12

    We present an implementation of EAM and FS interatomic potentials, which are widely used in simulating metallic systems, in HOOMD-blue, a software designed to perform classical molecular dynamics simulations using GPU accelerations. We first discuss the details of our implementation and then report extensive benchmark tests. We demonstrate that single-precision floating point operations efficiently implemented on GPUs can produce sufficient accuracy when compared against double-precision codes, as demonstrated in test simulations of calculations of the glass-transition temperature of Cu 64.5Zr 35.5, and pair correlation function of liquid Ni 3Al. Our code scales well with the size of the simulating systemmore » on NVIDIA Tesla M40 and P100 GPUs. Compared with another popular software LAMMPS running on 32 cores of AMD Opteron 6220 processors, the GPU/CPU performance ratio can reach as high as 4.6. In conclusion, the source code can be accessed through the HOOMD-blue web page for free by any interested user.« less

  2. Implementation of metal-friendly EAM/FS-type semi-empirical potentials in HOOMD-blue: A GPU-accelerated molecular dynamics software

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Yang, Lin; Zhang, Feng; Wang, Cai-Zhuang

    We present an implementation of EAM and FS interatomic potentials, which are widely used in simulating metallic systems, in HOOMD-blue, a software designed to perform classical molecular dynamics simulations using GPU accelerations. We first discuss the details of our implementation and then report extensive benchmark tests. We demonstrate that single-precision floating point operations efficiently implemented on GPUs can produce sufficient accuracy when compared against double-precision codes, as demonstrated in test simulations of calculations of the glass-transition temperature of Cu 64.5Zr 35.5, and pair correlation function of liquid Ni 3Al. Our code scales well with the size of the simulating systemmore » on NVIDIA Tesla M40 and P100 GPUs. Compared with another popular software LAMMPS running on 32 cores of AMD Opteron 6220 processors, the GPU/CPU performance ratio can reach as high as 4.6. In conclusion, the source code can be accessed through the HOOMD-blue web page for free by any interested user.« less

  3. Allosteric dynamics of SAMHD1 studied by molecular dynamics simulations

    NASA Astrophysics Data System (ADS)

    Patra, K. K.; Bhattacharya, A.; Bhattacharya, S.

    2016-10-01

    SAMHD1 is a human cellular enzyme that blocks HIV-1 infection in myeloid cells and non-cycling CD4+T cells. The enzyme is an allosterically regulated triphosphohydrolase that modulates the level of cellular dNTP. The virus restriction is attributed to the lowering of the pool of dNTP in the cell to a point where reverse-transcription is impaired. Mutations in SAMHD1 are also implicated in Aicardi-Goutieres syndrome. A mechanistic understanding of the allosteric activation of the enzyme is still elusive. We have performed molecular dynamics simulations to examine the allosteric site dynamics of the protein and to examine the connection between the stability of the tetrameric complex and the Allosite occupancy.

  4. A fast recursive algorithm for molecular dynamics simulation

    NASA Technical Reports Server (NTRS)

    Jain, A.; Vaidehi, N.; Rodriguez, G.

    1993-01-01

    The present recursive algorithm for solving molecular systems' dynamical equations of motion employs internal variable models that reduce such simulations' computation time by an order of magnitude, relative to Cartesian models. Extensive use is made of spatial operator methods recently developed for analysis and simulation of the dynamics of multibody systems. A factor-of-450 speedup over the conventional O(N-cubed) algorithm is demonstrated for the case of a polypeptide molecule with 400 residues.

  5. Parallel Discrete Molecular Dynamics Simulation With Speculation and In-Order Commitment*†

    PubMed Central

    Khan, Md. Ashfaquzzaman; Herbordt, Martin C.

    2011-01-01

    Discrete molecular dynamics simulation (DMD) uses simplified and discretized models enabling simulations to advance by event rather than by timestep. DMD is an instance of discrete event simulation and so is difficult to scale: even in this multi-core era, all reported DMD codes are serial. In this paper we discuss the inherent difficulties of scaling DMD and present our method of parallelizing DMD through event-based decomposition. Our method is microarchitecture inspired: speculative processing of events exposes parallelism, while in-order commitment ensures correctness. We analyze the potential of this parallelization method for shared-memory multiprocessors. Achieving scalability required extensive experimentation with scheduling and synchronization methods to mitigate serialization. The speed-up achieved for a variety of system sizes and complexities is nearly 6× on an 8-core and over 9× on a 12-core processor. We present and verify analytical models that account for the achieved performance as a function of available concurrency and architectural limitations. PMID:21822327

  6. Sensitivity of peptide conformational dynamics on clustering of a classical molecular dynamics trajectory

    NASA Astrophysics Data System (ADS)

    Jensen, Christian H.; Nerukh, Dmitry; Glen, Robert C.

    2008-03-01

    We investigate the sensitivity of a Markov model with states and transition probabilities obtained from clustering a molecular dynamics trajectory. We have examined a 500ns molecular dynamics trajectory of the peptide valine-proline-alanine-leucine in explicit water. The sensitivity is quantified by varying the boundaries of the clusters and investigating the resulting variation in transition probabilities and the average transition time between states. In this way, we represent the effect of clustering using different clustering algorithms. It is found that in terms of the investigated quantities, the peptide dynamics described by the Markov model is sensitive to the clustering; in particular, the average transition times are found to vary up to 46%. Moreover, inclusion of nonphysical sparsely populated clusters can lead to serious errors of up to 814%. In the investigation, the time step used in the transition matrix is determined by the minimum time scale on which the system behaves approximately Markovian. This time step is found to be about 100ps. It is concluded that the description of peptide dynamics with transition matrices should be performed with care, and that using standard clustering algorithms to obtain states and transition probabilities may not always produce reliable results.

  7. AWE-WQ: Fast-Forwarding Molecular Dynamics Using the Accelerated Weighted Ensemble

    PubMed Central

    2015-01-01

    A limitation of traditional molecular dynamics (MD) is that reaction rates are difficult to compute. This is due to the rarity of observing transitions between metastable states since high energy barriers trap the system in these states. Recently the weighted ensemble (WE) family of methods have emerged which can flexibly and efficiently sample conformational space without being trapped and allow calculation of unbiased rates. However, while WE can sample correctly and efficiently, a scalable implementation applicable to interesting biomolecular systems is not available. We provide here a GPLv2 implementation called AWE-WQ of a WE algorithm using the master/worker distributed computing WorkQueue (WQ) framework. AWE-WQ is scalable to thousands of nodes and supports dynamic allocation of computer resources, heterogeneous resource usage (such as central processing units (CPU) and graphical processing units (GPUs) concurrently), seamless heterogeneous cluster usage (i.e., campus grids and cloud providers), and support for arbitrary MD codes such as GROMACS, while ensuring that all statistics are unbiased. We applied AWE-WQ to a 34 residue protein which simulated 1.5 ms over 8 months with peak aggregate performance of 1000 ns/h. Comparison was done with a 200 μs simulation collected on a GPU over a similar timespan. The folding and unfolded rates were of comparable accuracy. PMID:25207854

  8. Molecular dynamics simulations of human E3 ubiquitin ligase Parkin

    PubMed Central

    Qiu, Shi; Zhu, Shun; Xu, Shan; Han, Yanyan; Liu, Wen; Zuo, Ji

    2017-01-01

    Human E3 ubiquitin protein ligase parkin (Parkin) mediates mitophagy to maintain mitochondrial homeostasis. Parkin mutations are common genetic causes of early onset familial Parkinson's disease. The molecular mechanism of Parkin activation has been widely studied with emerging evidence suggesting an essential role of the phosphorylated (phospho)-ubiquitin interaction. However, the underlying mechanism of the phospho-ubiquitin interaction remains elusive. In the present study, replica exchange molecular dynamics simulations were performed to examine the conformational dynamics of Parkin in monomer and phospho-ubiquitin-bound states. In the Parkin monomer state, high structural flexibilities were observed in the majority of regions of Parkin particularly in the loop domain between the ubiquitin-like (UBL) and really interesting new gene (RING)0 domain. Binding of phospho-ubiquitin stabilizes the RING1/RING in between RING interface but destabilizes the RING1-UBL interface. Furthermore, using steered molecular dynamics simulations of Parkin mutations, it was demonstrated that salt bridge interactions contribute significantly to the interdomain interactions between the RING1 and UBL domain. Taken together, the results of the present study revealed the conformational dynamics of human full-length Parkin in monomer and phospho-ubiquitin-bound states, providing insights into designing potential therapeutics against Parkinson's disease. PMID:28765939

  9. Molecular dynamics simulations of human E3 ubiquitin ligase Parkin.

    PubMed

    Qiu, Shi; Zhu, Shun; Xu, Shan; Han, Yanyan; Liu, Wen; Zuo, Ji

    2017-10-01

    Human E3 ubiquitin protein ligase parkin (Parkin) mediates mitophagy to maintain mitochondrial homeostasis. Parkin mutations are common genetic causes of early onset familial Parkinson's disease. The molecular mechanism of Parkin activation has been widely studied with emerging evidence suggesting an essential role of the phosphorylated (phospho)‑ubiquitin interaction. However, the underlying mecha-nism of the phospho‑ubiquitin interaction remains elusive. In the present study, replica exchange molecular dynamics simulations were performed to examine the conformational dynamics of Parkin in monomer and phospho‑ubiquitin‑bound states. In the Parkin monomer state, high structural flexi-bilities were observed in the majority of regions of Parkin particularly in the loop domain between the ubiquitin‑like (UBL) and really interesting new gene (RING)0 domain. Binding of phospho‑ubiquitin stabilizes the RING1/RING in between RING interface but destabilizes the RING1‑UBL interface. Furthermore, using steered molecular dynamics simulations of Parkin mutations, it was demonstrated that salt bridge interactions contribute significantly to the interdomain interactions between the RING1 and UBL domain. Taken together, the results of the present study revealed the conformational dynamics of human full‑length Parkin in monomer and phospho‑ubiquitin‑bound states, providing insights into designing potential therapeutics against Parkinson's disease.

  10. An analytical benchmark and a Mathematica program for MD codes: Testing LAMMPS on the 2nd generation Brenner potential

    NASA Astrophysics Data System (ADS)

    Favata, Antonino; Micheletti, Andrea; Ryu, Seunghwa; Pugno, Nicola M.

    2016-10-01

    An analytical benchmark and a simple consistent Mathematica program are proposed for graphene and carbon nanotubes, that may serve to test any molecular dynamics code implemented with REBO potentials. By exploiting the benchmark, we checked results produced by LAMMPS (Large-scale Atomic/Molecular Massively Parallel Simulator) when adopting the second generation Brenner potential, we made evident that this code in its current implementation produces results which are offset from those of the benchmark by a significant amount, and provide evidence of the reason.

  11. Extended Lagrangian formulation of charge-constrained tight-binding molecular dynamics.

    PubMed

    Cawkwell, M J; Coe, J D; Yadav, S K; Liu, X-Y; Niklasson, A M N

    2015-06-09

    The extended Lagrangian Born-Oppenheimer molecular dynamics formalism [Niklasson, Phys. Rev. Lett., 2008, 100, 123004] has been applied to a tight-binding model under the constraint of local charge neutrality to yield microcanonical trajectories with both precise, long-term energy conservation and a reduced number of self-consistent field optimizations at each time step. The extended Lagrangian molecular dynamics formalism restores time reversal symmetry in the propagation of the electronic degrees of freedom, and it enables the efficient and accurate self-consistent optimization of the chemical potential and atomwise potential energy shifts in the on-site elements of the tight-binding Hamiltonian that are required when enforcing local charge neutrality. These capabilities are illustrated with microcanonical molecular dynamics simulations of a small metallic cluster using an sd-valent tight-binding model for titanium. The effects of weak dissipation on the propagation of the auxiliary degrees of freedom for the chemical potential and on-site Hamiltonian matrix elements that is used to counteract the accumulation of numerical noise during trajectories was also investigated.

  12. Electron-nuclear corellations for photoinduced dynamics in molecular dimers

    NASA Astrophysics Data System (ADS)

    Kilin, Dmitri S.; Pereversev, Yuryi V.; Prezhdo, Oleg V.

    2003-03-01

    Ultrafast photoinduced dynamics of electronic excitation in molecular dimers is drastically affected by dynamic reorganization of of inter- and intra- molecular nuclear configuration modelled by quantized nuclear degree of freedom [1]. The dynamics of the electronic population and nuclear coherence is analyzed with help of both numerical solution of the chain of coupled differential equations for mean coordinate, population inversion, electronic-vibrational correlation etc.[2] and by propagating the Gaussian wavepackets in relevant adiabatic potentials. Intriguing results were obtained in the approximation of small energy difference and small change of nuclear equilibrium configuration for excited electronic states. In the limiting case of resonance between electronic states energy difference and frequency of the nuclear mode these results have been justified by comparison to exactly solvable Jaynes-Cummings model. It has been found that the photoinduced processes in dimer are arranged according to their time scales:(i) fast scale of nuclear motion,(ii) intermediate scale of dynamical redistribution of electronic population between excited states as well as growth and dynamics of electronic -nuclear correlation,(iii) slow scale of electronic population approaching to the quasiequilibrium distribution, decay of electronic-nuclear correlation, and diminishing the amplitude of mean coordinate oscillations, accompanied by essential growth of the nuclear coordinate dispersion associated with the overall nuclear wavepacket width. Demonstrated quantum-relaxational features of photoinduced vibronic dinamical processess in molecular dimers are obtained by simple method, applicable to large biological systems with many degrees of freedom. [1] J. A. Cina, D. S. Kilin, T. S. Humble, J. Chem. Phys. (2003) in press. [2] O. V. Prezhdo, J. Chem. Phys. 117, 2995 (2002).

  13. Molecular dynamics studies of protein folding and aggregation

    NASA Astrophysics Data System (ADS)

    Ding, Feng

    This thesis applies molecular dynamics simulations and statistical mechanics to study: (i) protein folding; and (ii) protein aggregation. Most small proteins fold into their native states via a first-order-like phase transition with a major free energy barrier between the folded and unfolded states. A set of protein conformations corresponding to the free energy barrier, Delta G >> kBT, are the folding transition state ensemble (TSE). Due to their evasive nature, TSE conformations are hard to capture (probability ∝ exp(-DeltaG/k BT)) and characterize. A coarse-grained discrete molecular dynamics model with realistic steric constraints is constructed to reproduce the experimentally observed two-state folding thermodynamics. A kinetic approach is proposed to identify the folding TSE. A specific set of contacts, common to the TSE conformations, is identified as the folding nuclei which are necessary to be formed in order for the protein to fold. Interestingly, the amino acids at the site of the identified folding nuclei are highly conserved for homologous proteins sharing the same structures. Such conservation suggests that amino acids that are important for folding kinetics are under selective pressure to be preserved during the course of molecular evolution. In addition, studies of the conformations close to the transition states uncover the importance of topology in the construction of order parameter for protein folding transition. Misfolded proteins often form insoluble aggregates, amyloid fibrils, that deposit in the extracellular space and lead to a type of disease known as amyloidosis. Due to its insoluble and non-crystalline nature, the aggregation structure and, thus the aggregation mechanism, has yet to be uncovered. Discrete molecular dynamics studies reveal an aggregate structure with the same structural signatures as in experimental observations and show a nucleation aggregation scenario. The simulations also suggest a generic aggregation mechanism

  14. Performance Evaluation of NWChem Ab-Initio Molecular Dynamics (AIMD) Simulations on the Intel® Xeon Phi™ Processor

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Bylaska, Eric J.; Jacquelin, Mathias; De Jong, Wibe A.

    2017-10-20

    Ab-initio Molecular Dynamics (AIMD) methods are an important class of algorithms, as they enable scientists to understand the chemistry and dynamics of molecular and condensed phase systems while retaining a first-principles-based description of their interactions. Many-core architectures such as the Intel® Xeon Phi™ processor are an interesting and promising target for these algorithms, as they can provide the computational power that is needed to solve interesting problems in chemistry. In this paper, we describe the efforts of refactoring the existing AIMD plane-wave method of NWChem from an MPI-only implementation to a scalable, hybrid code that employs MPI and OpenMP tomore » exploit the capabilities of current and future many-core architectures. We describe the optimizations required to get close to optimal performance for the multiplication of the tall-and-skinny matrices that form the core of the computational algorithm. We present strong scaling results on the complete AIMD simulation for a test case that simulates 256 water molecules and that strong-scales well on a cluster of 1024 nodes of Intel Xeon Phi processors. We compare the performance obtained with a cluster of dual-socket Intel® Xeon® E5–2698v3 processors.« less

  15. Insight into the Li2CO3-K2CO3 eutectic mixture from classical molecular dynamics: Thermodynamics, structure, and dynamics

    NASA Astrophysics Data System (ADS)

    Corradini, Dario; Coudert, François-Xavier; Vuilleumier, Rodolphe

    2016-03-01

    We use molecular dynamics simulations to study the thermodynamics, structure, and dynamics of the Li2CO3-K2CO3 (62:38 mol. %) eutectic mixture. We present a new classical non-polarizable force field for this molten salt mixture, optimized using experimental and first principles molecular dynamics simulations data as reference. This simple force field allows efficient molecular simulations of phenomena at long time scales. We use this optimized force field to describe the behavior of the eutectic mixture in the 900-1100 K temperature range, at pressures between 0 and 5 GPa. After studying the equation of state in these thermodynamic conditions, we present molecular insight into the structure and dynamics of the melt. In particular, we present an analysis of the temperature and pressure dependence of the eutectic mixture's self-diffusion coefficients, viscosity, and ionic conductivity.

  16. Insight into the Li2CO3-K2CO3 eutectic mixture from classical molecular dynamics: Thermodynamics, structure, and dynamics.

    PubMed

    Corradini, Dario; Coudert, François-Xavier; Vuilleumier, Rodolphe

    2016-03-14

    We use molecular dynamics simulations to study the thermodynamics, structure, and dynamics of the Li2CO3-K2CO3 (62:38 mol. %) eutectic mixture. We present a new classical non-polarizable force field for this molten salt mixture, optimized using experimental and first principles molecular dynamics simulations data as reference. This simple force field allows efficient molecular simulations of phenomena at long time scales. We use this optimized force field to describe the behavior of the eutectic mixture in the 900-1100 K temperature range, at pressures between 0 and 5 GPa. After studying the equation of state in these thermodynamic conditions, we present molecular insight into the structure and dynamics of the melt. In particular, we present an analysis of the temperature and pressure dependence of the eutectic mixture's self-diffusion coefficients, viscosity, and ionic conductivity.

  17. Evaluating data mining algorithms using molecular dynamics trajectories.

    PubMed

    Tatsis, Vasileios A; Tjortjis, Christos; Tzirakis, Panagiotis

    2013-01-01

    Molecular dynamics simulations provide a sample of a molecule's conformational space. Experiments on the mus time scale, resulting in large amounts of data, are nowadays routine. Data mining techniques such as classification provide a way to analyse such data. In this work, we evaluate and compare several classification algorithms using three data sets which resulted from computer simulations, of a potential enzyme mimetic biomolecule. We evaluated 65 classifiers available in the well-known data mining toolkit Weka, using 'classification' errors to assess algorithmic performance. Results suggest that: (i) 'meta' classifiers perform better than the other groups, when applied to molecular dynamics data sets; (ii) Random Forest and Rotation Forest are the best classifiers for all three data sets; and (iii) classification via clustering yields the highest classification error. Our findings are consistent with bibliographic evidence, suggesting a 'roadmap' for dealing with such data.

  18. Quantum wavepacket ab initio molecular dynamics: an approach for computing dynamically averaged vibrational spectra including critical nuclear quantum effects.

    PubMed

    Sumner, Isaiah; Iyengar, Srinivasan S

    2007-10-18

    We have introduced a computational methodology to study vibrational spectroscopy in clusters inclusive of critical nuclear quantum effects. This approach is based on the recently developed quantum wavepacket ab initio molecular dynamics method that combines quantum wavepacket dynamics with ab initio molecular dynamics. The computational efficiency of the dynamical procedure is drastically improved (by several orders of magnitude) through the utilization of wavelet-based techniques combined with the previously introduced time-dependent deterministic sampling procedure measure to achieve stable, picosecond length, quantum-classical dynamics of electrons and nuclei in clusters. The dynamical information is employed to construct a novel cumulative flux/velocity correlation function, where the wavepacket flux from the quantized particle is combined with classical nuclear velocities to obtain the vibrational density of states. The approach is demonstrated by computing the vibrational density of states of [Cl-H-Cl]-, inclusive of critical quantum nuclear effects, and our results are in good agreement with experiment. A general hierarchical procedure is also provided, based on electronic structure harmonic frequencies, classical ab initio molecular dynamics, computation of nuclear quantum-mechanical eigenstates, and employing quantum wavepacket ab initio dynamics to understand vibrational spectroscopy in hydrogen-bonded clusters that display large degrees of anharmonicities.

  19. Reasoning with Atomic-Scale Molecular Dynamic Models

    ERIC Educational Resources Information Center

    Pallant, Amy; Tinker, Robert F.

    2004-01-01

    The studies reported in this paper are an initial effort to explore the applicability of computational models in introductory science learning. Two instructional interventions are described that use a molecular dynamics model embedded in a set of online learning activities with middle and high school students in 10 classrooms. The studies indicate…

  20. High-performance computational fluid dynamics: a custom-code approach

    NASA Astrophysics Data System (ADS)

    Fannon, James; Loiseau, Jean-Christophe; Valluri, Prashant; Bethune, Iain; Náraigh, Lennon Ó.

    2016-07-01

    We introduce a modified and simplified version of the pre-existing fully parallelized three-dimensional Navier-Stokes flow solver known as TPLS. We demonstrate how the simplified version can be used as a pedagogical tool for the study of computational fluid dynamics (CFDs) and parallel computing. TPLS is at its heart a two-phase flow solver, and uses calls to a range of external libraries to accelerate its performance. However, in the present context we narrow the focus of the study to basic hydrodynamics and parallel computing techniques, and the code is therefore simplified and modified to simulate pressure-driven single-phase flow in a channel, using only relatively simple Fortran 90 code with MPI parallelization, but no calls to any other external libraries. The modified code is analysed in order to both validate its accuracy and investigate its scalability up to 1000 CPU cores. Simulations are performed for several benchmark cases in pressure-driven channel flow, including a turbulent simulation, wherein the turbulence is incorporated via the large-eddy simulation technique. The work may be of use to advanced undergraduate and graduate students as an introductory study in CFDs, while also providing insight for those interested in more general aspects of high-performance computing.

  1. Molecular dynamics simulation and NMR investigation of the association of the β-blockers atenolol and propranolol with a chiral molecular micelle

    NASA Astrophysics Data System (ADS)

    Morris, Kevin F.; Billiot, Eugene J.; Billiot, Fereshteh H.; Hoffman, Charlene B.; Gladis, Ashley A.; Lipkowitz, Kenny B.; Southerland, William M.; Fang, Yayin

    2015-08-01

    Molecular dynamics simulations and NMR spectroscopy were used to compare the binding of two β-blocker drugs to the chiral molecular micelle poly-(sodium undecyl-(L)-leucine-valine). The molecular micelle is used as a chiral selector in capillary electrophoresis. This study is part of a larger effort to understand the mechanism of chiral recognition in capillary electrophoresis by characterizing the molecular micelle binding of chiral compounds with different geometries and charges. Propranolol and atenolol were chosen because their structures are similar, but their chiral interactions with the molecular micelle are different. Molecular dynamics simulations showed both propranolol enantiomers inserted their aromatic rings into the molecular micelle core and that (S)-propranolol associated more strongly with the molecular micelle than (R)-propranolol. This difference was attributed to stronger molecular micelle hydrogen bonding interactions experienced by (S)-propranolol. Atenolol enantiomers were found to bind near the molecular micelle surface and to have similar molecular micelle binding free energies.

  2. Molecular dynamics simulation of low-energy recoil events in titanate pyrochlores

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Dong, Liyuan; Setyawan, Wahyu; Li, Yuhong

    2017-01-01

    Molecular dynamics simulations of low-energy displacements in titanate pyrochlores have been carried out along three main directions, to determineE dfor A, Ti and O, corresponding defect configurations, and defect formation dynamics.

  3. Characterizing rare-event property distributions via replicate molecular dynamics simulations of proteins.

    PubMed

    Krishnan, Ranjani; Walton, Emily B; Van Vliet, Krystyn J

    2009-11-01

    As computational resources increase, molecular dynamics simulations of biomolecules are becoming an increasingly informative complement to experimental studies. In particular, it has now become feasible to use multiple initial molecular configurations to generate an ensemble of replicate production-run simulations that allows for more complete characterization of rare events such as ligand-receptor unbinding. However, there are currently no explicit guidelines for selecting an ensemble of initial configurations for replicate simulations. Here, we use clustering analysis and steered molecular dynamics simulations to demonstrate that the configurational changes accessible in molecular dynamics simulations of biomolecules do not necessarily correlate with observed rare-event properties. This informs selection of a representative set of initial configurations. We also employ statistical analysis to identify the minimum number of replicate simulations required to sufficiently sample a given biomolecular property distribution. Together, these results suggest a general procedure for generating an ensemble of replicate simulations that will maximize accurate characterization of rare-event property distributions in biomolecules.

  4. Code Verification of the HIGRAD Computational Fluid Dynamics Solver

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Van Buren, Kendra L.; Canfield, Jesse M.; Hemez, Francois M.

    2012-05-04

    The purpose of this report is to outline code and solution verification activities applied to HIGRAD, a Computational Fluid Dynamics (CFD) solver of the compressible Navier-Stokes equations developed at the Los Alamos National Laboratory, and used to simulate various phenomena such as the propagation of wildfires and atmospheric hydrodynamics. Code verification efforts, as described in this report, are an important first step to establish the credibility of numerical simulations. They provide evidence that the mathematical formulation is properly implemented without significant mistakes that would adversely impact the application of interest. Highly accurate analytical solutions are derived for four code verificationmore » test problems that exercise different aspects of the code. These test problems are referred to as: (i) the quiet start, (ii) the passive advection, (iii) the passive diffusion, and (iv) the piston-like problem. These problems are simulated using HIGRAD with different levels of mesh discretization and the numerical solutions are compared to their analytical counterparts. In addition, the rates of convergence are estimated to verify the numerical performance of the solver. The first three test problems produce numerical approximations as expected. The fourth test problem (piston-like) indicates the extent to which the code is able to simulate a 'mild' discontinuity, which is a condition that would typically be better handled by a Lagrangian formulation. The current investigation concludes that the numerical implementation of the solver performs as expected. The quality of solutions is sufficient to provide credible simulations of fluid flows around wind turbines. The main caveat associated to these findings is the low coverage provided by these four problems, and somewhat limited verification activities. A more comprehensive evaluation of HIGRAD may be beneficial for future studies.« less

  5. Molecular dynamics simulations of aqueous solutions of ethanolamines.

    PubMed

    López-Rendón, Roberto; Mora, Marco A; Alejandre, José; Tuckerman, Mark E

    2006-08-03

    We report on molecular dynamics simulations performed at constant temperature and pressure to study ethanolamines as pure components and in aqueous solutions. A new geometric integration algorithm that preserves the correct phase space volume is employed to study molecules having up to three ethanol chains. The most stable geometry, rotational barriers, and atomic charges were obtained by ab initio calculations in the gas phase. The calculated dipole moments agree well with available experimental data. The most stable conformation, due to intramolecular hydrogen bonding interactions, has a ringlike structure in one of the ethanol chains, leading to high molecular stability. All molecular dynamics simulations were performed in the liquid phase. The interaction parameters are the same for the atoms in the ethanol chains, reducing the number of variables in the potential model. Intermolecular hydrogen bonding is also analyzed, and it is shown that water associates at low water mole fractions. The force field reproduced (within 1%) the experimental liquid densities at different temperatures of pure components and aqueous solutions at 313 K. The excess and partial molar volumes are analyzed as a function of ethanolamine concentration.

  6. Drugs That Target Dynamic Microtubules: A New Molecular Perspective

    PubMed Central

    Stanton, Richard A.; Gernert, Kim M.; Nettles, James H.; Aneja, Ritu

    2011-01-01

    Microtubules have long been considered an ideal target for anticancer drugs because of the essential role they play in mitosis, forming the dynamic spindle apparatus. As such, there is a wide variety of compounds currently in clinical use and in development that act as antimitotic agents by altering microtubule dynamics. Although these diverse molecules are known to affect microtubule dynamics upon binding to one of the three established drug domains (taxane, vinca alkaloid, or colchicine site), the exact mechanism by which each drug works is still an area of intense speculation and research. In this study, we review the effects of microtubule-binding chemotherapeutic agents from a new perspective, considering how their mode of binding induces conformational changes and alters biological function relative to the molecular vectors of microtubule assembly or disassembly. These “biological vectors” can thus be used as a spatiotemporal context to describe molecular mechanisms by which microtubule-targeting drugs work. PMID:21381049

  7. Moving Contact Lines: Linking Molecular Dynamics and Continuum-Scale Modeling.

    PubMed

    Smith, Edward R; Theodorakis, Panagiotis E; Craster, Richard V; Matar, Omar K

    2018-05-17

    Despite decades of research, the modeling of moving contact lines has remained a formidable challenge in fluid dynamics whose resolution will impact numerous industrial, biological, and daily life applications. On the one hand, molecular dynamics (MD) simulation has the ability to provide unique insight into the microscopic details that determine the dynamic behavior of the contact line, which is not possible with either continuum-scale simulations or experiments. On the other hand, continuum-based models provide a link to the macroscopic description of the system. In this Feature Article, we explore the complex range of physical factors, including the presence of surfactants, which governs the contact line motion through MD simulations. We also discuss links between continuum- and molecular-scale modeling and highlight the opportunities for future developments in this area.

  8. Dynamic combinatorial libraries: from exploring molecular recognition to systems chemistry.

    PubMed

    Li, Jianwei; Nowak, Piotr; Otto, Sijbren

    2013-06-26

    Dynamic combinatorial chemistry (DCC) is a subset of combinatorial chemistry where the library members interconvert continuously by exchanging building blocks with each other. Dynamic combinatorial libraries (DCLs) are powerful tools for discovering the unexpected and have given rise to many fascinating molecules, ranging from interlocked structures to self-replicators. Furthermore, dynamic combinatorial molecular networks can produce emergent properties at systems level, which provide exciting new opportunities in systems chemistry. In this perspective we will highlight some new methodologies in this field and analyze selected examples of DCLs that are under thermodynamic control, leading to synthetic receptors, catalytic systems, and complex self-assembled supramolecular architectures. Also reviewed are extensions of the principles of DCC to systems that are not at equilibrium and may therefore harbor richer functional behavior. Examples include self-replication and molecular machines.

  9. Computational Studies on the Anharmonic Dynamics of Molecular Clusters

    NASA Astrophysics Data System (ADS)

    Mancini, John S.

    Molecular nanoclusters present ideal systems to probe the physical forces and dynamics that drive the behavior of larger bulk systems. At the nanocluster limit the first instances of several phenomena can be observed including the breaking of hydrogen and molecular bonds. Advancements in experimental and theoretical techniques have made it possible to explore these phenomena in great detail. The most fruitful of these studies have involved the use of both experimental and theoretical techniques to leverage to strengths of the two approaches. This dissertation seeks to explore several important phenomena of molecular clusters using new and existing theoretical methodologies. Three specific systems are considered, hydrogen chloride clusters, mixed water and hydrogen chloride clusters and the first cluster where hydrogen chloride autoionization occurs. The focus of these studies remain as close as possible to experimentally observable phenomena with the intention of validating, simulating and expanding on experimental work. Specifically, the properties of interested are those related to the vibrational ground and excited state dynamics of these systems. Studies are performed using full and reduced dimensional potential energy surface alongside advanced quantum mechanical methods including diffusion Monte Carlo, vibrational configuration interaction theory and quasi-classical molecular dynamics. The insight gained from these studies are great and varied. A new on-they-fly ab initio method for studying molecular clusters is validated for (HCl)1--6. A landmark study of the dissociation energy and predissociation mechanism of (HCl)3 is reported. The ground states of mixed (HCl)n(H2O)m are found to be highly delocalized across multiple stationary point configurations. Furthermore, it is identified that the consideration of this delocalization is required in vibrational excited state calculations to achieve agreement with experimental measurements. Finally, the theoretical

  10. Application of Multiplexed Replica Exchange Molecular Dynamics to the UNRES Force Field: Tests with α and α+β Proteins

    PubMed Central

    Czaplewski, Cezary; Kalinowski, Sebastian; Liwo, Adam; Scheraga, Harold A.

    2009-01-01

    The replica exchange (RE) method is increasingly used to improve sampling in molecular dynamics (MD) simulations of biomolecular systems. Recently, we implemented the united-residue UNRES force field for mesoscopic MD. Initial results from UNRES MD simulations show that we are able to simulate folding events that take place in a microsecond or even a millisecond time scale. To speed up the search further, we applied the multiplexing replica exchange molecular dynamics (MREMD) method. The multiplexed variant (MREMD) of the RE method, developed by Rhee and Pande, differs from the original RE method in that several trajectories are run at a given temperature. Each set of trajectories run at a different temperature constitutes a layer. Exchanges are attempted not only within a single layer but also between layers. The code has been parallelized and scales up to 4000 processors. We present a comparison of canonical MD, REMD, and MREMD simulations of protein folding with the UNRES force-field. We demonstrate that the multiplexed procedure increases the power of replica exchange MD considerably and convergence of the thermodynamic quantities is achieved much faster. PMID:20161452

  11. Investigation of the dynamics of aqueous proline solutions using neutron scattering and molecular dynamics simulations.

    PubMed

    Malo de Molina, Paula; Alvarez, Fernando; Frick, Bernhard; Wildes, Andrew; Arbe, Arantxa; Colmenero, Juan

    2017-10-18

    We applied quasielastic neutron scattering (QENS) techniques to samples with two different contrasts (deuterated solute/hydrogenated solvent and the opposite label) to selectively study the component dynamics of proline/water solutions. Results on diluted and concentrated solutions (31 and 6 water molecules/proline molecule, respectively) were analyzed in terms of the susceptibility and considering a recently proposed model for water dynamics [Arbe et al., Phys. Rev. Lett., 2016, 117, 185501] which includes vibrations and the convolution of localized motions and diffusion. We found that proline molecules not only reduce the average diffusion coefficient of water but also extend the time/frequency range of the crossover region ('cage') between the vibrations and purely diffusive behavior. For the high proline concentration we also found experimental evidence of water heterogeneous dynamics and a distribution of diffusion coefficients. Complementary molecular dynamics simulations show that water molecules start to perform rotational diffusion when they escape the cage regime but before the purely diffusive behavior is established. The rotational diffusion regime is also retarded by the presence of proline molecules. On the other hand, a strong coupling between proline and water diffusive dynamics which persists with decreasing temperature is directly observed using QENS. Not only are the temperature dependences of the diffusion coefficients of both components the same, but their absolute values also approach each other with increasing proline concentration. We compared our results with those reported using other techniques, in particular using dielectric spectroscopy (DS). A simple approach based on molecular hydrodynamics and a molecular treatment of DS allows rationalizing the a priori puzzling inconsistency between QENS and dielectric results regarding the dynamic coupling of the two components. The interpretation proposed is based on general grounds and therefore

  12. Molecular dynamics of individual alpha-helices of bacteriorhodopsin in dimyristol phosphatidylocholine. I. Structure and dynamics.

    PubMed

    Woolf, T B

    1997-11-01

    Understanding the role of the lipid bilayer in membrane protein structure and dynamics is needed for tertiary structure determination methods. However, the molecular details are not well understood. Molecular dynamics computer calculations can provide insight into these molecular details of protein:lipid interactions. This paper reports on 10 simulations of individual alpha-helices in explicit lipid bilayers. The 10 helices were selected from the bacteriorhodopsin structure as representative alpha-helical membrane folding components. The bilayer is constructed of dimyristoyl phosphatidylcholine molecules. The only major difference between simulations is the primary sequence of the alpha-helix. The results show dramatic differences in motional behavior between alpha-helices. For example, helix A has much smaller root-mean-squared deviations than does helix D. This can be understood in terms of the presence of aromatic residues at the interface for helix A that are not present in helix D. Additional motions are possible for the helices that contain proline side chains relative to other amino acids. The results thus provide insight into the types of motion and the average structures possible for helices within the bilayer setting and demonstrate the strength of molecular simulations in providing molecular details that are not directly visualized in experiments.

  13. GPU-accelerated Tersoff potentials for massively parallel Molecular Dynamics simulations

    NASA Astrophysics Data System (ADS)

    Nguyen, Trung Dac

    2017-03-01

    The Tersoff potential is one of the empirical many-body potentials that has been widely used in simulation studies at atomic scales. Unlike pair-wise potentials, the Tersoff potential involves three-body terms, which require much more arithmetic operations and data dependency. In this contribution, we have implemented the GPU-accelerated version of several variants of the Tersoff potential for LAMMPS, an open-source massively parallel Molecular Dynamics code. Compared to the existing MPI implementation in LAMMPS, the GPU implementation exhibits a better scalability and offers a speedup of 2.2X when run on 1000 compute nodes on the Titan supercomputer. On a single node, the speedup ranges from 2.0 to 8.0 times, depending on the number of atoms per GPU and hardware configurations. The most notable features of our GPU-accelerated version include its design for MPI/accelerator heterogeneous parallelism, its compatibility with other functionalities in LAMMPS, its ability to give deterministic results and to support both NVIDIA CUDA- and OpenCL-enabled accelerators. Our implementation is now part of the GPU package in LAMMPS and accessible for public use.

  14. Molecular dynamics study of silicon carbide properties under external dynamic loading

    NASA Astrophysics Data System (ADS)

    Utkin, A. V.; Fomin, V. M.

    2017-10-01

    In this study, molecular dynamic simulations of high-velocity impact of a spherical 3C-SiC cluster, with a wide range of velocities (from 100 to 2600 m/s) and with a rigid wall, were performed. The analysis of the final structure shows that no structural phase transformation occurred in the material, despite the high pressure during the collision process.

  15. Concise NMR approach for molecular dynamics characterizations in organic solids.

    PubMed

    Aliev, Abil E; Courtier-Murias, Denis

    2013-08-22

    Molecular dynamics characterisations in solids can be carried out selectively using dipolar-dephasing experiments. Here we show that the introduction of a sum of Lorentzian and Gaussian functions greatly improve fittings of the "intensity versus time" data for protonated carbons in dipolar-dephasing experiments. The Lorentzian term accounts for remote intra- and intermolecular (1)H-(13)C dipole-dipole interactions, which vary from one molecule to another or for different carbons within the same molecule. Thus, by separating contributions from weak remote interactions, more accurate Gaussian decay constants, T(dd), can be extracted for directly bonded (1)H-(13)C dipole-dipole interactions. Reorientations of the (1)H-(13)C bonds lead to the increase of T(dd), and by measuring dipolar-dephasing constants, insight can be gained into dynamics in solids. We have demonstrated advantages of the method using comparative dynamics studies in the α and γ polymorphs of glycine, cyclic amino acids L-proline, DL-proline and trans-4-hydroxy-L-proline, the Ala residue in different dipeptides, as well as adamantane and hexamethylenetetramine. It was possible to distinguish subtle differences in dynamics of different carbon sites within a molecule in polymorphs and in L- and DL-forms. The presence of overall molecular motions is shown to lead to particularly large differences in dipolar-dephasing experiments. The differences in dynamics can be attributed to differences in noncovalent interactions. In the case of hexamethylenetetramine, for example, the presence of C-H···N interactions leads to nearly rigid molecules. Overall, the method allows one to gain insight into the role of noncovalent interactions in solids and their influence on the molecular dynamics.

  16. A Direct, Quantitative Connection between Molecular Dynamics Simulations and Vibrational Probe Line Shapes.

    PubMed

    Xu, Rosalind J; Blasiak, Bartosz; Cho, Minhaeng; Layfield, Joshua P; Londergan, Casey H

    2018-05-17

    A quantitative connection between molecular dynamics simulations and vibrational spectroscopy of probe-labeled systems would enable direct translation of experimental data into structural and dynamical information. To constitute this connection, all-atom molecular dynamics (MD) simulations were performed for two SCN probe sites (solvent-exposed and buried) in a calmodulin-target peptide complex. Two frequency calculation approaches with substantial nonelectrostatic components, a quantum mechanics/molecular mechanics (QM/MM)-based technique and a solvatochromic fragment potential (SolEFP) approach, were used to simulate the infrared probe line shapes. While QM/MM results disagreed with experiment, SolEFP results matched experimental frequencies and line shapes and revealed the physical and dynamic bases for the observed spectroscopic behavior. The main determinant of the CN probe frequency is the exchange repulsion between the probe and its local structural neighbors, and there is a clear dynamic explanation for the relatively broad probe line shape observed at the "buried" probe site. This methodology should be widely applicable to vibrational probes in many environments.

  17. Molecular dynamics computer simulation of permeation in solids

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Pohl, P.I.; Heffelfinger, G.S.; Fisler, D.K.

    1997-12-31

    In this work the authors simulate permeation of gases and cations in solid models using molecular mechanics and a dual control volume grand canonical molecular dynamics technique. The molecular sieving nature of microporous zeolites are discussed and compared with that for amorphous silica made by sol-gel methods. One mesoporous and one microporous membrane model are tested with Lennard-Jones gases corresponding to He, H{sub 2}, Ar and CH{sub 4}. The mesoporous membrane model clearly follows a Knudsen diffusion mechanism, while the microporous model having a hard-sphere cutoff pore diameter of {approximately}3.4 {angstrom} demonstrates molecular sieving of the methane ({sigma} = 3.8more » {angstrom}) but anomalous behavior for Ar ({sigma} = 3.4 {angstrom}). Preliminary results of Ca{sup +} diffusion in calcite and He/H{sub 2} diffusion in polyisobutylene are also presented.« less

  18. Exploring GPCR-Lipid Interactions by Molecular Dynamics Simulations: Excitements, Challenges, and the Way Forward.

    PubMed

    Sengupta, Durba; Prasanna, Xavier; Mohole, Madhura; Chattopadhyay, Amitabha

    2018-06-07

    Gprotein-coupled receptors (GPCRs) are seven transmembrane receptors that mediate a large number of cellular responses and are important drug targets. One of the current challenges in GPCR biology is to analyze the molecular signatures of receptor-lipid interactions and their subsequent effects on GPCR structure, organization, and function. Molecular dynamics simulation studies have been successful in predicting molecular determinants of receptor-lipid interactions. In particular, predicted cholesterol interaction sites appear to correspond well with experimentally determined binding sites and estimated time scales of association. In spite of several success stories, the methodologies in molecular dynamics simulations are still emerging. In this Feature Article, we provide a comprehensive overview of coarse-grain and atomistic molecular dynamics simulations of GPCR-lipid interaction in the context of experimental observations. In addition, we discuss the effect of secondary and tertiary structural constraints in coarse-grain simulations in the context of functional dynamics and structural plasticity of GPCRs. We envision that this comprehensive overview will help resolve differences in computational studies and provide a way forward.

  19. Atomic and Molecular Dynamics on and in Superfluid Helium Nanodroplets

    NASA Astrophysics Data System (ADS)

    Lehmann, Kevin K.

    2003-03-01

    Studies of intramolecular and intermolecular dynamics is at the core of Molecular Spectroscopic research several decades. Gas phase, particularly molecular beam, studies have greatly illuminated these processes in isolated molecules, bimolecular collisions, or small covalent and van der Waals complexes. Parallel to this effort have been studies in condensed phases, but there has unfortunately been little intellectual contact between these. The recent development of Helium Nanodropet Isolation Spectroscopy is providing an intellectual bridge between gas phase and condensed phase spectroscopy. While droplets of 10,000 He atoms are effectively a condensed phase, their low temperature ( 0.4 K) and ultralow heat capacities combined with their superfluid state make them an almost ideal matrix in which to study both molecular dynamics, including solute induced relaxations. The nsec times scales for many of the relaxation events, orders of magnitude slower than in classical liquids, results in spectra with unprecedented resolution for the liquid state. In this talk, studies of the Princeton group will be highlighted, with particular emphasis on those for which a combination of theory and experiment have combined to reveal dynamics in this unique Quantum Fluid.

  20. Integrating atomistic molecular dynamics simulations, experiments, and network analysis to study protein dynamics: strength in unity.

    PubMed

    Papaleo, Elena

    2015-01-01

    In the last years, we have been observing remarkable improvements in the field of protein dynamics. Indeed, we can now study protein dynamics in atomistic details over several timescales with a rich portfolio of experimental and computational techniques. On one side, this provides us with the possibility to validate simulation methods and physical models against a broad range of experimental observables. On the other side, it also allows a complementary and comprehensive view on protein structure and dynamics. What is needed now is a better understanding of the link between the dynamic properties that we observe and the functional properties of these important cellular machines. To make progresses in this direction, we need to improve the physical models used to describe proteins and solvent in molecular dynamics, as well as to strengthen the integration of experiments and simulations to overcome their own limitations. Moreover, now that we have the means to study protein dynamics in great details, we need new tools to understand the information embedded in the protein ensembles and in their dynamic signature. With this aim in mind, we should enrich the current tools for analysis of biomolecular simulations with attention to the effects that can be propagated over long distances and are often associated to important biological functions. In this context, approaches inspired by network analysis can make an important contribution to the analysis of molecular dynamics simulations.

  1. Molecular ordering and molecular dynamics in isotactic-polypropylene characterized by solid state NMR.

    PubMed

    Miyoshi, Toshikazu; Mamun, Al; Hu, Wei

    2010-01-14

    The order-disorder phenomenon of local packing structures, space heterogeneity, and molecular dynamics and average lamellar thickness, , of the alpha form of isotactic polypropylene (iPP) crystallized at various supercooling temperatures, DeltaT, are investigated by solid-state (SS) NMR and SAXS, respectively. increases with lowering DeltaT, and extrapolations of (-1) versus averaged melting point, , gives an equilibrium melting temperature, T(m)(0) = 457 +/- 4 K. High-power TPPM decoupling with a field strength of 110 kHz extremely improves (13)C high-resolution SS-NMR spectral resolution of the ordered crystalline signals at various DeltaT. A high-resolution (13)C SS-NMR spectrum combined with a conventional spin-lattice relaxation time in the rotating frame (T(1rhoH)) filter easily accesses an order-disorder phenomenon for upward and downward orientations of stems and their packing in the crystalline region. It is found that ordered packing fraction, f(order), increases with lowering DeltaT and reaches a maximum value of 62% at DeltaT = 34 K. The ordering phenomenon of stem packing indicates that chain-folding direction changes from random in the disordered packing to order in the ordered packing along the a sin theta axis under a hypothesis of adjacent re-entry structures. It is also found that f(order) significantly increases prior to enhancement of lamellar thickness. Additionally, annealing experiments indicate that is significantly enhanced after a simultaneous process of partial melting and recrystallization/reorganization into the ordered packing at annealing temperature >/=423 K. Furthermore, the center-bands only detection of exchange (CODEX) NMR method demonstrates that time-kinetic parameters of helical jump motions are highly influenced by DeltaT. These dynamic constraints are interpreted in terms of increment of and packing ordering. Through these new results related to molecular structures and dynamics, roles of polymer

  2. Molecular electron recollision dynamics in intense circularly polarized laser pulses

    NASA Astrophysics Data System (ADS)

    Bandrauk, André D.; Yuan, Kai-Jun

    2018-04-01

    Extreme UV and x-ray table top light sources based on high-order harmonic generation (HHG) are focused now on circular polarization for the generation of circularly polarized attosecond pulses as new tools for controlling electron dynamics, such as charge transfer and migration and the generation of attosecond quantum electron currents for ultrafast magneto-optics. A fundamental electron dynamical process in HHG is laser induced electron recollision with the parent ion, well established theoretically and experimentally for linear polarization. We discuss molecular electron recollision dynamics in circular polarization by theoretical analysis and numerical simulation. The control of the polarization of HHG with circularly polarized ionizing pulses is examined and it is shown that bichromatic circularly polarized pulses enhance recollision dynamics, rendering HHG more efficient, especially in molecules because of their nonspherical symmetry. The polarization of the harmonics is found to be dependent on the compatibility of the rotational symmetry of the net electric field created by combinations of bichromatic circularly polarized pulses with the dynamical symmetry of molecules. We show how the field and molecule symmetry influences the electron recollision trajectories by a time-frequency analysis of harmonics. The results, in principle, offer new unique controllable tools in the study of attosecond molecular electron dynamics.

  3. Integration of Molecular Dynamics Based Predictions into the Optimization of De Novo Protein Designs: Limitations and Benefits.

    PubMed

    Carvalho, Henrique F; Barbosa, Arménio J M; Roque, Ana C A; Iranzo, Olga; Branco, Ricardo J F

    2017-01-01

    Recent advances in de novo protein design have gained considerable insight from the intrinsic dynamics of proteins, based on the integration of molecular dynamics simulations protocols on the state-of-the-art de novo protein design protocols used nowadays. With this protocol we illustrate how to set up and run a molecular dynamics simulation followed by a functional protein dynamics analysis. New users will be introduced to some useful open-source computational tools, including the GROMACS molecular dynamics simulation software package and ProDy for protein structural dynamics analysis.

  4. The development of an intelligent interface to a computational fluid dynamics flow-solver code

    NASA Technical Reports Server (NTRS)

    Williams, Anthony D.

    1988-01-01

    Researchers at NASA Lewis are currently developing an 'intelligent' interface to aid in the development and use of large, computational fluid dynamics flow-solver codes for studying the internal fluid behavior of aerospace propulsion systems. This paper discusses the requirements, design, and implementation of an intelligent interface to Proteus, a general purpose, 3-D, Navier-Stokes flow solver. The interface is called PROTAIS to denote its introduction of artificial intelligence (AI) concepts to the Proteus code.

  5. The development of an intelligent interface to a computational fluid dynamics flow-solver code

    NASA Technical Reports Server (NTRS)

    Williams, Anthony D.

    1988-01-01

    Researchers at NASA Lewis are currently developing an 'intelligent' interface to aid in the development and use of large, computational fluid dynamics flow-solver codes for studying the internal fluid behavior of aerospace propulsion systems. This paper discusses the requirements, design, and implementation of an intelligent interface to Proteus, a general purpose, three-dimensional, Navier-Stokes flow solver. The interface is called PROTAIS to denote its introduction of artificial intelligence (AI) concepts to the Proteus code.

  6. Prediction of glass transition temperature of freeze-dried formulations by molecular dynamics simulation.

    PubMed

    Yoshioka, Sumie; Aso, Yukio; Kojima, Shigeo

    2003-06-01

    To examine whether the glass transition temperature (Tg) of freeze-dried formulations containing polymer excipients can be accurately predicted by molecular dynamics simulation using software currently available on the market. Molecular dynamics simulations were carried out for isomaltodecaose, a fragment of dextran, and alpha-glucose, the repeated unit of dextran. in the presence or absence of water molecules. Estimated values of Tg were compared with experimental values obtained by differential scanning calorimetry (DSC). Isothermal-isobaric molecular dynamics simulations (NPTMD) and isothermal molecular dynamics simulations at a constant volume (NVTMD) were carried out using the software package DISCOVER (Material Studio) with the Polymer Consortium Force Field. Mean-squared displacement and radial distribution function were calculated. NVTMD using the values of density obtained by NPTMD provided the diffusivity of glucose-ring oxygen and water oxygen in amorphous alpha-glucose and isomaltodecaose, which exhibited a discontinuity in temperature dependence due to glass transition. Tg was estimated to be approximately 400K and 500K for pure amorphous a-glucose and isomaltodecaose, respectively, and in the presence of one water molecule per glucose unit, Tg was 340K and 360K, respectively. Estimated Tg values were higher than experimentally determined values because of the very fast cooling rates in the simulations. However, decreases in Tg on hydration and increases in Tg associated with larger fragment size could be demonstrated. The results indicate that molecular dynamics simulation is a useful method for investigating the effects of hydration and molecular weight on the Tg of lyophilized formulations containing polymer excipients. although the relationship between cooling rates and Tg must first be elucidated to predict Tg vales observed by DSC measurement. January 16.

  7. Molecular dynamics equation of state for nonpolar geochemical fluids

    NASA Astrophysics Data System (ADS)

    Duan, Zhenhao; Møller, Nancy; Wears, John H.

    1995-04-01

    Remarkable agreement between molecular dynamics simulations and experimental measurements has been obtained for methane for a large range of intensive variables, including those corresponding to liquid/vapor coexistence. Using a simple Lennard-Jones potential the simulations not only predict the PVT properties up to 2000°C and 20,000 bar with errors less than 1.5%, but also reproduce phase equilibria well below 0°C with accuracy close to experiment. This two-parameter molecular dynamics equation of state (SOS) is accurate for a much larger range of temperatures and pressures than our previously published EOS with a total fifteen parameters or that of Angus et al. (1978) with thirty-three parameters. By simple scaling, it is possible to predict PVT and phase equilibria of other nonpolar and weakly polar species.

  8. Molecular Dynamics of Dense Fluids: Simulation-Theory Symbiosis

    NASA Astrophysics Data System (ADS)

    Yip, Sidney

    35 years ago Berni J. Alder showed the Boltzmann-Enskog kinetic theory failed to adequately account for the viscosity of fluids near solid density as determined by molecular dynamics simulation. This work, along with other notable simulation findings, provided great stimulus to the statistical mechanical studies of transport phenomena, particularly in dealing with collective effects in the time correlation functions of liquids. An extended theoretical challenge that remains partially resolved at best is the shear viscosity of supercooled liquids. How can one give a unified explanation of the so-called fragile and strong characteristic temperature behavior, with implications for the dynamics of glass transition? In this tribute on the occasion of his 90th birthday symposium, we recount a recent study where simulation, combined with heuristic (transition-state) and first principles (linear response) theories, identifies the molecular mechanisms governing glassy-state relaxation. Such an interplay between simulation and theory is progress from the early days; instead of simulation challenging theory, now simulation and theory complement each other.

  9. Molecular Dynamics: New Frontier in Personalized Medicine.

    PubMed

    Sneha, P; Doss, C George Priya

    2016-01-01

    The field of drug discovery has witnessed infinite development over the last decade with the demand for discovery of novel efficient lead compounds. Although the development of novel compounds in this field has seen large failure, a breakthrough in this area might be the establishment of personalized medicine. The trend of personalized medicine has shown stupendous growth being a hot topic after the successful completion of Human Genome Project and 1000 genomes pilot project. Genomic variant such as SNPs play a vital role with respect to inter individual's disease susceptibility and drug response. Hence, identification of such genetic variants has to be performed before administration of a drug. This process requires high-end techniques to understand the complexity of the molecules which might bring an insight to understand the compounds at their molecular level. To sustenance this, field of bioinformatics plays a crucial role in revealing the molecular mechanism of the mutation and thereby designing a drug for an individual in fast and affordable manner. High-end computational methods, such as molecular dynamics (MD) simulation has proved to be a constitutive approach to detecting the minor changes associated with an SNP for better understanding of the structural and functional relationship. The parameters used in molecular dynamic simulation elucidate different properties of a macromolecule, such as protein stability and flexibility. MD along with docking analysis can reveal the synergetic effect of an SNP in protein-ligand interaction and provides a foundation for designing a particular drug molecule for an individual. This compelling application of computational power and the advent of other technologies have paved a promising way toward personalized medicine. In this in-depth review, we tried to highlight the different wings of MD toward personalized medicine. © 2016 Elsevier Inc. All rights reserved.

  10. Molecular dynamic simulation of Copper and Platinum nanoparticles Poiseuille flow in a nanochannels

    NASA Astrophysics Data System (ADS)

    Toghraie, Davood; Mokhtari, Majid; Afrand, Masoud

    2016-10-01

    In this paper, simulation of Poiseuille flow within nanochannel containing Copper and Platinum particles has been performed using molecular dynamic (MD). In this simulation LAMMPS code is used to simulate three-dimensional Poiseuille flow. The atomic interaction is governed by the modified Lennard-Jones potential. To study the wall effects on the surface tension and density profile, we placed two solid walls, one at the bottom boundary and the other at the top boundary. For solid-liquid interactions, the modified Lennard-Jones potential function was used. Velocity profiles and distribution of temperature and density have been obtained, and agglutination of nanoparticles has been discussed. It has also shown that with more particles, less time is required for the particles to fuse or agglutinate. Also, we can conclude that the agglutination time in nanochannel with Copper particles is faster that in Platinum nanoparticles. Finally, it is demonstrated that using nanoparticles raises thermal conduction in the channel.

  11. Molecular dynamics based enhanced sampling of collective variables with very large time steps.

    PubMed

    Chen, Pei-Yang; Tuckerman, Mark E

    2018-01-14

    Enhanced sampling techniques that target a set of collective variables and that use molecular dynamics as the driving engine have seen widespread application in the computational molecular sciences as a means to explore the free-energy landscapes of complex systems. The use of molecular dynamics as the fundamental driver of the sampling requires the introduction of a time step whose magnitude is limited by the fastest motions in a system. While standard multiple time-stepping methods allow larger time steps to be employed for the slower and computationally more expensive forces, the maximum achievable increase in time step is limited by resonance phenomena, which inextricably couple fast and slow motions. Recently, we introduced deterministic and stochastic resonance-free multiple time step algorithms for molecular dynamics that solve this resonance problem and allow ten- to twenty-fold gains in the large time step compared to standard multiple time step algorithms [P. Minary et al., Phys. Rev. Lett. 93, 150201 (2004); B. Leimkuhler et al., Mol. Phys. 111, 3579-3594 (2013)]. These methods are based on the imposition of isokinetic constraints that couple the physical system to Nosé-Hoover chains or Nosé-Hoover Langevin schemes. In this paper, we show how to adapt these methods for collective variable-based enhanced sampling techniques, specifically adiabatic free-energy dynamics/temperature-accelerated molecular dynamics, unified free-energy dynamics, and by extension, metadynamics, thus allowing simulations employing these methods to employ similarly very large time steps. The combination of resonance-free multiple time step integrators with free-energy-based enhanced sampling significantly improves the efficiency of conformational exploration.

  12. Molecular dynamics based enhanced sampling of collective variables with very large time steps

    NASA Astrophysics Data System (ADS)

    Chen, Pei-Yang; Tuckerman, Mark E.

    2018-01-01

    Enhanced sampling techniques that target a set of collective variables and that use molecular dynamics as the driving engine have seen widespread application in the computational molecular sciences as a means to explore the free-energy landscapes of complex systems. The use of molecular dynamics as the fundamental driver of the sampling requires the introduction of a time step whose magnitude is limited by the fastest motions in a system. While standard multiple time-stepping methods allow larger time steps to be employed for the slower and computationally more expensive forces, the maximum achievable increase in time step is limited by resonance phenomena, which inextricably couple fast and slow motions. Recently, we introduced deterministic and stochastic resonance-free multiple time step algorithms for molecular dynamics that solve this resonance problem and allow ten- to twenty-fold gains in the large time step compared to standard multiple time step algorithms [P. Minary et al., Phys. Rev. Lett. 93, 150201 (2004); B. Leimkuhler et al., Mol. Phys. 111, 3579-3594 (2013)]. These methods are based on the imposition of isokinetic constraints that couple the physical system to Nosé-Hoover chains or Nosé-Hoover Langevin schemes. In this paper, we show how to adapt these methods for collective variable-based enhanced sampling techniques, specifically adiabatic free-energy dynamics/temperature-accelerated molecular dynamics, unified free-energy dynamics, and by extension, metadynamics, thus allowing simulations employing these methods to employ similarly very large time steps. The combination of resonance-free multiple time step integrators with free-energy-based enhanced sampling significantly improves the efficiency of conformational exploration.

  13. Unraveling HIV protease flaps dynamics by Constant pH Molecular Dynamics simulations.

    PubMed

    Soares, Rosemberg O; Torres, Pedro H M; da Silva, Manuela L; Pascutti, Pedro G

    2016-08-01

    The active site of HIV protease (HIV-PR) is covered by two flaps. These flaps are known to be essential for the catalytic activity of the HIV-PR, but their exact conformations at the different stages of the enzymatic pathway remain subject to debate. Understanding the correct functional dynamics of the flaps might aid the development of new HIV-PR inhibitors. It is known that, the HIV-PR catalytic efficiency is pH-dependent, likely due to the influence of processes such as charge transfer and protonation/deprotonation of ionizable residues. Several Molecular Dynamics (MD) simulations have reported information about the HIV-PR flaps. However, in MD simulations the protonation of a residue is fixed and thus it is not possible to study the correlation between conformation and protonation state. To address this shortcoming, this work attempts to capture, through Constant pH Molecular Dynamics (CpHMD), the conformations of the apo, substrate-bound and inhibitor-bound HIV-PR, which differ drastically in their flap arrangements. The results show that the HIV-PR flaps conformations are defined by the protonation of the catalytic residues Asp25/Asp25' and that these residues are sensitive to pH changes. This study suggests that the catalytic aspartates can modulate the opening of the active site and substrate binding. Copyright © 2016 Elsevier Inc. All rights reserved.

  14. Fully Anisotropic Rotational Diffusion Tensor from Molecular Dynamics Simulations.

    PubMed

    Linke, Max; Köfinger, Jürgen; Hummer, Gerhard

    2018-05-31

    We present a method to calculate the fully anisotropic rotational diffusion tensor from molecular dynamics simulations. Our approach is based on fitting the time-dependent covariance matrix of the quaternions that describe the rigid-body rotational dynamics. Explicit analytical expressions have been derived for the covariances by Favro, which are valid irrespective of the degree of anisotropy. We use these expressions to determine an optimal rotational diffusion tensor from trajectory data. The molecular structures are aligned against a reference by optimal rigid-body superposition. The quaternion covariances can then be obtained directly from the rotation matrices used in the alignment. The rotational diffusion tensor is determined by a fit to the time-dependent quaternion covariances, or directly by Laplace transformation and matrix diagonalization. To quantify uncertainties in the fit, we derive analytical expressions and compare them with the results of Brownian dynamics simulations of anisotropic rotational diffusion. We apply the method to microsecond long trajectories of the Dickerson-Drew B-DNA dodecamer and of horse heart myoglobin. The anisotropic rotational diffusion tensors calculated from simulations agree well with predictions from hydrodynamics.

  15. User Manual and Source Code for a LAMMPS Implementation of Constant Energy Dissipative Particle Dynamics (DPD-E)

    DTIC Science & Technology

    2014-06-01

    User Manual and Source Code for a LAMMPS Implementation of Constant Energy Dissipative Particle Dynamics (DPD-E) by James P. Larentzos...Laboratory Aberdeen Proving Ground, MD 21005-5069 ARL-SR-290 June 2014 User Manual and Source Code for a LAMMPS Implementation of Constant...3. DATES COVERED (From - To) September 2013–February 2014 4. TITLE AND SUBTITLE User Manual and Source Code for a LAMMPS Implementation of

  16. Accelerated molecular dynamics simulations of protein folding.

    PubMed

    Miao, Yinglong; Feixas, Ferran; Eun, Changsun; McCammon, J Andrew

    2015-07-30

    Folding of four fast-folding proteins, including chignolin, Trp-cage, villin headpiece and WW domain, was simulated via accelerated molecular dynamics (aMD). In comparison with hundred-of-microsecond timescale conventional molecular dynamics (cMD) simulations performed on the Anton supercomputer, aMD captured complete folding of the four proteins in significantly shorter simulation time. The folded protein conformations were found within 0.2-2.1 Å of the native NMR or X-ray crystal structures. Free energy profiles calculated through improved reweighting of the aMD simulations using cumulant expansion to the second-order are in good agreement with those obtained from cMD simulations. This allows us to identify distinct conformational states (e.g., unfolded and intermediate) other than the native structure and the protein folding energy barriers. Detailed analysis of protein secondary structures and local key residue interactions provided important insights into the protein folding pathways. Furthermore, the selections of force fields and aMD simulation parameters are discussed in detail. Our work shows usefulness and accuracy of aMD in studying protein folding, providing basic references in using aMD in future protein-folding studies. © 2015 Wiley Periodicals, Inc.

  17. Dynamics of molecular hydrogen in crystalline silicon

    NASA Astrophysics Data System (ADS)

    Fowler, W. Beall; Walters, Peter; Stavola, Michael

    2002-03-01

    We have studied the dynamics of interstitial molecular hydrogen in crystalline silicon by using a potential energy function for the molecule that consists of the superposition of potentials for two separated atomic hydrogens as generated from the quantum-mechanical calculations of Porter et al.(1) The rotational properties were calculated using the approach of Martin and Fowler (2) and the vibrational properties of the molecules as a whole were obtained. Results for molecular hydrogen, deuterium, and HD indicate nearly free rotational motion, consistent with shallow rotational potentials. Confinement of the molecules leads to center-of-mass vibrations of a few hundred wave numbers and dynamical "off-centeredness" that breaks tetrahedral symmetry for the high-frequency stretch vibrations. These and other results have helped to interpret recent experiments on these systems (3). This work was supported by the NSF REU program at Lehigh University. 1. A. R. Porter et al., Phys. Rev. B 60, 13 534 (1999). 2. K. R. Martin and W. B. Fowler, Phys. Rev. B 52, 16 516 (1995). 3. E Chen, M. Stavola, W. B. Fowler, and P. Walters (to be published).

  18. Nonadiabatic Ab Initio Molecular Dynamics with the Floating Occupation Molecular Orbital-Complete Active Space Configuration Interaction Method [Non-Adiabatic Ab Initio Molecular Dynamics with Floating Occupation Molecular Orbitals CASCI Method

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Hollas, Daniel; Sistik, Lukas; Hohenstein, Edward G.

    Here, we show that the floating occupation molecular orbital complete active space configuration interaction (FOMO-CASCI) method is a promising alternative to the widely used complete active space self-consistent field (CASSCF) method in direct nonadiabatic dynamics simulations. We have simulated photodynamics of three archetypal molecules in photodynamics: ethylene, methaniminium cation, and malonaldehyde. We compared the time evolution of electronic populations and reaction mechanisms as revealed by the FOMO-CASCI and CASSCF approaches. Generally, the two approaches provide similar results. Some dynamical differences are observed, but these can be traced back to energetically minor differences in the potential energy surfaces. We suggest thatmore » the FOMO-CASCI method represents, due to its efficiency and stability, a promising approach for direct ab initio dynamics in the excited state.« less

  19. Protein dynamics in organic media at varying water activity studied by molecular dynamics simulation.

    PubMed

    Wedberg, Rasmus; Abildskov, Jens; Peters, Günther H

    2012-03-01

    In nonaqueous enzymology, control of enzyme hydration is commonly approached by fixing the thermodynamic water activity of the medium. In this work, we present a strategy for evaluating the water activity in molecular dynamics simulations of proteins in water/organic solvent mixtures. The method relies on determining the water content of the bulk phase and uses a combination of Kirkwood-Buff theory and free energy calculations to determine corresponding activity coefficients. We apply the method in a molecular dynamics study of Candida antarctica lipase B in pure water and the organic solvents methanol, tert-butyl alcohol, methyl tert-butyl ether, and hexane, each mixture at five different water activities. It is shown that similar water activity yields similar enzyme hydration in the different solvents. However, both solvent and water activity are shown to have profound effects on enzyme structure and flexibility.

  20. Insights from molecular dynamics simulations for computational protein design.

    PubMed

    Childers, Matthew Carter; Daggett, Valerie

    2017-02-01

    A grand challenge in the field of structural biology is to design and engineer proteins that exhibit targeted functions. Although much success on this front has been achieved, design success rates remain low, an ever-present reminder of our limited understanding of the relationship between amino acid sequences and the structures they adopt. In addition to experimental techniques and rational design strategies, computational methods have been employed to aid in the design and engineering of proteins. Molecular dynamics (MD) is one such method that simulates the motions of proteins according to classical dynamics. Here, we review how insights into protein dynamics derived from MD simulations have influenced the design of proteins. One of the greatest strengths of MD is its capacity to reveal information beyond what is available in the static structures deposited in the Protein Data Bank. In this regard simulations can be used to directly guide protein design by providing atomistic details of the dynamic molecular interactions contributing to protein stability and function. MD simulations can also be used as a virtual screening tool to rank, select, identify, and assess potential designs. MD is uniquely poised to inform protein design efforts where the application requires realistic models of protein dynamics and atomic level descriptions of the relationship between dynamics and function. Here, we review cases where MD simulations was used to modulate protein stability and protein function by providing information regarding the conformation(s), conformational transitions, interactions, and dynamics that govern stability and function. In addition, we discuss cases where conformations from protein folding/unfolding simulations have been exploited for protein design, yielding novel outcomes that could not be obtained from static structures.

  1. Insights from molecular dynamics simulations for computational protein design

    PubMed Central

    Childers, Matthew Carter; Daggett, Valerie

    2017-01-01

    A grand challenge in the field of structural biology is to design and engineer proteins that exhibit targeted functions. Although much success on this front has been achieved, design success rates remain low, an ever-present reminder of our limited understanding of the relationship between amino acid sequences and the structures they adopt. In addition to experimental techniques and rational design strategies, computational methods have been employed to aid in the design and engineering of proteins. Molecular dynamics (MD) is one such method that simulates the motions of proteins according to classical dynamics. Here, we review how insights into protein dynamics derived from MD simulations have influenced the design of proteins. One of the greatest strengths of MD is its capacity to reveal information beyond what is available in the static structures deposited in the Protein Data Bank. In this regard simulations can be used to directly guide protein design by providing atomistic details of the dynamic molecular interactions contributing to protein stability and function. MD simulations can also be used as a virtual screening tool to rank, select, identify, and assess potential designs. MD is uniquely poised to inform protein design efforts where the application requires realistic models of protein dynamics and atomic level descriptions of the relationship between dynamics and function. Here, we review cases where MD simulations was used to modulate protein stability and protein function by providing information regarding the conformation(s), conformational transitions, interactions, and dynamics that govern stability and function. In addition, we discuss cases where conformations from protein folding/unfolding simulations have been exploited for protein design, yielding novel outcomes that could not be obtained from static structures. PMID:28239489

  2. Dynamics of Oxidation of Aluminum Nanoclusters using Variable Charge Molecular-Dynamics Simulations on Parallel Computers

    NASA Astrophysics Data System (ADS)

    Campbell, Timothy; Kalia, Rajiv K.; Nakano, Aiichiro; Vashishta, Priya; Ogata, Shuji; Rodgers, Stephen

    1999-06-01

    Oxidation of aluminum nanoclusters is investigated with a parallel molecular-dynamics approach based on dynamic charge transfer among atoms. Structural and dynamic correlations reveal that significant charge transfer gives rise to large negative pressure in the oxide which dominates the positive pressure due to steric forces. As a result, aluminum moves outward and oxygen moves towards the interior of the cluster with the aluminum diffusivity 60% higher than that of oxygen. A stable 40 Å thick amorphous oxide is formed; this is in excellent agreement with experiments.

  3. Solution of the neutronics code dynamic benchmark by finite element method

    NASA Astrophysics Data System (ADS)

    Avvakumov, A. V.; Vabishchevich, P. N.; Vasilev, A. O.; Strizhov, V. F.

    2016-10-01

    The objective is to analyze the dynamic benchmark developed by Atomic Energy Research for the verification of best-estimate neutronics codes. The benchmark scenario includes asymmetrical ejection of a control rod in a water-type hexagonal reactor at hot zero power. A simple Doppler feedback mechanism assuming adiabatic fuel temperature heating is proposed. The finite element method on triangular calculation grids is used to solve the three-dimensional neutron kinetics problem. The software has been developed using the engineering and scientific calculation library FEniCS. The matrix spectral problem is solved using the scalable and flexible toolkit SLEPc. The solution accuracy of the dynamic benchmark is analyzed by condensing calculation grid and varying degree of finite elements.

  4. Coherent Amplification of Ultrafast Molecular Dynamics in an Optical Oscillator

    NASA Astrophysics Data System (ADS)

    Aharonovich, Igal; Pe'er, Avi

    2016-02-01

    Optical oscillators present a powerful optimization mechanism. The inherent competition for the gain resources between possible modes of oscillation entails the prevalence of the most efficient single mode. We harness this "ultrafast" coherent feedback to optimize an optical field in time, and show that, when an optical oscillator based on a molecular gain medium is synchronously pumped by ultrashort pulses, a temporally coherent multimode field can develop that optimally dumps a general, dynamically evolving vibrational wave packet, into a single vibrational target state. Measuring the emitted field opens a new window to visualization and control of fast molecular dynamics. The realization of such a coherent oscillator with hot alkali dimers appears within experimental reach.

  5. Molecular dynamics simulation of water at mineral surfaces: Structure, dynamics, energetics and hydrogen bonding

    NASA Astrophysics Data System (ADS)

    Kalinichev, A. G.; Wang, J.; Kirkpatrick, R.

    2006-05-01

    Fundamental molecular-level understanding of the properties of aqueous mineral interfaces is of great importance for many geochemical and environmental systems. Interaction between water and mineral surfaces substantially affects the properties of both phases, including the reactivity and functionality of the substrate surface, and the structure, dynamics, and energetics of the near surface aqueous phase. Experimental studies of interfacial water structure and dynamics using surface-sensitive techniques such as sum-frequency vibrational spectroscopy or X-ray and neutron reflectivity are not always possible for many practically important substrates, and their results often require interpretation concerning the atomistic mechanisms responsible for the observed behavior. Molecular computer simulations can provide new insight into the underlying molecular- level relationships between the inorganic substrate structure and composition and the structure, ordering, and dynamics of interfacial water. We have performed a series of molecular dynamics (MD) computer simulations of aqueous interfaces with several silicates (quartz, muscovite, and talc) and hydroxides (brucite, portlandite, gibbsite, Ca/Al and Mg/Al double hydroxides) to quantify the effects of the substrate mineral structure and composition on the structural, transport, and thermodynamic properties of water on these mineral surfaces. Due to the prevalent effects of the development of well-interconnected H-bonding networks across the mineral- water interfaces, all the hydroxide surfaces (including a fully hydroxylated quartz surface) show very similar H2O density profiles perpendicular to the interface. However, the predominant orientations of the interfacial H2O molecules and their detailed 2-dimensional near-surface structure and dynamics parallel to the interface are quite different reflecting the differences in the substrate structural charge distribution and the density and orientations of the surface OH

  6. Molecular dynamics modelling of solidification in metals

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Boercker, D.B.; Belak, J.; Glosli, J.

    1997-12-31

    Molecular dynamics modeling is used to study the solidification of metals at high pressure and temperature. Constant pressure MD is applied to a simulation cell initially filled with both solid and molten metal. The solid/liquid interface is tracked as a function of time, and the data are used to estimate growth rates of crystallites at high pressure and temperature in Ta and Mg.

  7. Anisotropic polarization π -molecular skeleton coupled dynamics in proton-displacive organic ferroelectrics

    NASA Astrophysics Data System (ADS)

    Fujioka, J.; Horiuchi, S.; Kida, N.; Shimano, R.; Tokura, Y.

    2009-09-01

    We have investigated the polarization π -molecular skeleton coupled dynamics for the proton-displacive organic ferroelectrics, cocrystal of phenazine with the 2,5-dihalo-3,6-dihydroxy-p-benzoquinones by measurements of the terahertz/infrared spectroscopy. In the course of the ferroelectric-to-paraelectric transition, the ferroelectric soft phonon mode originating from the intermolecular dynamical displacement is observed in the imaginary part of dielectric spectra γ2 , when the electric field of the light (E) is parallel to the spontaneous polarization (P) . The soft phonon mode is isolated from the intramolecular vibrational mode and hence the intramolecular skeleton dynamics is almost decoupled from the polarization fluctuation. In the spectra for E parallel to the hydrogen-bonded supramolecular chain, by contrast, the vibrational mode mainly originating from the oxygen atom motion within the π -molecular plane is anomalously blurred and amalgamated into the polarization relaxation mode concomitantly with the dynamical proton disorder. This indicates that the dynamical disorder of the intramolecular skeleton structure, specifically that of oxygen atom, is strongly enhanced by the proton fluctuation and is significantly coupled to the polarization fluctuation along the hydrogen-bonded supramolecular chain. The results are discussed in terms of the proton-mediated anisotropic polarization π -molecular skeleton interaction, which characterizes these emerging proton-displacive ferroelectrics.

  8. Low-noise delays from dynamic Brillouin gratings based on perfect Golomb coding of pump waves.

    PubMed

    Antman, Yair; Levanon, Nadav; Zadok, Avi

    2012-12-15

    A method for long variable all-optical delay is proposed and simulated, based on reflections from localized and stationary dynamic Brillouin gratings (DBGs). Inspired by radar methods, the DBGs are inscribed by two pumps that are comodulated by perfect Golomb codes, which reduce the off-peak reflectivity. Compared with random bit sequence coding, Golomb codes improve the optical signal-to-noise ratio (OSNR) of delayed waveforms by an order of magnitude. Simulations suggest a delay of 5  Gb/s data by 9 ns, or 45 bit durations, with an OSNR of 13 dB.

  9. Nanoscopic length scale dependence of hydrogen bonded molecular associates’ dynamics in methanol

    PubMed Central

    Bertrand, C. E.; Self, J. L.; Copley, J. R. D.; Faraone, A.

    2017-01-01

    In a recent paper [C. E. Bertrand et al., J. Chem. Phys. 145, 014502 (2016)], we have shown that the collective dynamics of methanol shows a fast relaxation process related to the standard density-fluctuation heat mode and a slow non-Fickian mode originating from the hydrogen bonded molecular associates. Here we report on the length scale dependence of this slow relaxation process. Using quasielastic neutron scattering and molecular dynamics simulations, we show that the dynamics of the slow process is affected by the structuring of the associates, which is accessible through polarized neutron diffraction experiments. Using a series of partially deuterated samples, the dynamics of the associates is investigated and is found to have a similar time scale to the lifetime of hydrogen bonding in the system. Both the structural relaxation and the dynamics of the associates are thermally activated by the breaking of hydrogen bonding. PMID:28527447

  10. Charge-dependent conformations and dynamics of pamam dendrimers revealed by neutron scattering and molecular dynamics

    NASA Astrophysics Data System (ADS)

    Wu, Bin

    Neutron scattering and fully atomistic molecular dynamics (MD) are employed to investigate the structural and dynamical properties of polyamidoamine (PAMAM) dendrimers with ethylenediamine (EDA) core under various charge conditions. Regarding to the conformational characteristics, we focus on scrutinizing density profile evolution of PAMAM dendrimers as the molecular charge of dendrimer increases from neutral state to highly charged condition. It should be noted that within the context of small angle neutron scattering (SANS), the dendrimers are composed of hydrocarbon component (dry part) and the penetrating water molecules. Though there have been SANS experiments that studied the charge-dependent structural change of PAMAM dendrimers, their results were limited to the collective behavior of the aforementioned two parts. This study is devoted to deepen the understanding towards the structural responsiveness of intra-molecular polymeric and hydration parts separately through advanced contrast variation SANS data analysis scheme available recently and unravel the governing principles through coupling with MD simulations. Two kinds of acids, namely hydrochloric and sulfuric acids, are utilized to tune the pH condition and hence the molecular charge. As far as the dynamical properties, we target at understanding the underlying mechanism that leads to segmental dynamic enhancement observed from quasielstic neutron scattering (QENS) experiment previously. PAMAM dendrimers have a wealth of potential applications, such as drug delivery agency, energy harvesting medium, and light emitting diodes. More importantly, it is regarded as an ideal system to test many theoretical predictions since dendrimers conjugate both colloid-like globular shape and polymer-like flexible chains. This Ph.D. research addresses two main challenges in studying PAMAM dendrimers. Even though neutron scattering is an ideal tool to study this PAMAM dendrimer solution due to its matching temporal and

  11. Multilevel summation with B-spline interpolation for pairwise interactions in molecular dynamics simulations.

    PubMed

    Hardy, David J; Wolff, Matthew A; Xia, Jianlin; Schulten, Klaus; Skeel, Robert D

    2016-03-21

    The multilevel summation method for calculating electrostatic interactions in molecular dynamics simulations constructs an approximation to a pairwise interaction kernel and its gradient, which can be evaluated at a cost that scales linearly with the number of atoms. The method smoothly splits the kernel into a sum of partial kernels of increasing range and decreasing variability with the longer-range parts interpolated from grids of increasing coarseness. Multilevel summation is especially appropriate in the context of dynamics and minimization, because it can produce continuous gradients. This article explores the use of B-splines to increase the accuracy of the multilevel summation method (for nonperiodic boundaries) without incurring additional computation other than a preprocessing step (whose cost also scales linearly). To obtain accurate results efficiently involves technical difficulties, which are overcome by a novel preprocessing algorithm. Numerical experiments demonstrate that the resulting method offers substantial improvements in accuracy and that its performance is competitive with an implementation of the fast multipole method in general and markedly better for Hamiltonian formulations of molecular dynamics. The improvement is great enough to establish multilevel summation as a serious contender for calculating pairwise interactions in molecular dynamics simulations. In particular, the method appears to be uniquely capable for molecular dynamics in two situations, nonperiodic boundary conditions and massively parallel computation, where the fast Fourier transform employed in the particle-mesh Ewald method falls short.

  12. Multilevel summation with B-spline interpolation for pairwise interactions in molecular dynamics simulations

    NASA Astrophysics Data System (ADS)

    Hardy, David J.; Wolff, Matthew A.; Xia, Jianlin; Schulten, Klaus; Skeel, Robert D.

    2016-03-01

    The multilevel summation method for calculating electrostatic interactions in molecular dynamics simulations constructs an approximation to a pairwise interaction kernel and its gradient, which can be evaluated at a cost that scales linearly with the number of atoms. The method smoothly splits the kernel into a sum of partial kernels of increasing range and decreasing variability with the longer-range parts interpolated from grids of increasing coarseness. Multilevel summation is especially appropriate in the context of dynamics and minimization, because it can produce continuous gradients. This article explores the use of B-splines to increase the accuracy of the multilevel summation method (for nonperiodic boundaries) without incurring additional computation other than a preprocessing step (whose cost also scales linearly). To obtain accurate results efficiently involves technical difficulties, which are overcome by a novel preprocessing algorithm. Numerical experiments demonstrate that the resulting method offers substantial improvements in accuracy and that its performance is competitive with an implementation of the fast multipole method in general and markedly better for Hamiltonian formulations of molecular dynamics. The improvement is great enough to establish multilevel summation as a serious contender for calculating pairwise interactions in molecular dynamics simulations. In particular, the method appears to be uniquely capable for molecular dynamics in two situations, nonperiodic boundary conditions and massively parallel computation, where the fast Fourier transform employed in the particle-mesh Ewald method falls short.

  13. Analyzing the Molecular Kinetics of Water Spreading on Hydrophobic Surfaces via Molecular Dynamics Simulation.

    PubMed

    Zhao, Lei; Cheng, Jiangtao

    2017-09-07

    In this paper, we report molecular kinetic analyses of water spreading on hydrophobic surfaces via molecular dynamics simulation. The hydrophobic surfaces are composed of amorphous polytetrafluoroethylene (PTFE) with a static contact angle of ~112.4° for water. On the basis of the molecular kinetic theory (MKT), the influences of both viscous damping and solid-liquid retarding were analyzed in evaluating contact line friction, which characterizes the frictional force on the contact line. The unit displacement length on PTFE was estimated to be ~0.621 nm and is ~4 times as long as the bond length of C-C backbone. The static friction coefficient was found to be ~[Formula: see text] Pa·s, which is on the same order of magnitude as the dynamic viscosity of water, and increases with the droplet size. A nondimensional number defined by the ratio of the standard deviation of wetting velocity to the characteristic wetting velocity was put forward to signify the strength of the inherent contact line fluctuation and unveil the mechanism of enhanced energy dissipation in nanoscale, whereas such effect would become insignificant in macroscale. Moreover, regarding a liquid droplet on hydrophobic or superhydrophobic surfaces, an approximate solution to the base radius development was derived by an asymptotic expansion approach.

  14. Molecular Dynamics Simulations of Folding and Insertion of the Ebola Virus Fusion Peptide into a Membrane Bilayer

    DTIC Science & Technology

    2008-07-01

    Molecular Dynamics Simulations of Folding and Insertion of the Ebola Virus Fusion Peptide into a Membrane Bilayer Mark A. Olson1, In...presents replica-exchange molecular dynamics simulations of the folding and insertion of a 16- residue Ebola virus fusion peptide into a membrane...separate calculated structures into conformational basins. 2.1 Simulation models Molecular dynamics simulations were performed using the all-atom

  15. Ice formation on kaolinite: Insights from molecular dynamics simulations

    NASA Astrophysics Data System (ADS)

    Sosso, Gabriele C.; Tribello, Gareth A.; Zen, Andrea; Pedevilla, Philipp; Michaelides, Angelos

    2016-12-01

    The formation of ice affects many aspects of our everyday life as well as important technologies such as cryotherapy and cryopreservation. Foreign substances almost always aid water freezing through heterogeneous ice nucleation, but the molecular details of this process remain largely unknown. In fact, insight into the microscopic mechanism of ice formation on different substrates is difficult to obtain even if state-of-the-art experimental techniques are used. At the same time, atomistic simulations of heterogeneous ice nucleation frequently face extraordinary challenges due to the complexity of the water-substrate interaction and the long time scales that characterize nucleation events. Here, we have investigated several aspects of molecular dynamics simulations of heterogeneous ice nucleation considering as a prototypical ice nucleating material the clay mineral kaolinite, which is of relevance in atmospheric science. We show via seeded molecular dynamics simulations that ice nucleation on the hydroxylated (001) face of kaolinite proceeds exclusively via the formation of the hexagonal ice polytype. The critical nucleus size is two times smaller than that obtained for homogeneous nucleation at the same supercooling. Previous findings suggested that the flexibility of the kaolinite surface can alter the time scale for ice nucleation within molecular dynamics simulations. However, we here demonstrate that equally flexible (or non flexible) kaolinite surfaces can lead to very different outcomes in terms of ice formation, according to whether or not the surface relaxation of the clay is taken into account. We show that very small structural changes upon relaxation dramatically alter the ability of kaolinite to provide a template for the formation of a hexagonal overlayer of water molecules at the water-kaolinite interface, and that this relaxation therefore determines the nucleation ability of this mineral.

  16. Multiscale simulations of anisotropic particles combining molecular dynamics and Green's function reaction dynamics

    NASA Astrophysics Data System (ADS)

    Vijaykumar, Adithya; Ouldridge, Thomas E.; ten Wolde, Pieter Rein; Bolhuis, Peter G.

    2017-03-01

    The modeling of complex reaction-diffusion processes in, for instance, cellular biochemical networks or self-assembling soft matter can be tremendously sped up by employing a multiscale algorithm which combines the mesoscopic Green's Function Reaction Dynamics (GFRD) method with explicit stochastic Brownian, Langevin, or deterministic molecular dynamics to treat reactants at the microscopic scale [A. Vijaykumar, P. G. Bolhuis, and P. R. ten Wolde, J. Chem. Phys. 143, 214102 (2015)]. Here we extend this multiscale MD-GFRD approach to include the orientational dynamics that is crucial to describe the anisotropic interactions often prevalent in biomolecular systems. We present the novel algorithm focusing on Brownian dynamics only, although the methodology is generic. We illustrate the novel algorithm using a simple patchy particle model. After validation of the algorithm, we discuss its performance. The rotational Brownian dynamics MD-GFRD multiscale method will open up the possibility for large scale simulations of protein signalling networks.

  17. Industrial Computer Codes

    NASA Technical Reports Server (NTRS)

    Shapiro, Wilbur

    1996-01-01

    This is an overview of new and updated industrial codes for seal design and testing. GCYLT (gas cylindrical seals -- turbulent), SPIRALI (spiral-groove seals -- incompressible), KTK (knife to knife) Labyrinth Seal Code, and DYSEAL (dynamic seal analysis) are covered. CGYLT uses G-factors for Poiseuille and Couette turbulence coefficients. SPIRALI is updated to include turbulence and inertia, but maintains the narrow groove theory. KTK labyrinth seal code handles straight or stepped seals. And DYSEAL provides dynamics for the seal geometry.

  18. Molecular Dynamics, Monte Carlo Simulations, and Langevin Dynamics: A Computational Review

    PubMed Central

    Paquet, Eric; Viktor, Herna L.

    2015-01-01

    Macromolecular structures, such as neuraminidases, hemagglutinins, and monoclonal antibodies, are not rigid entities. Rather, they are characterised by their flexibility, which is the result of the interaction and collective motion of their constituent atoms. This conformational diversity has a significant impact on their physicochemical and biological properties. Among these are their structural stability, the transport of ions through the M2 channel, drug resistance, macromolecular docking, binding energy, and rational epitope design. To assess these properties and to calculate the associated thermodynamical observables, the conformational space must be efficiently sampled and the dynamic of the constituent atoms must be simulated. This paper presents algorithms and techniques that address the abovementioned issues. To this end, a computational review of molecular dynamics, Monte Carlo simulations, Langevin dynamics, and free energy calculation is presented. The exposition is made from first principles to promote a better understanding of the potentialities, limitations, applications, and interrelations of these computational methods. PMID:25785262

  19. A GPU-accelerated immersive audio-visual framework for interaction with molecular dynamics using consumer depth sensors.

    PubMed

    Glowacki, David R; O'Connor, Michael; Calabró, Gaetano; Price, James; Tew, Philip; Mitchell, Thomas; Hyde, Joseph; Tew, David P; Coughtrie, David J; McIntosh-Smith, Simon

    2014-01-01

    With advances in computational power, the rapidly growing role of computational/simulation methodologies in the physical sciences, and the development of new human-computer interaction technologies, the field of interactive molecular dynamics seems destined to expand. In this paper, we describe and benchmark the software algorithms and hardware setup for carrying out interactive molecular dynamics utilizing an array of consumer depth sensors. The system works by interpreting the human form as an energy landscape, and superimposing this landscape on a molecular dynamics simulation to chaperone the motion of the simulated atoms, affecting both graphics and sonified simulation data. GPU acceleration has been key to achieving our target of 60 frames per second (FPS), giving an extremely fluid interactive experience. GPU acceleration has also allowed us to scale the system for use in immersive 360° spaces with an array of up to ten depth sensors, allowing several users to simultaneously chaperone the dynamics. The flexibility of our platform for carrying out molecular dynamics simulations has been considerably enhanced by wrappers that facilitate fast communication with a portable selection of GPU-accelerated molecular force evaluation routines. In this paper, we describe a 360° atmospheric molecular dynamics simulation we have run in a chemistry/physics education context. We also describe initial tests in which users have been able to chaperone the dynamics of 10-alanine peptide embedded in an explicit water solvent. Using this system, both expert and novice users have been able to accelerate peptide rare event dynamics by 3-4 orders of magnitude.

  20. Development of a dynamic coupled hydro-geomechanical code and its application to induced seismicity

    NASA Astrophysics Data System (ADS)

    Miah, Md Mamun

    This research describes the importance of a hydro-geomechanical coupling in the geologic sub-surface environment from fluid injection at geothermal plants, large-scale geological CO2 sequestration for climate mitigation, enhanced oil recovery, and hydraulic fracturing during wells construction in the oil and gas industries. A sequential computational code is developed to capture the multiphysics interaction behavior by linking a flow simulation code TOUGH2 and a geomechanics modeling code PyLith. Numerical formulation of each code is discussed to demonstrate their modeling capabilities. The computational framework involves sequential coupling, and solution of two sub-problems- fluid flow through fractured and porous media and reservoir geomechanics. For each time step of flow calculation, pressure field is passed to the geomechanics code to compute effective stress field and fault slips. A simplified permeability model is implemented in the code that accounts for the permeability of porous and saturated rocks subject to confining stresses. The accuracy of the TOUGH-PyLith coupled simulator is tested by simulating Terzaghi's 1D consolidation problem. The modeling capability of coupled poroelasticity is validated by benchmarking it against Mandel's problem. The code is used to simulate both quasi-static and dynamic earthquake nucleation and slip distribution on a fault from the combined effect of far field tectonic loading and fluid injection by using an appropriate fault constitutive friction model. Results from the quasi-static induced earthquake simulations show a delayed response in earthquake nucleation. This is attributed to the increased total stress in the domain and not accounting for pressure on the fault. However, this issue is resolved in the final chapter in simulating a single event earthquake dynamic rupture. Simulation results show that fluid pressure has a positive effect on slip nucleation and subsequent crack propagation. This is confirmed by

  1. Comparative Investigation of Normal Modes and Molecular Dynamics of Hepatitis C NS5B Protein

    NASA Astrophysics Data System (ADS)

    Asafi, M. S.; Yildirim, A.; Tekpinar, M.

    2016-04-01

    Understanding dynamics of proteins has many practical implications in terms of finding a cure for many protein related diseases. Normal mode analysis and molecular dynamics methods are widely used physics-based computational methods for investigating dynamics of proteins. In this work, we studied dynamics of Hepatitis C NS5B protein with molecular dynamics and normal mode analysis. Principal components obtained from a 100 nanoseconds molecular dynamics simulation show good overlaps with normal modes calculated with a coarse-grained elastic network model. Coarse-grained normal mode analysis takes at least an order of magnitude shorter time. Encouraged by this good overlaps and short computation times, we analyzed further low frequency normal modes of Hepatitis C NS5B. Motion directions and average spatial fluctuations have been analyzed in detail. Finally, biological implications of these motions in drug design efforts against Hepatitis C infections have been elaborated.

  2. Script, code, information: how to differentiate analogies in the "prehistory" of molecular biology.

    PubMed

    Kogge, Werner

    2012-01-01

    The remarkable fact that twentieth-century molecular biology developed its conceptual system on the basis of sign-like terms has been the object of numerous studies and debates. Throughout these, the assumption is made that this vocabulary's emergence should be seen in the historical context of mathematical communication theory and cybernetics. This paper, in contrast, sets out the need for a more differentiated view: whereas the success of the terms "code" and "information" would probably be unthinkable outside that historical context, general semiotic and especially scriptural concepts arose far earlier in the "prehistory" of molecular biology, and in close association with biological research and phenomena. This distinction, established through a reconstruction of conceptual developments between 1870 and 1950, makes it possible to separate off a critique of the reductive implications of particular information-based concepts from the use of semiotic and scriptural concepts, which is fundamental to molecular biology. Gene-centrism and determinism are not implications of semiotic and scriptural analogies, but arose only when the vocabulary of information was superimposed upon them.

  3. Insights into the effects of mutations on Cren7-DNA binding using molecular dynamics simulations and free energy calculations.

    PubMed

    Chen, Lin; Zheng, Qing-Chuan; Zhang, Hong-Xing

    2015-02-28

    A novel, highly conserved chromatin protein, Cren7 is involved in regulating essential cellular processes such as transcription, replication and repair. Although mutations in the DNA-binding loop of Cren7 destabilize the structure and reduce DNA-binding activity, the details are not very clear. Focusing on the specific Cren7-dsDNA complex (PDB code ), we applied molecular dynamics (MD) simulations and the molecular mechanics Poisson-Boltzmann surface area (MM-PBSA) free energy calculations to explore the structural and dynamic effects of W26A, L28A, and K53A mutations in comparison to the wild-type protein. The energetic analysis indicated that the intermolecular van der Waals interaction and nonpolar solvation energy play an important role in the binding process of Cren7 and dsDNA. Compared with the wild type Cren7, all the studied mutants W26A, L28A, and K53A have obviously reduced binding free energies with dsDNA in the reduction of the polar and/or nonpolar interactions. These results further elucidated the previous experiments to understand the Cren7-DNA interaction comprehensively. Our work also would provide support for an understanding of the interactions of proteins with nucleic acids.

  4. Molecular Dynamics Simulation of Carbon Nanotube Based Gears

    NASA Technical Reports Server (NTRS)

    Han, Jie; Globus, Al; Jaffe, Richard; Deardorff, Glenn; Chancellor, Marisa K. (Technical Monitor)

    1996-01-01

    We used molecular dynamics to investigate the properties and design space of molecular gears fashioned from carbon nanotubes with teeth added via a benzyne reaction known to occur with C60. A modified, parallelized version of Brenner's potential was used to model interatomic forces within each molecule. A Leonard-Jones 6-12 potential was used for forces between molecules. One gear was powered by forcing the atoms near the end of the buckytube to rotate, and a second gear was allowed.to rotate by keeping the atoms near the end of its buckytube on a cylinder. The meshing aromatic gear teeth transfer angular momentum from the powered gear to the driven gear. A number of gear and gear/shaft configurations were simulated. Cases in vacuum and with an inert atmosphere were examined. In an extension to molecular dynamics technology, some simulations used a thermostat on the atmosphere while the hydrocarbon gear's temperature was allowed to fluctuate. This models cooling the gears with an atmosphere. Results suggest that these gears can operate at up to 50-100 gigahertz in a vacuum or inert atmosphere at room temperature. The failure mode involves tooth slip, not bond breaking, so failed gears can be returned to operation by lowering temperature and/or rotation rate. Videos and atomic trajectory files in xyz format are presented.

  5. Pasta nucleosynthesis: Molecular dynamics simulations of nuclear statistical equilibrium

    NASA Astrophysics Data System (ADS)

    Caplan, M. E.; Schneider, A. S.; Horowitz, C. J.; Berry, D. K.

    2015-06-01

    Background: Exotic nonspherical nuclear pasta shapes are expected in nuclear matter at just below saturation density because of competition between short-range nuclear attraction and long-range Coulomb repulsion. Purpose: We explore the impact nuclear pasta may have on nucleosynthesis during neutron star mergers when cold dense nuclear matter is ejected and decompressed. Methods: We use a hybrid CPU/GPU molecular dynamics (MD) code to perform decompression simulations of cold dense matter with 51 200 and 409 600 nucleons from 0.080 fm-3 down to 0.00125 fm-3 . Simulations are run for proton fractions YP= 0.05, 0.10, 0.20, 0.30, and 0.40 at temperatures T = 0.5, 0.75, and 1.0 MeV. The final composition of each simulation is obtained using a cluster algorithm and compared to a constant density run. Results: Size of nuclei in the final state of decompression runs are in good agreement with nuclear statistical equilibrium (NSE) models for temperatures of 1 MeV while constant density runs produce nuclei smaller than the ones obtained with NSE. Our MD simulations produces unphysical results with large rod-like nuclei in the final state of T =0.5 MeV runs. Conclusions: Our MD model is valid at higher densities than simple nuclear statistical equilibrium models and may help determine the initial temperatures and proton fractions of matter ejected in mergers.

  6. Hierarchical Coupling of First-Principles Molecular Dynamics with Advanced Sampling Methods.

    PubMed

    Sevgen, Emre; Giberti, Federico; Sidky, Hythem; Whitmer, Jonathan K; Galli, Giulia; Gygi, Francois; de Pablo, Juan J

    2018-05-14

    We present a seamless coupling of a suite of codes designed to perform advanced sampling simulations, with a first-principles molecular dynamics (MD) engine. As an illustrative example, we discuss results for the free energy and potential surfaces of the alanine dipeptide obtained using both local and hybrid density functionals (DFT), and we compare them with those of a widely used classical force field, Amber99sb. In our calculations, the efficiency of first-principles MD using hybrid functionals is augmented by hierarchical sampling, where hybrid free energy calculations are initiated using estimates obtained with local functionals. We find that the free energy surfaces obtained from classical and first-principles calculations differ. Compared to DFT results, the classical force field overestimates the internal energy contribution of high free energy states, and it underestimates the entropic contribution along the entire free energy profile. Using the string method, we illustrate how these differences lead to different transition pathways connecting the metastable minima of the alanine dipeptide. In larger peptides, those differences would lead to qualitatively different results for the equilibrium structure and conformation of these molecules.

  7. LiGRO: a graphical user interface for protein-ligand molecular dynamics.

    PubMed

    Kagami, Luciano Porto; das Neves, Gustavo Machado; da Silva, Alan Wilter Sousa; Caceres, Rafael Andrade; Kawano, Daniel Fábio; Eifler-Lima, Vera Lucia

    2017-10-04

    To speed up the drug-discovery process, molecular dynamics (MD) calculations performed in GROMACS can be coupled to docking simulations for the post-screening analyses of large compound libraries. This requires generating the topology of the ligands in different software, some basic knowledge of Linux command lines, and a certain familiarity in handling the output files. LiGRO-the python-based graphical interface introduced here-was designed to overcome these protein-ligand parameterization challenges by allowing the graphical (non command line-based) control of GROMACS (MD and analysis), ACPYPE (ligand topology builder) and PLIP (protein-binder interactions monitor)-programs that can be used together to fully perform and analyze the outputs of complex MD simulations (including energy minimization and NVT/NPT equilibration). By allowing the calculation of linear interaction energies in a simple and quick fashion, LiGRO can be used in the drug-discovery pipeline to select compounds with a better protein-binding interaction profile. The design of LiGRO allows researchers to freely download and modify the software, with the source code being available under the terms of a GPLv3 license from http://www.ufrgs.br/lasomfarmacia/ligro/ .

  8. Associating schizophrenia, long non-coding RNAs and neurostructural dynamics

    PubMed Central

    Merelo, Veronica; Durand, Dante; Lescallette, Adam R.; Vrana, Kent E.; Hong, L. Elliot; Faghihi, Mohammad Ali; Bellon, Alfredo

    2015-01-01

    Several lines of evidence indicate that schizophrenia has a strong genetic component. But the exact nature and functional role of this genetic component in the pathophysiology of this mental illness remains a mystery. Long non-coding RNAs (lncRNAs) are a recently discovered family of molecules that regulate gene transcription through a variety of means. Consequently, lncRNAs could help us bring together apparent unrelated findings in schizophrenia; namely, genomic deficiencies on one side and neuroimaging, as well as postmortem results on the other. In fact, the most consistent finding in schizophrenia is decreased brain size together with enlarged ventricles. This anomaly appears to originate from shorter and less ramified dendrites and axons. But a decrease in neuronal arborizations cannot explain the complex pathophysiology of this psychotic disorder; however, dynamic changes in neuronal structure present throughout life could. It is well recognized that the structure of developing neurons is extremely plastic. This structural plasticity was thought to stop with brain development. However, breakthrough discoveries have shown that neuronal structure retains some degree of plasticity throughout life. What the neuroscientific field is still trying to understand is how these dynamic changes are regulated and lncRNAs represent promising candidates to fill this knowledge gap. Here, we present evidence that associates specific lncRNAs with schizophrenia. We then discuss the potential role of lncRNAs in neurostructural dynamics. Finally, we explain how dynamic neurostructural modifications present throughout life could, in theory, reconcile apparent unrelated findings in schizophrenia. PMID:26483630

  9. Predictive Coding of Dynamical Variables in Balanced Spiking Networks

    PubMed Central

    Boerlin, Martin; Machens, Christian K.; Denève, Sophie

    2013-01-01

    Two observations about the cortex have puzzled neuroscientists for a long time. First, neural responses are highly variable. Second, the level of excitation and inhibition received by each neuron is tightly balanced at all times. Here, we demonstrate that both properties are necessary consequences of neural networks that represent information efficiently in their spikes. We illustrate this insight with spiking networks that represent dynamical variables. Our approach is based on two assumptions: We assume that information about dynamical variables can be read out linearly from neural spike trains, and we assume that neurons only fire a spike if that improves the representation of the dynamical variables. Based on these assumptions, we derive a network of leaky integrate-and-fire neurons that is able to implement arbitrary linear dynamical systems. We show that the membrane voltage of the neurons is equivalent to a prediction error about a common population-level signal. Among other things, our approach allows us to construct an integrator network of spiking neurons that is robust against many perturbations. Most importantly, neural variability in our networks cannot be equated to noise. Despite exhibiting the same single unit properties as widely used population code models (e.g. tuning curves, Poisson distributed spike trains), balanced networks are orders of magnitudes more reliable. Our approach suggests that spikes do matter when considering how the brain computes, and that the reliability of cortical representations could have been strongly underestimated. PMID:24244113

  10. The Design, Synthesis, and Study of Solid-State Molecular Rotors: Structure/Function Relationships for Condensed-Phase Anisotropic Dynamics

    NASA Astrophysics Data System (ADS)

    Vogelsberg, Cortnie Sue

    Amphidynamic crystals are an extremely promising platform for the development of artificial molecular machines and stimuli-responsive materials. In analogy to skeletal muscle, their function will rely upon the collective operation of many densely packed molecular machines (i.e. actin-bound myosin) that are self-assembled in a highly organized anisotropic medium. By choosing lattice-forming elements and moving "parts" with specific functionalities, individual molecular machines may be synthesized and self-assembled in order to carry out desirable functions. In recent years, efforts in the design of amphidynamic materials based on molecular gyroscopes and compasses have shown that a certain amount of free volume is essential to facilitate internal rotation and reorientation within a crystal. In order to further establish structure/function relationships to advance the development of increasingly complex molecular machinery, molecular rotors and a molecular "spinning" top were synthesized and incorporated into a variety of solid-state architectures with different degrees of periodicity, dimensionality, and free volume. Specifically, lamellar molecular crystals, hierarchically ordered periodic mesoporous organosilicas, and metal-organic frameworks were targeted for the development of solid-state molecular machines. Using an array of solid-state nuclear magnetic resonance spectroscopy techniques, the dynamic properties of these novel molecular machine assemblies were determined and correlated with their corresponding structural features. It was found that architecture type has a profound influence on functional dynamics. The study of layered molecular crystals, composed of either molecular rotors or "spinning" tops, probed functional dynamics within dense, highly organized environments. From their study, it was discovered that: 1) crystallographically distinct sites may be utilized to differentiate machine function, 2) halogen bonding interactions are sufficiently

  11. POLYANA-A tool for the calculation of molecular radial distribution functions based on Molecular Dynamics trajectories

    NASA Astrophysics Data System (ADS)

    Dimitroulis, Christos; Raptis, Theophanes; Raptis, Vasilios

    2015-12-01

    We present an application for the calculation of radial distribution functions for molecular centres of mass, based on trajectories generated by molecular simulation methods (Molecular Dynamics, Monte Carlo). When designing this application, the emphasis was placed on ease of use as well as ease of further development. In its current version, the program can read trajectories generated by the well-known DL_POLY package, but it can be easily extended to handle other formats. It is also very easy to 'hack' the program so it can compute intermolecular radial distribution functions for groups of interaction sites rather than whole molecules.

  12. Molecular shear heating and vortex dynamics in thermostatted two dimensional Yukawa liquids

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Gupta, Akanksha; Ganesh, Rajaraman, E-mail: ganesh@ipr.res.in; Joy, Ashwin

    2016-07-15

    It is well known that two-dimensional macroscale shear flows are susceptible to instabilities leading to macroscale vortical structures. The linear and nonlinear fate of such a macroscale flow in a strongly coupled medium is a fundamental problem. A popular example of a strongly coupled medium is a dusty plasma, often modelled as a Yukawa liquid. Recently, laboratory experiments and molecular dynamics (MD) studies of shear flows in strongly coupled Yukawa liquids indicated the occurrence of strong molecular shear heating, which is found to reduce the coupling strength exponentially leading to the destruction of macroscale vorticity. To understand the vortex dynamicsmore » of strongly coupled molecular fluids undergoing macroscale shear flows and molecular shear heating, MD simulation has been performed, which allows the macroscopic vortex dynamics to evolve, while at the same time “removes” the microscopically generated heat without using the velocity degrees of freedom. We demonstrate that by using a configurational thermostat in a novel way, the microscale heat generated by shear flow can be thermostatted out efficiently without compromising the large scale vortex dynamics. In the present work, using MD simulations, a comparative study of shear flow evolution in Yukawa liquids in the presence and absence of molecular or microscopic heating is presented for a prototype shear flow, namely, Kolmogorov flow.« less

  13. Smoothed-particle hydrodynamics and nonequilibrium molecular dynamics

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Hoover, W. G.; Hoover, C. G.

    1993-08-01

    Gingold, Lucy, and Monaghan invented a grid-free version of continuum mechanics ``smoothed-particle hydrodynamics,`` in 1977. It is a likely contributor to ``hybrid`` simulations combining atomistic and continuum simulations. We describe applications of this particle-based continuum technique from the closely-related standpoint of nonequilibrium molecular dynamics. We compare chaotic Lyapunov spectra for atomistic solids and fluids with those which characterize a two-dimensional smoothed-particle fluid system.

  14. The fluctuating ribosome: thermal molecular dynamics characterized by neutron scattering

    NASA Astrophysics Data System (ADS)

    Zaccai, Giuseppe; Natali, Francesca; Peters, Judith; Řihová, Martina; Zimmerman, Ella; Ollivier, J.; Combet, J.; Maurel, Marie-Christine; Bashan, Anat; Yonath, Ada

    2016-11-01

    Conformational changes associated with ribosome function have been identified by X-ray crystallography and cryo-electron microscopy. These methods, however, inform poorly on timescales. Neutron scattering is well adapted for direct measurements of thermal molecular dynamics, the ‘lubricant’ for the conformational fluctuations required for biological activity. The method was applied to compare water dynamics and conformational fluctuations in the 30 S and 50 S ribosomal subunits from Haloarcula marismortui, under high salt, stable conditions. Similar free and hydration water diffusion parameters are found for both subunits. With respect to the 50 S subunit, the 30 S is characterized by a softer force constant and larger mean square displacements (MSD), which would facilitate conformational adjustments required for messenger and transfer RNA binding. It has been shown previously that systems from mesophiles and extremophiles are adapted to have similar MSD under their respective physiological conditions. This suggests that the results presented are not specific to halophiles in high salt but a general property of ribosome dynamics under corresponding, active conditions. The current study opens new perspectives for neutron scattering characterization of component functional molecular dynamics within the ribosome.

  15. Statistical study of defects caused by primary knock-on atoms in fcc Cu and bcc W using molecular dynamics

    NASA Astrophysics Data System (ADS)

    Warrier, M.; Bhardwaj, U.; Hemani, H.; Schneider, R.; Mutzke, A.; Valsakumar, M. C.

    2015-12-01

    We report on molecular Dynamics (MD) simulations carried out in fcc Cu and bcc W using the Large-scale Atomic/Molecular Massively Parallel Simulator (LAMMPS) code to study (i) the statistical variations in the number of interstitials and vacancies produced by energetic primary knock-on atoms (PKA) (0.1-5 keV) directed in random directions and (ii) the in-cascade cluster size distributions. It is seen that around 60-80 random directions have to be explored for the average number of displaced atoms to become steady in the case of fcc Cu, whereas for bcc W around 50-60 random directions need to be explored. The number of Frenkel pairs produced in the MD simulations are compared with that from the Binary Collision Approximation Monte Carlo (BCA-MC) code SDTRIM-SP and the results from the NRT model. It is seen that a proper choice of the damage energy, i.e. the energy required to create a stable interstitial, is essential for the BCA-MC results to match the MD results. On the computational front it is seen that in-situ processing saves the need to input/output (I/O) atomic position data of several tera-bytes when exploring a large number of random directions and there is no difference in run-time because the extra run-time in processing data is offset by the time saved in I/O.

  16. Self Diffusion in Nano Filled Polymer Melts: a Molecular Dynamics Simulation Study

    NASA Astrophysics Data System (ADS)

    Desai, Tapan; Keblinski, Pawel

    2003-03-01

    SELF DIFFUSION IN NANO FILLED POLYMER MELTS: A MOLECULAR DYNAMICS SIMULATION STUDY* T. G. Desai,P. Keblinski, Material Science and Engineering Department, Rensselaer Polytechnic Institute, Troy, NY. Using molecular dynamics simulations, we studied the dynamics of the polymeric systems containing immobile and analytically smooth spherical nanoparticles. Each chain consisted of N monomers connected by an anharmonic springs described by the finite extendible nonlinear elastic, FENE potential. The system comprises of 3nanoparticles and the rest by freely rotating but not overlapping chains. The longest chain studied has a Radius of gyration equal to particle size radius and comparable to inter-particle distance. There is no effect on the structural characteristics such as Radius of gyration or end to end distance due to the nanoparticles. Diffusion of polymeric chains is not affected by the presence of either attractive or repulsive nanoparticles. In all cases Rouse dynamics is observed for short chains with a crossover to reptation dynamics for longer chains.

  17. N-MODY: A Code for Collisionless N-body Simulations in Modified Newtonian Dynamics

    NASA Astrophysics Data System (ADS)

    Londrillo, Pasquale; Nipoti, Carlo

    2011-02-01

    N-MODY is a parallel particle-mesh code for collisionless N-body simulations in modified Newtonian dynamics (MOND). N-MODY is based on a numerical potential solver in spherical coordinates that solves the non-linear MOND field equation, and is ideally suited to simulate isolated stellar systems. N-MODY can be used also to compute the MOND potential of arbitrary static density distributions. A few applications of N-MODY indicate that some astrophysically relevant dynamical processes are profoundly different in MOND and in Newtonian gravity with dark matter.

  18. Experimentally assessing molecular dynamics sampling of the protein native state conformational distribution

    PubMed Central

    Hernández, Griselda; Anderson, Janet S.; LeMaster, David M.

    2012-01-01

    The acute sensitivity to conformation exhibited by amide hydrogen exchange reactivity provides a valuable test for the physical accuracy of model ensembles developed to represent the Boltzmann distribution of the protein native state. A number of molecular dynamics studies of ubiquitin have predicted a well-populated transition in the tight turn immediately preceding the primary site of proteasome-directed polyubiquitylation Lys 48. Amide exchange reactivity analysis demonstrates that this transition is 103-fold rarer than these predictions. More strikingly, for the most populated novel conformational basin predicted from a recent 1 ms MD simulation of bovine pancreatic trypsin inhibitor (at 13% of total), experimental hydrogen exchange data indicates a population below 10−6. The most sophisticated efforts to directly incorporate experimental constraints into the derivation of model protein ensembles have been applied to ubiquitin, as illustrated by three recently deposited studies (PDB codes 2NR2, 2K39 and 2KOX). Utilizing the extensive set of experimental NOE constraints, each of these three ensembles yields a modestly more accurate prediction of the exchange rates for the highly exposed amides than does a standard unconstrained molecular simulation. However, for the less frequently exposed amide hydrogens, the 2NR2 ensemble offers no improvement in rate predictions as compared to the unconstrained MD ensemble. The other two NMR-constrained ensembles performed markedly worse, either underestimating (2KOX) or overestimating (2K39) the extent of conformational diversity. PMID:22425325

  19. Molecular Dynamics Simulation of Hydrogen Trapping on Sigma 5 Tungsten Grain Boundaries

    NASA Astrophysics Data System (ADS)

    Al-Shalash, Aws Mohammed Taha

    Tungsten as a plasma facing material is the predominant contender for future Tokamak reactor environments. The interaction between the plasma particles and tungsten is crucial to be studied for successful usage and design of tungsten in the plasma facing components ensuring the reliability and longevity of the fusion reactors. The bombardment of the sigma 5 polycrystalline tungsten was modeled using the molecular dynamics simulation through the large-scale atomic/molecular massively parallel simulator (LAMMPS) code and Tersoff type interatomic potential. By simulating the operational conditions of the Tokamak reactors, the hydrogen trapping rate, implantation distribution, and bubble formation was investigated at various temperatures (300-1200 K) and various hydrogen incident energy (20-100 eV). The substrate's temperature increases the deflected H atoms, and increases the penetration depth for the ones that go through. As well, the lower temperature tungsten substrates retain more H atoms. Increasing the bombarded hydrogen's energy increases the trapping and retention rate and the depth of penetration. Another experiments were conducted to determine whether the Sigma5 grain boundary's (GB) location affects the trapping profiles in H. The findings are ranges from small effect on deflection rates at low H energies to no effect at high H energies. However, there is a considerable effect on shifting the trapping depth profile upward toward the surface when raising the GB closer to the surface. Hydrogen atoms are highly mobile on tungsten substrate, yet no bubble formation was witnessed.

  20. Recent applications of boxed molecular dynamics: a simple multiscale technique for atomistic simulations.

    PubMed

    Booth, Jonathan; Vazquez, Saulo; Martinez-Nunez, Emilio; Marks, Alison; Rodgers, Jeff; Glowacki, David R; Shalashilin, Dmitrii V

    2014-08-06

    In this paper, we briefly review the boxed molecular dynamics (BXD) method which allows analysis of thermodynamics and kinetics in complicated molecular systems. BXD is a multiscale technique, in which thermodynamics and long-time dynamics are recovered from a set of short-time simulations. In this paper, we review previous applications of BXD to peptide cyclization, solution phase organic reaction dynamics and desorption of ions from self-assembled monolayers (SAMs). We also report preliminary results of simulations of diamond etching mechanisms and protein unfolding in atomic force microscopy experiments. The latter demonstrate a correlation between the protein's structural motifs and its potential of mean force. Simulations of these processes by standard molecular dynamics (MD) is typically not possible, because the experimental time scales are very long. However, BXD yields well-converged and physically meaningful results. Compared with other methods of accelerated MD, our BXD approach is very simple; it is easy to implement, and it provides an integrated approach for simultaneously obtaining both thermodynamics and kinetics. It also provides a strategy for obtaining statistically meaningful dynamical results in regions of configuration space that standard MD approaches would visit only very rarely.

  1. Molecular dynamics simulations of theoretical cellulose nanotube models.

    PubMed

    Uto, Takuya; Kodama, Yuta; Miyata, Tatsuhiko; Yui, Toshifumi

    2018-06-15

    Nanotubes are remarkable nanoscale architectures for a wide range of potential applications. In the present paper, we report a molecular dynamics (MD) study of the theoretical cellulose nanotube (CelNT) models to evaluate their dynamic behavior in solution (either chloroform or benzene). Based on the one-quarter chain staggering relationship, we constructed six CelNT models by combining the two chain polarities (parallel (P) and antiparallel (AP)) and three symmetry operations (helical right (H R ), helical left (H L ), and rotation (R)) to generate a circular arrangement of molecular chains. Among the four models that retained the tubular form (P-H R , P-H L , P-R, and AP-R), the P-R and AP-R models have the lowest steric energies in benzene and chloroform, respectively. The structural features of the CelNT models were characterized in terms of the hydroxymethyl group conformation and intermolecular hydrogen bonds. Solvent structuring more clearly occurred with benzene than chloroform, suggesting that the CelNT models may disperse in benzene. Copyright © 2018 Elsevier Ltd. All rights reserved.

  2. Molecular Dynamics Simulations of Adhesion at Epoxy Interfaces

    NASA Technical Reports Server (NTRS)

    Frankland, Sarah-Jane V.; Clancy, Thomas C.; Hinkley, J. A.; Gates. T. S.

    2008-01-01

    The effect of moisture on adhesives used in aerospace applications can be modeled with chemically specific techniques such as molecular dynamics simulation. In the present study, the surface energy and work of adhesion are calculated for epoxy surfaces and interfaces, respectively, by using molecular dynamics simulation. Modifications are made to current theory to calculate the work of adhesion at the epoxy-epoxy interface with and without water. Quantitative agreement with experimental values is obtained for the surface energy and work of adhesion at the interface without water. The work of adhesion agrees qualitatively with the experimental values for the interface with water: the magnitude is reduced 15% with respect to the value for the interface without water. A variation of 26% in the magnitude is observed depending on the water configuration at a concentration of 1.6 wt%. The methods and modifications to the method that are employed to obtain these values are expected to be applicable for other epoxy adhesives to determine the effects of moisture uptake on their work of adhesion.

  3. Multibillion-atom Molecular Dynamics Simulations of Plasticity, Spall, and Ejecta

    NASA Astrophysics Data System (ADS)

    Germann, Timothy C.

    2007-06-01

    Modern supercomputing platforms, such as the IBM BlueGene/L at Lawrence Livermore National Laboratory and the Roadrunner hybrid supercomputer being built at Los Alamos National Laboratory, are enabling large-scale classical molecular dynamics simulations of phenomena that were unthinkable just a few years ago. Using either the embedded atom method (EAM) description of simple (close-packed) metals, or modified EAM (MEAM) models of more complex solids and alloys with mixed covalent and metallic character, simulations containing billions to trillions of atoms are now practical, reaching volumes in excess of a cubic micron. In order to obtain any new physical insights, however, it is equally important that the analysis of such systems be tractable. This is in fact possible, in large part due to our highly efficient parallel visualization code, which enables the rendering of atomic spheres, Eulerian cells, and other geometric objects in a matter of minutes, even for tens of thousands of processors and billions of atoms. After briefly describing the BlueGene/L and Roadrunner architectures, and the code optimization strategies that were employed, results obtained thus far on BlueGene/L will be reviewed, including: (1) shock compression and release of a defective EAM Cu sample, illustrating the plastic deformation accompanying void collapse as well as the subsequent void growth and linkup upon release; (2) solid-solid martensitic phase transition in shock-compressed MEAM Ga; and (3) Rayleigh-Taylor fluid instability modeled using large-scale direct simulation Monte Carlo (DSMC) simulations. I will also describe our initial experiences utilizing Cell Broadband Engine processors (developed for the Sony PlayStation 3), and planned simulation studies of ejecta and spall failure in polycrystalline metals that will be carried out when the full Petaflop Opteron/Cell Roadrunner supercomputer is assembled in mid-2008.

  4. Structure of a tethered polymer under flow using molecular dynamics and hybrid molecular-continuum simulations

    NASA Astrophysics Data System (ADS)

    Delgado-Buscalioni, Rafael; Coveney, Peter V.

    2006-03-01

    We analyse the structure of a single polymer tethered to a solid surface undergoing a Couette flow. We study the problem using molecular dynamics (MD) and hybrid MD-continuum simulations, wherein the polymer and the surrounding solvent are treated via standard MD, and the solvent flow farther away from the polymer is solved by continuum fluid dynamics (CFD). The polymer represents a freely jointed chain (FJC) and is modelled by Lennard-Jones (LJ) beads interacting through the FENE potential. The solvent (modelled as a LJ fluid) and a weakly attractive wall are treated at the molecular level. At large shear rates the polymer becomes more elongated than predicted by existing theoretical scaling laws. Also, along the normal-to-wall direction the structure observed for the FJC is, surprisingly, very similar to that predicted for a semiflexible chain. Comparison with previous Brownian dynamics simulations (which exclude both solvent and wall potential) indicates that these effects are due to the polymer-solvent and polymer-wall interactions. The hybrid simulations are in perfect agreement with the MD simulations, showing no trace of finite size effects. Importantly, the extra cost required to couple the MD and CFD domains is negligible.

  5. Pipeline for inferring protein function from dynamics using coarse-grained molecular mechanics forcefield.

    PubMed

    Bhadra, Pratiti; Pal, Debnath

    2017-04-01

    Dynamics is integral to the function of proteins, yet the use of molecular dynamics (MD) simulation as a technique remains under-explored for molecular function inference. This is more important in the context of genomics projects where novel proteins are determined with limited evolutionary information. Recently we developed a method to match the query protein's flexible segments to infer function using a novel approach combining analysis of residue fluctuation-graphs and auto-correlation vectors derived from coarse-grained (CG) MD trajectory. The method was validated on a diverse dataset with sequence identity between proteins as low as 3%, with high function-recall rates. Here we share its implementation as a publicly accessible web service, named DynFunc (Dynamics Match for Function) to query protein function from ≥1 µs long CG dynamics trajectory information of protein subunits. Users are provided with the custom-developed coarse-grained molecular mechanics (CGMM) forcefield to generate the MD trajectories for their protein of interest. On upload of trajectory information, the DynFunc web server identifies specific flexible regions of the protein linked to putative molecular function. Our unique application does not use evolutionary information to infer molecular function from MD information and can, therefore, work for all proteins, including moonlighting and the novel ones, whenever structural information is available. Our pipeline is expected to be of utility to all structural biologists working with novel proteins and interested in moonlighting functions. Copyright © 2017 Elsevier Ltd. All rights reserved.

  6. Multiscale Molecular Dynamics Model for Heterogeneous Charged Systems

    NASA Astrophysics Data System (ADS)

    Stanton, L. G.; Glosli, J. N.; Murillo, M. S.

    2018-04-01

    Modeling matter across large length scales and timescales using molecular dynamics simulations poses significant challenges. These challenges are typically addressed through the use of precomputed pair potentials that depend on thermodynamic properties like temperature and density; however, many scenarios of interest involve spatiotemporal variations in these properties, and such variations can violate assumptions made in constructing these potentials, thus precluding their use. In particular, when a system is strongly heterogeneous, most of the usual simplifying assumptions (e.g., spherical potentials) do not apply. Here, we present a multiscale approach to orbital-free density functional theory molecular dynamics (OFDFT-MD) simulations that bridges atomic, interionic, and continuum length scales to allow for variations in hydrodynamic quantities in a consistent way. Our multiscale approach enables simulations on the order of micron length scales and 10's of picosecond timescales, which exceeds current OFDFT-MD simulations by many orders of magnitude. This new capability is then used to study the heterogeneous, nonequilibrium dynamics of a heated interface characteristic of an inertial-confinement-fusion capsule containing a plastic ablator near a fuel layer composed of deuterium-tritium ice. At these scales, fundamental assumptions of continuum models are explored; features such as the separation of the momentum fields among the species and strong hydrogen jetting from the plastic into the fuel region are observed, which had previously not been seen in hydrodynamic simulations.

  7. A molecular dynamics study of polymer/graphene interfacial systems

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Rissanou, Anastassia N.; Harmandaris, Vagelis

    2014-05-15

    Graphene based polymer nanocomposites are hybrid materials with a very broad range of technological applications. In this work, we study three hybrid polymer/graphene interfacial systems (polystyrene/graphene, poly(methyl methacrylate)/graphene and polyethylene/graphene) through detailed atomistic molecular dynamics (MD) simulations. Density profiles, structural characteristics and mobility aspects are being examined at the molecular level for all model systems. In addition, we compare the properties of the hybrid systems to the properties of the corresponding bulk ones, as well as to theoretical predictions.

  8. Molecular dynamics simulations of dense plasmas

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Collins, L.A.; Kress, J.D.; Kwon, I.

    1993-12-31

    We have performed quantum molecular dynamics simulations of hot, dense plasmas of hydrogen over a range of temperatures(0.1-5eV) and densities(0.0625-5g/cc). We determine the forces quantum mechanically from density functional, extended Huckel, and tight binding techniques and move the nuclei according to the classical equations of motion. We determine pair-correlation functions, diffusion coefficients, and electrical conductivities. We find that many-body effects predominate in this regime. We begin to obtain agreement with the OCP and Thomas-Fermi models only at the higher temperatures and densities.

  9. Multilevel summation with B-spline interpolation for pairwise interactions in molecular dynamics simulations

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Hardy, David J., E-mail: dhardy@illinois.edu; Schulten, Klaus; Wolff, Matthew A.

    2016-03-21

    The multilevel summation method for calculating electrostatic interactions in molecular dynamics simulations constructs an approximation to a pairwise interaction kernel and its gradient, which can be evaluated at a cost that scales linearly with the number of atoms. The method smoothly splits the kernel into a sum of partial kernels of increasing range and decreasing variability with the longer-range parts interpolated from grids of increasing coarseness. Multilevel summation is especially appropriate in the context of dynamics and minimization, because it can produce continuous gradients. This article explores the use of B-splines to increase the accuracy of the multilevel summation methodmore » (for nonperiodic boundaries) without incurring additional computation other than a preprocessing step (whose cost also scales linearly). To obtain accurate results efficiently involves technical difficulties, which are overcome by a novel preprocessing algorithm. Numerical experiments demonstrate that the resulting method offers substantial improvements in accuracy and that its performance is competitive with an implementation of the fast multipole method in general and markedly better for Hamiltonian formulations of molecular dynamics. The improvement is great enough to establish multilevel summation as a serious contender for calculating pairwise interactions in molecular dynamics simulations. In particular, the method appears to be uniquely capable for molecular dynamics in two situations, nonperiodic boundary conditions and massively parallel computation, where the fast Fourier transform employed in the particle–mesh Ewald method falls short.« less

  10. Molecular Dynamics Simulations of Nucleic Acids. From Tetranucleotides to the Ribosome.

    PubMed

    Šponer, Jiří; Banáš, Pavel; Jurečka, Petr; Zgarbová, Marie; Kührová, Petra; Havrila, Marek; Krepl, Miroslav; Stadlbauer, Petr; Otyepka, Michal

    2014-05-15

    We present a brief overview of explicit solvent molecular dynamics (MD) simulations of nucleic acids. We explain physical chemistry limitations of the simulations, namely, the molecular mechanics (MM) force field (FF) approximation and limited time scale. Further, we discuss relations and differences between simulations and experiments, compare standard and enhanced sampling simulations, discuss the role of starting structures, comment on different versions of nucleic acid FFs, and relate MM computations with contemporary quantum chemistry. Despite its limitations, we show that MD is a powerful technique for studying the structural dynamics of nucleic acids with a fast growing potential that substantially complements experimental results and aids their interpretation.

  11. The dance of molecules: new dynamical perspectives on highly excited molecular vibrations.

    PubMed

    Kellman, Michael E; Tyng, Vivian

    2007-04-01

    At low energies, molecular vibrational motion is described by the normal modes model. This model breaks down at higher energy, with strong coupling between normal modes and onset of chaotic dynamics. New anharmonic modes are born in bifurcations, or branchings of the normal modes. Knowledge of these new modes is obtained through the window of frequency-domain spectroscopy, using techniques of nonlinear classical dynamics. It may soon be possible to "watch" molecular rearrangement reactions spectroscopically. Connections are being made with reaction rate theories, condensed phase systems, and motions of electrons in quantum dots.

  12. raaSAFT: A framework enabling coarse-grained molecular dynamics simulations based on the SAFT- γ Mie force field

    NASA Astrophysics Data System (ADS)

    Ervik, Åsmund; Serratos, Guadalupe Jiménez; Müller, Erich A.

    2017-03-01

    We describe here raaSAFT, a Python code that enables the setup and running of coarse-grained molecular dynamics simulations in a systematic and efficient manner. The code is built on top of the popular HOOMD-blue code, and as such harnesses the computational power of GPUs. The methodology makes use of the SAFT- γ Mie force field, so the resulting coarse grained pair potentials are both closely linked to and consistent with the macroscopic thermodynamic properties of the simulated fluid. In raaSAFT both homonuclear and heteronuclear models are implemented for a wide range of compounds spanning from linear alkanes, to more complicated fluids such as water and alcohols, all the way up to nonionic surfactants and models of asphaltenes and resins. Adding new compounds as well as new features is made straightforward by the modularity of the code. To demonstrate the ease-of-use of raaSAFT, we give a detailed walkthrough of how to simulate liquid-liquid equilibrium of a hydrocarbon with water. We describe in detail how both homonuclear and heteronuclear compounds are implemented. To demonstrate the performance and versatility of raaSAFT, we simulate a large polymer-solvent mixture with 300 polystyrene molecules dissolved in 42 700 molecules of heptane, reproducing the experimentally observed temperature-dependent solubility of polystyrene. For this case we obtain a speedup of more than three orders of magnitude as compared to atomistically-detailed simulations.

  13. Distance-Based Configurational Entropy of Proteins from Molecular Dynamics Simulations

    PubMed Central

    Fogolari, Federico; Corazza, Alessandra; Fortuna, Sara; Soler, Miguel Angel; VanSchouwen, Bryan; Brancolini, Giorgia; Corni, Stefano; Melacini, Giuseppe; Esposito, Gennaro

    2015-01-01

    Estimation of configurational entropy from molecular dynamics trajectories is a difficult task which is often performed using quasi-harmonic or histogram analysis. An entirely different approach, proposed recently, estimates local density distribution around each conformational sample by measuring the distance from its nearest neighbors. In this work we show this theoretically well grounded the method can be easily applied to estimate the entropy from conformational sampling. We consider a set of systems that are representative of important biomolecular processes. In particular: reference entropies for amino acids in unfolded proteins are obtained from a database of residues not participating in secondary structure elements;the conformational entropy of folding of β2-microglobulin is computed from molecular dynamics simulations using reference entropies for the unfolded state;backbone conformational entropy is computed from molecular dynamics simulations of four different states of the EPAC protein and compared with order parameters (often used as a measure of entropy);the conformational and rototranslational entropy of binding is computed from simulations of 20 tripeptides bound to the peptide binding protein OppA and of β2-microglobulin bound to a citrate coated gold surface. This work shows the potential of the method in the most representative biological processes involving proteins, and provides a valuable alternative, principally in the shown cases, where other approaches are problematic. PMID:26177039

  14. Distance-Based Configurational Entropy of Proteins from Molecular Dynamics Simulations.

    PubMed

    Fogolari, Federico; Corazza, Alessandra; Fortuna, Sara; Soler, Miguel Angel; VanSchouwen, Bryan; Brancolini, Giorgia; Corni, Stefano; Melacini, Giuseppe; Esposito, Gennaro

    2015-01-01

    Estimation of configurational entropy from molecular dynamics trajectories is a difficult task which is often performed using quasi-harmonic or histogram analysis. An entirely different approach, proposed recently, estimates local density distribution around each conformational sample by measuring the distance from its nearest neighbors. In this work we show this theoretically well grounded the method can be easily applied to estimate the entropy from conformational sampling. We consider a set of systems that are representative of important biomolecular processes. In particular: reference entropies for amino acids in unfolded proteins are obtained from a database of residues not participating in secondary structure elements;the conformational entropy of folding of β2-microglobulin is computed from molecular dynamics simulations using reference entropies for the unfolded state;backbone conformational entropy is computed from molecular dynamics simulations of four different states of the EPAC protein and compared with order parameters (often used as a measure of entropy);the conformational and rototranslational entropy of binding is computed from simulations of 20 tripeptides bound to the peptide binding protein OppA and of β2-microglobulin bound to a citrate coated gold surface. This work shows the potential of the method in the most representative biological processes involving proteins, and provides a valuable alternative, principally in the shown cases, where other approaches are problematic.

  15. Exploiting molecular dynamics in Nested Sampling simulations of small peptides

    NASA Astrophysics Data System (ADS)

    Burkoff, Nikolas S.; Baldock, Robert J. N.; Várnai, Csilla; Wild, David L.; Csányi, Gábor

    2016-04-01

    Nested Sampling (NS) is a parameter space sampling algorithm which can be used for sampling the equilibrium thermodynamics of atomistic systems. NS has previously been used to explore the potential energy surface of a coarse-grained protein model and has significantly outperformed parallel tempering when calculating heat capacity curves of Lennard-Jones clusters. The original NS algorithm uses Monte Carlo (MC) moves; however, a variant, Galilean NS, has recently been introduced which allows NS to be incorporated into a molecular dynamics framework, so NS can be used for systems which lack efficient prescribed MC moves. In this work we demonstrate the applicability of Galilean NS to atomistic systems. We present an implementation of Galilean NS using the Amber molecular dynamics package and demonstrate its viability by sampling alanine dipeptide, both in vacuo and implicit solvent. Unlike previous studies of this system, we present the heat capacity curves of alanine dipeptide, whose calculation provides a stringent test for sampling algorithms. We also compare our results with those calculated using replica exchange molecular dynamics (REMD) and find good agreement. We show the computational effort required for accurate heat capacity estimation for small peptides. We also calculate the alanine dipeptide Ramachandran free energy surface for a range of temperatures and use it to compare the results using the latest Amber force field with previous theoretical and experimental results.

  16. Hardware accelerator for molecular dynamics: MDGRAPE-2

    NASA Astrophysics Data System (ADS)

    Susukita, Ryutaro; Ebisuzaki, Toshikazu; Elmegreen, Bruce G.; Furusawa, Hideaki; Kato, Kenya; Kawai, Atsushi; Kobayashi, Yoshinao; Koishi, Takahiro; McNiven, Geoffrey D.; Narumi, Tetsu; Yasuoka, Kenji

    2003-10-01

    We developed MDGRAPE-2, a hardware accelerator that calculates forces at high speed in molecular dynamics (MD) simulations. MDGRAPE-2 is connected to a PC or a workstation as an extension board. The sustained performance of one MDGRAPE-2 board is 15 Gflops, roughly equivalent to the peak performance of the fastest supercomputer processing element. One board is able to calculate all forces between 10 000 particles in 0.28 s (i.e. 310000 time steps per day). If 16 boards are connected to one computer and operated in parallel, this calculation speed becomes ˜10 times faster. In addition to MD, MDGRAPE-2 can be applied to gravitational N-body simulations, the vortex method and smoothed particle hydrodynamics in computational fluid dynamics.

  17. Structured Ionomer Thin Films at Water Interface: Molecular Dynamics Simulation Insight

    DOE PAGES

    Aryal, Dipak; Agrawal, Anupriya; Perahia, Dvora; ...

    2017-08-23

    Controlling the structure and dynamics of thin films of ionizable polymers at water interfaces is critical to their many applications. As the chemical diversity within one polymer is increased, controlling the structure and dynamics of the polymer, which is a key to their use, becomes a challenge. Here molecular dynamics simulations (MD) are used to obtain molecular insight into the structure and dynamics of thin films of one such macromolecule at the interface with water. The polymer consists of an ABCBA topology with randomly sulfonated polystyrene (C), tethered symmetrically to flexible poly(ethylene- r-propylene) blocks (B), and end-capped by a poly(more » t-butylstyrene) block (A). The compositions of the interfacial and bulk regions of thin films of the ABCBA polymers are followed as a function of exposure time to water. We find that interfacial rearrangements take place where buried ionic segments migrate toward the water interface. The hydrophobic blocks collapse and rearrange to minimize their exposure to water. In conclusion, the water that initially drives interfacial reengagements breaks the ionic clusters within the film, forming a dynamic hydrophilic internal network within the hydrophobic segments.« less

  18. Quantum Molecular Dynamics Simulations of Nanotube Tip Assisted Reactions

    NASA Technical Reports Server (NTRS)

    Menon, Madhu

    1998-01-01

    In this report we detail the development and application of an efficient quantum molecular dynamics computational algorithm and its application to the nanotube-tip assisted reactions on silicon and diamond surfaces. The calculations shed interesting insights into the microscopic picture of tip surface interactions.

  19. Molecular dynamics simulations of methane hydrate decomposition.

    PubMed

    Myshakin, Evgeniy M; Jiang, Hao; Warzinski, Robert P; Jordan, Kenneth D

    2009-03-12

    Molecular dynamics simulations have been carried out to study decomposition of methane hydrate at different cage occupancies. The decomposition rate is found to depend sensitively on the hydration number. The rate of the destruction of the cages displays Arrhenius behavior, consistent with an activated mechanism. During the simulations, reversible formation of partial water cages around methane molecules in the liquid was observed at the interface at temperatures above the computed hydrate decomposition temperature.

  20. Predicting RNA Duplex Dimerization Free-Energy Changes upon Mutations Using Molecular Dynamics Simulations.

    PubMed

    Sakuraba, Shun; Asai, Kiyoshi; Kameda, Tomoshi

    2015-11-05

    The dimerization free energies of RNA-RNA duplexes are fundamental values that represent the structural stability of RNA complexes. We report a comparative analysis of RNA-RNA duplex dimerization free-energy changes upon mutations, estimated from a molecular dynamics simulation and experiments. A linear regression for nine pairs of double-stranded RNA sequences, six base pairs each, yielded a mean absolute deviation of 0.55 kcal/mol and an R(2) value of 0.97, indicating quantitative agreement between simulations and experimental data. The observed accuracy indicates that the molecular dynamics simulation with the current molecular force field is capable of estimating the thermodynamic properties of RNA molecules.

  1. Implementing Molecular Dynamics on Hybrid High Performance Computers - Three-Body Potentials

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Brown, W Michael; Yamada, Masako

    The use of coprocessors or accelerators such as graphics processing units (GPUs) has become popular in scientific computing applications due to their low cost, impressive floating-point capabilities, high memory bandwidth, and low electrical power re- quirements. Hybrid high-performance computers, defined as machines with nodes containing more than one type of floating-point processor (e.g. CPU and GPU), are now becoming more prevalent due to these advantages. Although there has been extensive research into methods to efficiently use accelerators to improve the performance of molecular dynamics (MD) employing pairwise potential energy models, little is reported in the literature for models that includemore » many-body effects. 3-body terms are required for many popular potentials such as MEAM, Tersoff, REBO, AIREBO, Stillinger-Weber, Bond-Order Potentials, and others. Because the per-atom simulation times are much higher for models incorporating 3-body terms, there is a clear need for efficient algo- rithms usable on hybrid high performance computers. Here, we report a shared-memory force-decomposition for 3-body potentials that avoids memory conflicts to allow for a deterministic code with substantial performance improvements on hybrid machines. We describe modifications necessary for use in distributed memory MD codes and show results for the simulation of water with Stillinger-Weber on the hybrid Titan supercomputer. We compare performance of the 3-body model to the SPC/E water model when using accelerators. Finally, we demonstrate that our approach can attain a speedup of 5.1 with acceleration on Titan for production simulations to study water droplet freezing on a surface.« less

  2. Programed dynamical ordering in self-organization processes of a nanocube: a molecular dynamics study.

    PubMed

    Harada, Ryuhei; Mashiko, Takako; Tachikawa, Masanori; Hiraoka, Shuichi; Shigeta, Yasuteru

    2018-04-04

    Self-organization processes of a gear-shaped amphiphile molecule (1) to form a hexameric structure (nanocube, 16) were inferred from sequential dissociation processes by using molecular dynamics (MD) simulations. Our MD study unveiled that programed dynamic ordering exists in the dissociation processes of 16. According to the dissociation processes, it is proposed that triple π-stacking among three 3-pyridyl groups and other weak molecular interactions such as CH-π and van der Waals interactions, some of which arise from the solvophobic effect, were sequentially formed in stable and transient oligomeric states in the self-organization processes, i.e.12, 13, 14, and 15. By subsequent analyses on structural stabilities, it was found that 13 and 14 are stable intermediate oligomers, whereas 12 and 15 are transient ones. Thus, the formation of 13 from three monomers and of 16 from 14 and two monomers via corresponding transients is time consuming in the self-assembly process.

  3. Germacrone derivatives: synthesis, biological activity, molecular docking studies and molecular dynamics simulations.

    PubMed

    Wu, Jie; Feng, Yu; Han, Chao; Huang, Wu; Shen, Zhibin; Yang, Mengdie; Chen, Weiqiang; Ye, Lianbao

    2017-02-28

    Germacrone is one of the major bioactive components in the Curcuma zedoaria oil product, which is extracted from Curcuma zedoaria Roscoe, known as zedoary. The present study designed some novel germacrone derivatives based on combination principles, synthesized these compounds, and investigated their inhibitions on Bel-7402, HepG2, A549 and HeLa cells. Meanwhile, the study evaluated inhibitions of these derivatives on c-Met kinase, which has been detected in a number of cancers. The results suggested that the majority of the compounds showed stronger inhibitory effect on cancers and c-Met kinase than germacrone. Furthermore, our docking experiments analyzed the results and explained the molecular mechanism. Molecular dynamics simulations were then applied to perform further evaluation of the binding stabilities between compounds and their receptors.

  4. ORAC: a molecular dynamics simulation program to explore free energy surfaces in biomolecular systems at the atomistic level.

    PubMed

    Marsili, Simone; Signorini, Giorgio Federico; Chelli, Riccardo; Marchi, Massimo; Procacci, Piero

    2010-04-15

    We present the new release of the ORAC engine (Procacci et al., Comput Chem 1997, 18, 1834), a FORTRAN suite to simulate complex biosystems at the atomistic level. The previous release of the ORAC code included multiple time steps integration, smooth particle mesh Ewald method, constant pressure and constant temperature simulations. The present release has been supplemented with the most advanced techniques for enhanced sampling in atomistic systems including replica exchange with solute tempering, metadynamics and steered molecular dynamics. All these computational technologies have been implemented for parallel architectures using the standard MPI communication protocol. ORAC is an open-source program distributed free of charge under the GNU general public license (GPL) at http://www.chim.unifi.it/orac. 2009 Wiley Periodicals, Inc.

  5. LIBVERSIONINGCOMPILER: An easy-to-use library for dynamic generation and invocation of multiple code versions

    NASA Astrophysics Data System (ADS)

    Cherubin, S.; Agosta, G.

    2018-01-01

    We present LIBVERSIONINGCOMPILER, a C++ library designed to support the dynamic generation of multiple versions of the same compute kernel in a HPC scenario. It can be used to provide continuous optimization, code specialization based on the input data or on workload changes, or otherwise to dynamically adjust the application, without the burden of a full dynamic compiler. The library supports multiple underlying compilers but specifically targets the LLVM framework. We also provide examples of use, showing the overhead of the library, and providing guidelines for its efficient use.

  6. Study of the dynamics of poly(ethylene oxide) by combining molecular dynamic simulations and neutron scattering experiments

    NASA Astrophysics Data System (ADS)

    Brodeck, M.; Alvarez, F.; Arbe, A.; Juranyi, F.; Unruh, T.; Holderer, O.; Colmenero, J.; Richter, D.

    2009-03-01

    We performed quasielastic neutron scattering experiments and atomistic molecular dynamics simulations on a poly(ethylene oxide) (PEO) homopolymer system above the melting point. The excellent agreement found between both sets of data, together with a successful comparison with literature diffraction results, validates the condensed-phase optimized molecular potentials for atomistic simulation studies (COMPASS) force field used to produce our dynamic runs and gives support to their further analysis. This provided direct information on magnitudes which are not accessible from experiments such as the radial probability distribution functions of specific atoms at different times and their moments. The results of our simulations on the H-motions and different experiments indicate that in the high-temperature range investigated the dynamics is Rouse-like for Q-values below ≈0.6 Å-1. We then addressed the single chain dynamic structure factor with the simulations. A mode analysis, not possible directly experimentally, reveals the limits of applicability of the Rouse model to PEO. We discuss the possible origins for the observed deviations.

  7. Study of the dynamics of poly(ethylene oxide) by combining molecular dynamic simulations and neutron scattering experiments.

    PubMed

    Brodeck, M; Alvarez, F; Arbe, A; Juranyi, F; Unruh, T; Holderer, O; Colmenero, J; Richter, D

    2009-03-07

    We performed quasielastic neutron scattering experiments and atomistic molecular dynamics simulations on a poly(ethylene oxide) (PEO) homopolymer system above the melting point. The excellent agreement found between both sets of data, together with a successful comparison with literature diffraction results, validates the condensed-phase optimized molecular potentials for atomistic simulation studies (COMPASS) force field used to produce our dynamic runs and gives support to their further analysis. This provided direct information on magnitudes which are not accessible from experiments such as the radial probability distribution functions of specific atoms at different times and their moments. The results of our simulations on the H-motions and different experiments indicate that in the high-temperature range investigated the dynamics is Rouse-like for Q-values below approximately 0.6 A(-1). We then addressed the single chain dynamic structure factor with the simulations. A mode analysis, not possible directly experimentally, reveals the limits of applicability of the Rouse model to PEO. We discuss the possible origins for the observed deviations.

  8. Machine learning molecular dynamics for the simulation of infrared spectra.

    PubMed

    Gastegger, Michael; Behler, Jörg; Marquetand, Philipp

    2017-10-01

    Machine learning has emerged as an invaluable tool in many research areas. In the present work, we harness this power to predict highly accurate molecular infrared spectra with unprecedented computational efficiency. To account for vibrational anharmonic and dynamical effects - typically neglected by conventional quantum chemistry approaches - we base our machine learning strategy on ab initio molecular dynamics simulations. While these simulations are usually extremely time consuming even for small molecules, we overcome these limitations by leveraging the power of a variety of machine learning techniques, not only accelerating simulations by several orders of magnitude, but also greatly extending the size of systems that can be treated. To this end, we develop a molecular dipole moment model based on environment dependent neural network charges and combine it with the neural network potential approach of Behler and Parrinello. Contrary to the prevalent big data philosophy, we are able to obtain very accurate machine learning models for the prediction of infrared spectra based on only a few hundreds of electronic structure reference points. This is made possible through the use of molecular forces during neural network potential training and the introduction of a fully automated sampling scheme. We demonstrate the power of our machine learning approach by applying it to model the infrared spectra of a methanol molecule, n -alkanes containing up to 200 atoms and the protonated alanine tripeptide, which at the same time represents the first application of machine learning techniques to simulate the dynamics of a peptide. In all of these case studies we find an excellent agreement between the infrared spectra predicted via machine learning models and the respective theoretical and experimental spectra.

  9. Ab initio molecular dynamics of the reactivity of vitamin C toward hydroxyl and HO₂/O⁻₂ radicals.

    PubMed

    Lespade, Laure

    2017-11-21

    Vitamin C is one of the most abundant exogenous antioxidants in the cell, and it is of the utmost importance to elucidate its mechanism of action against radicals. In this study, the reactivity of vitamin C toward OH and [Formula: see text] radicals in aqueous medium was analyzed by ab initio molecular dynamics using CPMD code. The simulations led to results similar to those of static studies or experiments for the pair of [Formula: see text] radicals but bring new insights for the reactivity with hydroxyl radical: the reaction takes place before the formation of an adduct and consists of two steps: first an electron is transferred to hydroxyl radical and then the ascorbyl radical loses a proton. Graphical Abstract Reactivity of vitamin C toward hydroxyl and [Formula: see text] radicals.

  10. Synchronization Control for a Class of Discrete-Time Dynamical Networks With Packet Dropouts: A Coding-Decoding-Based Approach.

    PubMed

    Wang, Licheng; Wang, Zidong; Han, Qing-Long; Wei, Guoliang

    2017-09-06

    The synchronization control problem is investigated for a class of discrete-time dynamical networks with packet dropouts via a coding-decoding-based approach. The data is transmitted through digital communication channels and only the sequence of finite coded signals is sent to the controller. A series of mutually independent Bernoulli distributed random variables is utilized to model the packet dropout phenomenon occurring in the transmissions of coded signals. The purpose of the addressed synchronization control problem is to design a suitable coding-decoding procedure for each node, based on which an efficient decoder-based control protocol is developed to guarantee that the closed-loop network achieves the desired synchronization performance. By applying a modified uniform quantization approach and the Kronecker product technique, criteria for ensuring the detectability of the dynamical network are established by means of the size of the coding alphabet, the coding period and the probability information of packet dropouts. Subsequently, by resorting to the input-to-state stability theory, the desired controller parameter is obtained in terms of the solutions to a certain set of inequality constraints which can be solved effectively via available software packages. Finally, two simulation examples are provided to demonstrate the effectiveness of the obtained results.

  11. Void Growth and Coalescence in Dynamic Fracture of FCC and BCC Metals - Molecular Dynamics Study

    NASA Astrophysics Data System (ADS)

    Seppälä, Eira

    2004-03-01

    In dynamic fracture of ductile metals, the state of tension causes the nucleation of voids, typically from inclusions or grain boundary junctions, which grow and ultimately coalesce to form the fracture surface. Significant plastic deformation occurs in the process, including dislocations emitted to accommodate the growing voids. We have studied at the atomistic scale growth and coalescence processes of voids with concomitant dislocation formation. Classical molecular dynamics (MD) simulations of one and two pre-existing spherical voids initially a few nanometers in radius have been performed in single-crystal face-centered-cubic (FCC) and body-centered-cubic (BCC) lattices under dilational strain with high strain-rates. Million atom simulations of single void growth have been done to study the effect of stress triaxiality,^1 along with strain rate and lattice-structure dependence. An interesting prolate-to-oblate transition in the void shape in uniaxial expansion has been observed and quantitatively analyzed. The simulations also confirm that the plastic strain results directly from the void growth. Interaction and coalescence between two voids have been studied utilizing a parallel MD code in a seven million atom system. In particular, the movement of centers of the voids, linking of the voids, and the shape changes in vicinity of the other void are studied. Also the critical intervoid ligament distance after which the voids can be treated independently has been searched. ^1 E. T. Seppälä, J. Belak, and R. E. Rudd, cond-mat/0310541, submitted to Phys. Rev. B. Acknowledgment: This work was done in collaboration with Dr. James Belak and Dr. Robert E. Rudd, LLNL. It was performed under the auspices of the US Dept. of Energy at the Univ. of Cal./Lawrence Livermore National Laboratory under contract no. W-7405-Eng-48.

  12. Viscoelastic properties of dendrimers in the melt from nonequlibrium molecular dynamics

    NASA Astrophysics Data System (ADS)

    Bosko, Jaroslaw T.; Todd, B. D.; Sadus, Richard J.

    2004-12-01

    The viscoelastic properties of dendrimers of generation 1-4 are studied using nonequilibrium molecular dynamics. Flow properties of dendrimer melts under shear are compared to systems composed of linear chain polymers of the same molecular weight, and the influence of molecular architecture is discussed. Rheological material properties, such as the shear viscosity and normal stress coefficients, are calculated and compared for both systems. We also calculate and compare the microscopic properties of both linear chain and dendrimer molecules, such as their molecular alignment, order parameters and rotational velocities. We find that the highly symmetric shape of dendrimers and their highly constrained geometry allows for substantial differences in their material properties compared to traditional linear polymers of equivalent molecular weight.

  13. Temperature specification in atomistic molecular dynamics and its impact on simulation efficacy

    NASA Astrophysics Data System (ADS)

    Ocaya, R. O.; Terblans, J. J.

    2017-10-01

    Temperature is a vital thermodynamical function for physical systems. Knowledge of system temperature permits assessment of system ergodicity, entropy, system state and stability. Rapid theoretical and computational developments in the fields of condensed matter physics, chemistry, material science, molecular biology, nanotechnology and others necessitate clarity in the temperature specification. Temperature-based materials simulations, both standalone and distributed computing, are projected to grow in prominence over diverse research fields. In this article we discuss the apparent variability of temperature modeling formalisms used currently in atomistic molecular dynamics simulations, with respect to system energetics,dynamics and structural evolution. Commercial simulation programs, which by nature are heuristic, do not openly discuss this fundamental question. We address temperature specification in the context of atomistic molecular dynamics. We define a thermostat at 400K relative to a heat bath at 300K firstly using a modified ab-initio Newtonian method, and secondly using a Monte-Carlo method. The thermostatic vacancy formation and cohesion energies, equilibrium lattice constant for FCC copper is then calculated. Finally we compare and contrast the results.

  14. High-resolution reversible folding of hyperstable RNA tetraloops using molecular dynamics simulations

    PubMed Central

    Chen, Alan A.; García, Angel E.

    2013-01-01

    We report the de novo folding of three hyperstable RNA tetraloops to 1–3 Å rmsd from their experimentally determined structures using molecular dynamics simulations initialized in the unfolded state. RNA tetraloops with loop sequences UUCG, GCAA, or CUUG are hyperstable because of the formation of noncanonical loop-stabilizing interactions, and they are all faithfully reproduced to angstrom-level accuracy in replica exchange molecular dynamics simulations, including explicit solvent and ion molecules. This accuracy is accomplished using unique RNA parameters, in which biases that favor rigid, highly stacked conformations are corrected to accurately capture the inherent flexibility of ssRNA loops, accurate base stacking energetics, and purine syn-anti interconversions. In a departure from traditional quantum chemistrycentric approaches to force field optimization, our parameters are calibrated directly from thermodynamic and kinetic measurements of intra- and internucleotide structural transitions. The ability to recapitulate the signature noncanonical interactions of the three most abundant hyperstable stem loop motifs represents a significant milestone to the accurate prediction of RNA tertiary structure using unbiased all-atom molecular dynamics simulations. PMID:24043821

  15. Molecular dynamics studies on the buffalo prion protein.

    PubMed

    Zhang, Jiapu; Wang, Feng; Chatterjee, Subhojyoti

    2016-01-01

    It was reported that buffalo is a low susceptibility species resisting to transmissible spongiform encephalopathies (TSEs) (same as rabbits, horses, and dogs). TSEs, also called prion diseases, are invariably fatal and highly infectious neurodegenerative diseases that affect a wide variety of species (except for rabbits, dogs, horses, and buffalo), manifesting as scrapie in sheep and goats; bovine spongiform encephalopathy (BSE or "mad-cow" disease) in cattle; chronic wasting disease in deer and elk; and Creutzfeldt-Jakob diseases, Gerstmann-Sträussler-Scheinker syndrome, fatal familial insomnia, and Kulu in humans etc. In molecular structures, these neurodegenerative diseases are caused by the conversion from a soluble normal cellular prion protein (PrP(C)), predominantly with α-helices, into insoluble abnormally folded infectious prions (PrP(Sc)), rich in β-sheets. In this article, we studied the molecular structure and structural dynamics of buffalo PrP(C) (BufPrP(C)), in order to understand the reason why buffalo is resistant to prion diseases. We first did molecular modeling of a homology structure constructed by one mutation at residue 143 from the NMR structure of bovine and cattle PrP(124-227); immediately we found that for BufPrP(C)(124-227), there are five hydrogen bonds (HBs) at Asn143, but at this position, bovine/cattle do not have such HBs. Same as that of rabbits, dogs, or horses, our molecular dynamics studies also revealed there is a strong salt bridge (SB) ASP178-ARG164 (O-N) keeping the β2-α2 loop linked in buffalo. We also found there is a very strong HB SER170-TYR218 linking this loop with the C-terminal end of α-helix H3. Other information, such as (i) there is a very strong SB HIS187-ARG156 (N-O) linking α-helices H2 and H1 (if mutation H187R is made at position 187, then the hydrophobic core of PrP(C) will be exposed (L.H. Zhong (2010). Exposure of hydrophobic core in human prion protein pathogenic mutant H187R. Journal of

  16. Code Samples Used for Complexity and Control

    NASA Astrophysics Data System (ADS)

    Ivancevic, Vladimir G.; Reid, Darryn J.

    2015-11-01

    The following sections are included: * MathematicaⓇ Code * Generic Chaotic Simulator * Vector Differential Operators * NLS Explorer * 2C++ Code * C++ Lambda Functions for Real Calculus * Accelerometer Data Processor * Simple Predictor-Corrector Integrator * Solving the BVP with the Shooting Method * Linear Hyperbolic PDE Solver * Linear Elliptic PDE Solver * Method of Lines for a Set of the NLS Equations * C# Code * Iterative Equation Solver * Simulated Annealing: A Function Minimum * Simple Nonlinear Dynamics * Nonlinear Pendulum Simulator * Lagrangian Dynamics Simulator * Complex-Valued Crowd Attractor Dynamics * Freeform Fortran Code * Lorenz Attractor Simulator * Complex Lorenz Attractor * Simple SGE Soliton * Complex Signal Presentation * Gaussian Wave Packet * Hermitian Matrices * Euclidean L2-Norm * Vector/Matrix Operations * Plain C-Code: Levenberg-Marquardt Optimizer * Free Basic Code: 2D Crowd Dynamics with 3000 Agents

  17. GPU-enabled molecular dynamics simulations of ankyrin kinase complex

    NASA Astrophysics Data System (ADS)

    Gautam, Vertika; Chong, Wei Lim; Wisitponchai, Tanchanok; Nimmanpipug, Piyarat; Zain, Sharifuddin M.; Rahman, Noorsaadah Abd.; Tayapiwatana, Chatchai; Lee, Vannajan Sanghiran

    2014-10-01

    The ankyrin repeat (AR) protein can be used as a versatile scaffold for protein-protein interactions. It has been found that the heterotrimeric complex between integrin-linked kinase (ILK), PINCH, and parvin is an essential signaling platform, serving as a convergence point for integrin and growth-factor signaling and regulating cell adhesion, spreading, and migration. Using ILK-AR with high affinity for the PINCH1 as our model system, we explored a structure-based computational protocol to probe and characterize binding affinity hot spots at protein-protein interfaces. In this study, the long time scale dynamics simulations with GPU accelerated molecular dynamics (MD) simulations in AMBER12 have been performed to locate the hot spots of protein-protein interaction by the analysis of the Molecular Mechanics-Poisson-Boltzmann Surface Area/Generalized Born Solvent Area (MM-PBSA/GBSA) of the MD trajectories. Our calculations suggest good binding affinity of the complex and also the residues critical in the binding.

  18. Molecular Dynamics Approach in Designing Thermostable Aspergillus niger Xylanase

    NASA Astrophysics Data System (ADS)

    Malau, N. D.; Sianturi, M.

    2017-03-01

    Molecular dynamics methods we have applied as a tool in designing thermostable Aspergillus niger Xylanase, by examining Root Mean Square Deviation (RMSD) and The Stability of the Secondary Structure of enzymes structure at its optimum temperature and compare with its high temperature behavior. As RMSD represents structural fluctuation at a particular temperature, a better understanding of this factor will suggest approaches to bioengineer these enzymes to enhance their thermostability. In this work molecular dynamic simulations of Aspergillus niger xylanase (ANX) have been carried at 400K (optimum catalytic temperature) for 2.5 ns and 500K (ANX reported inactive temperature) for 2.5 ns. Analysis have shown that the Root Mean Square Deviation (RMSD) significant increase at higher temperatures compared at optimum temperature and some of the secondary structures of ANX that have been damaged at high temperature. Structural analysis revealed that the fluctuations of the α-helix and β-sheet regions are larger at higher temperatures compared to the fluctuations at optimum temperature.

  19. Wetting of crystalline polymer surfaces: A molecular dynamics simulation

    NASA Astrophysics Data System (ADS)

    Fan, Cun Feng; Caǧin, Tahir

    1995-11-01

    Molecular dynamics has been used to study the wetting of model polymer surfaces, the crystal surfaces of polyethylene (PE), poly(tetrafluoroethylene) (PTFE), and poly(ethylene terephthalate) (PET) by water and methylene iodide. In the simulation a liquid droplet is placed on a model surface and constant temperature, rigid body molecular dynamics is carried out while the model surface is kept fixed. A generally defined microscopic contact angle between a liquid droplet and a solid surface is quantitatively calculated from the volume of the droplet and the interfacial area between the droplet and the surface. The simulation results agree with the trend in experimental data for both water and methylene iodide. The shape of the droplets on the surface is analyzed and no obvious anisotropy of the droplets is seen in the surface plane, even though the crystal surfaces are highly oriented. The surface free energies of the model polymer surfaces are estimated from their contact angles with the two different liquid droplets.

  20. Modification of the SAS4A Safety Analysis Code for Integration with the ADAPT Discrete Dynamic Event Tree Framework.

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Jankovsky, Zachary Kyle; Denman, Matthew R.

    It is difficult to assess the consequences of a transient in a sodium-cooled fast reactor (SFR) using traditional probabilistic risk assessment (PRA) methods, as numerous safety-related sys- tems have passive characteristics. Often there is significant dependence on the value of con- tinuous stochastic parameters rather than binary success/failure determinations. One form of dynamic PRA uses a system simulator to represent the progression of a transient, tracking events through time in a discrete dynamic event tree (DDET). In order to function in a DDET environment, a simulator must have characteristics that make it amenable to changing physical parameters midway through themore » analysis. The SAS4A SFR system analysis code did not have these characteristics as received. This report describes the code modifications made to allow dynamic operation as well as the linking to a Sandia DDET driver code. A test case is briefly described to demonstrate the utility of the changes.« less

  1. Exploring warm dense matter using quantum molecular dynamics

    NASA Astrophysics Data System (ADS)

    Clérouin, J.; Mazevet, S.

    2006-06-01

    For dense plasmas produced in shock experiments, the influence of the media on the isolated atomic properties can no longer be treated as a perturbation and conventional atomic physics approaches usually fail. Recently, quantum molecular dynamics (QMD) has been used to successfully predict static, dynamical and optical properties in this regime within the framework of a first principle method. In this short report, we illustrate the usefulness of the method for dense plasmas with a few selected examples: the equation of state of liquid deuterium, the electrical properties of expanded metals, the optical properties of shocked insulators, and the interaction of femto-second lasers with gold thin films.

  2. Dynamical beam manipulation based on 2-bit digitally-controlled coding metasurface.

    PubMed

    Huang, Cheng; Sun, Bo; Pan, Wenbo; Cui, Jianhua; Wu, Xiaoyu; Luo, Xiangang

    2017-02-08

    Recently, a concept of digital metamaterials has been proposed to manipulate field distribution through proper spatial mixtures of digital metamaterial bits. Here, we present a design of 2-bit digitally-controlled coding metasurface that can effectively modulate the scattered electromagnetic wave and realize different far-field beams. Each meta-atom of this metasurface integrates two pin diodes, and by tuning their operating states, the metasurface has four phase responses of 0, π/2, π, and 3π/2, corresponding to four basic digital elements "00", "01", "10", and "11", respectively. By designing the coding sequence of the above digital element array, the reflected beam can be arbitrarily controlled. The proposed 2-bit digital metasurface has been demonstrated to possess capability of achieving beam deflection, multi-beam and beam diffusion, and the dynamical switching of these different scattering patterns is completed by a programmable electric source.

  3. On the molecular dynamics in the hurricane interactions with its environment

    NASA Astrophysics Data System (ADS)

    Meyer, Gabriel; Vitiello, Giuseppe

    2018-06-01

    By resorting to the Burgers model for hurricanes, we study the molecular motion involved in the hurricane dynamics. We show that the Lagrangian canonical formalism requires the inclusion of the environment degrees of freedom. This also allows the description of the motion of charged particles. In view of the role played by moist convection, cumulus and cloud water droplets in the hurricane dynamics, we discuss on the basis of symmetry considerations the role played by the molecular electrical dipoles and the formation of topologically non-trivial structures. The mechanism of energy storage and dissipation, the non-stationary time dependent Ginzburg-Landau equation and the vortex equation are studied. Finally, we discuss the fractal self-similarity properties of hurricanes.

  4. 369 TFlop/s molecular dynamics simulations on the Roadrunner general-purpose heterogeneous supercomputer

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Swaminarayan, Sriram; Germann, Timothy C; Kadau, Kai

    2008-01-01

    The authors present timing and performance numbers for a short-range parallel molecular dynamics (MD) code, SPaSM, that has been rewritten for the heterogeneous Roadrunner supercomputer. Each Roadrunner compute node consists of two AMD Opteron dual-core microprocessors and four PowerXCell 8i enhanced Cell microprocessors, so that there are four MPI ranks per node, each with one Opteron and one Cell. The interatomic forces are computed on the Cells (each with one PPU and eight SPU cores), while the Opterons are used to direct inter-rank communication and perform I/O-heavy periodic analysis, visualization, and checkpointing tasks. The performance measured for our initial implementationmore » of a standard Lennard-Jones pair potential benchmark reached a peak of 369 Tflop/s double-precision floating-point performance on the full Roadrunner system (27.7% of peak), corresponding to 124 MFlop/Watt/s at a price of approximately 3.69 MFlops/dollar. They demonstrate an initial target application, the jetting and ejection of material from a shocked surface.« less

  5. Exploring Protein-Peptide Recognition Pathways Using a Supervised Molecular Dynamics Approach.

    PubMed

    Salmaso, Veronica; Sturlese, Mattia; Cuzzolin, Alberto; Moro, Stefano

    2017-04-04

    Peptides have gained increased interest as therapeutic agents during recent years. The high specificity and relatively low toxicity of peptide drugs derive from their extremely tight binding to their targets. Indeed, understanding the molecular mechanism of protein-peptide recognition has important implications in the fields of biology, medicine, and pharmaceutical sciences. Even if crystallography and nuclear magnetic resonance are offering valuable atomic insights into the assembling of the protein-peptide complexes, the mechanism of their recognition and binding events remains largely unclear. In this work we report, for the first time, the use of a supervised molecular dynamics approach to explore the possible protein-peptide binding pathways within a timescale reduced up to three orders of magnitude compared with classical molecular dynamics. The better and faster understating of the protein-peptide recognition pathways could be very beneficial in enlarging the applicability of peptide-based drug design approaches in several biotechnological and pharmaceutical fields. Copyright © 2017 Elsevier Ltd. All rights reserved.

  6. Internal Coordinate Molecular Dynamics: A Foundation for Multiscale Dynamics

    PubMed Central

    2015-01-01

    Internal coordinates such as bond lengths, bond angles, and torsion angles (BAT) are natural coordinates for describing a bonded molecular system. However, the molecular dynamics (MD) simulation methods that are widely used for proteins, DNA, and polymers are based on Cartesian coordinates owing to the mathematical simplicity of the equations of motion. However, constraints are often needed with Cartesian MD simulations to enhance the conformational sampling. This makes the equations of motion in the Cartesian coordinates differential-algebraic, which adversely impacts the complexity and the robustness of the simulations. On the other hand, constraints can be easily placed in BAT coordinates by removing the degrees of freedom that need to be constrained. Thus, the internal coordinate MD (ICMD) offers an attractive alternative to Cartesian coordinate MD for developing multiscale MD method. The torsional MD method is a special adaptation of the ICMD method, where all the bond lengths and bond angles are kept rigid. The advantages of ICMD simulation methods are the longer time step size afforded by freezing high frequency degrees of freedom and performing a conformational search in the more important low frequency torsional degrees of freedom. However, the advancements in the ICMD simulations have been slow and stifled by long-standing mathematical bottlenecks. In this review, we summarize the recent mathematical advancements we have made based on spatial operator algebra, in developing a robust long time scale ICMD simulation toolkit useful for various applications. We also present the applications of ICMD simulations to study conformational changes in proteins and protein structure refinement. We review the advantages of the ICMD simulations over the Cartesian simulations when used with enhanced sampling methods and project the future use of ICMD simulations in protein dynamics. PMID:25517406

  7. Non-adiabatic molecular dynamics by accelerated semiclassical Monte Carlo

    DOE PAGES

    White, Alexander J.; Gorshkov, Vyacheslav N.; Tretiak, Sergei; ...

    2015-07-07

    Non-adiabatic dynamics, where systems non-radiatively transition between electronic states, plays a crucial role in many photo-physical processes, such as fluorescence, phosphorescence, and photoisomerization. Methods for the simulation of non-adiabatic dynamics are typically either numerically impractical, highly complex, or based on approximations which can result in failure for even simple systems. Recently, the Semiclassical Monte Carlo (SCMC) approach was developed in an attempt to combine the accuracy of rigorous semiclassical methods with the efficiency and simplicity of widely used surface hopping methods. However, while SCMC was found to be more efficient than other semiclassical methods, it is not yet as efficientmore » as is needed to be used for large molecular systems. Here, we have developed two new methods: the accelerated-SCMC and the accelerated-SCMC with re-Gaussianization, which reduce the cost of the SCMC algorithm up to two orders of magnitude for certain systems. In many cases shown here, the new procedures are nearly as efficient as the commonly used surface hopping schemes, with little to no loss of accuracy. This implies that these modified SCMC algorithms will be of practical numerical solutions for simulating non-adiabatic dynamics in realistic molecular systems.« less

  8. Molecular dynamics of oligofluorenes: A dielectric spectroscopy investigation

    NASA Astrophysics Data System (ADS)

    Papadopoulos, P.; Floudas, G.; Chi, C.; Wegner, G.

    2004-02-01

    The molecular dynamics were investigated in a series of "defect-free" oligofluorenes up to the polymer by dielectric spectroscopy (DS). The method is very sensitive to the presence of keto "defects" that when incorporated on the backbone give rise to poor optical and electronic properties. Two dielectrically active processes were found (β and α process). The latter process (α) displays strongly temperature dependent relaxation times and temperature- and molecular weight-dependent spectral broadening associated with intramolecular correlations. The glass temperature (Tg) obeys the Fox-Flory equation and the polymer Tg is obtained by DS at 332 K. The effective dipole moment associated with the α process is 0.27±0.03 D.

  9. Coupling all-atom molecular dynamics simulations of ions in water with Brownian dynamics.

    PubMed

    Erban, Radek

    2016-02-01

    Molecular dynamics (MD) simulations of ions (K + , Na + , Ca 2+ and Cl - ) in aqueous solutions are investigated. Water is described using the SPC/E model. A stochastic coarse-grained description for ion behaviour is presented and parametrized using MD simulations. It is given as a system of coupled stochastic and ordinary differential equations, describing the ion position, velocity and acceleration. The stochastic coarse-grained model provides an intermediate description between all-atom MD simulations and Brownian dynamics (BD) models. It is used to develop a multiscale method which uses all-atom MD simulations in parts of the computational domain and (less detailed) BD simulations in the remainder of the domain.

  10. Analysis of nanoscale two-phase flow of argon using molecular dynamics

    NASA Astrophysics Data System (ADS)

    Verma, Abhishek Kumar; Kumar, Rakesh

    2014-12-01

    Two phase flows through micro and nanochannels have attracted a lot of attention because of their immense applicability to many advanced fields such as MEMS/NEMS, electronic cooling, bioengineering etc. In this work, a molecular dynamics simulation method is employed to study the condensation process of superheated argon vapor force driven flow through a nanochannel combining fluid flow and heat transfer. A simple and effective particle insertion method is proposed to model phase change of argon based on non-periodic boundary conditions in the simulation domain. Starting from a crystalline solid wall of channel, the condensation process evolves from a transient unsteady state where we study the influence of different wall temperatures and fluid wall interactions on interfacial and heat transport properties of two phase flows. Subsequently, we analyzed transient temperature, density and velocity fields across the channel and their dependency on varying wall temperature and fluid wall interaction, after a dynamic equilibrium is achieved in phase transition. Quasi-steady nonequilibrium temperature profile, heat flux and interfacial thermal resistance were analyzed. The results demonstrate that the molecular dynamics method, with the proposed particle insertion method, effectively solves unsteady nonequilibrium two phase flows at nanoscale resolutions whose interphase between liquid and vapor phase is typically of the order of a few molecular diameters.

  11. Molecular-dynamics study on characteristics of energy and tangential momentum accommodation coefficients

    NASA Astrophysics Data System (ADS)

    Yamaguchi, Hiroki; Matsuda, Yu; Niimi, Tomohide

    2017-07-01

    Gas-surface interaction is studied by the molecular dynamics method to investigate qualitatively characteristics of accommodation coefficients. A large number of trajectories of gas molecules colliding to and scattering from a surface are statistically analyzed to calculate the energy (thermal) accommodation coefficient (EAC) and the tangential momentum accommodation coefficient (TMAC). Considering experimental measurements of the accommodation coefficients, the incident velocities are stochastically sampled to represent a bulk condition. The accommodation coefficients for noble gases show qualitative coincidence with experimental values. To investigate characteristics of these accommodation coefficients in detail, the gas-surface interaction is parametrically studied by varying the molecular mass of gas, the gas-surface interaction strength, and the molecular size of gas, one by one. EAC increases with increasing every parameter, while TMAC increases with increasing the interaction strength, but decreases with increasing the molecular mass and the molecular size. Thus, contradictory results in experimentally measured TMAC for noble gases could result from the difference between the surface conditions employed in the measurements in the balance among the effective parameters of molecular mass, interaction strength, and molecular size, due to surface roughness and/or adsorbed molecules. The accommodation coefficients for a thermo-fluid dynamics field with a temperature difference between gas and surface and a bulk flow at the same time are also investigated.

  12. Molecular Dynamics Simulations of Laser Powered Carbon Nanotube Gears

    NASA Technical Reports Server (NTRS)

    Srivastava, Deepak; Globus, Al; Han, Jie; Chancellor, Marisa K. (Technical Monitor)

    1997-01-01

    Dynamics of laser powered carbon nanotube gears is investigated by molecular dynamics simulations with Brenner's hydrocarbon potential. We find that when the frequency of the laser electric field is much less than the intrinsic frequency of the carbon nanotube, the tube exhibits an oscillatory pendulam behavior. However, a unidirectional rotation of the gear with oscillating frequency is observed under conditions of resonance between the laser field and intrinsic gear frequencies. The operating conditions for stable rotations of the nanotube gears, powered by laser electric fields are explored, in these simulations.

  13. Exploring Hamiltonian dielectric solvent molecular dynamics

    NASA Astrophysics Data System (ADS)

    Bauer, Sebastian; Tavan, Paul; Mathias, Gerald

    2014-09-01

    Hamiltonian dielectric solvent (HADES) is a recent method [7,25], which enables Hamiltonian molecular dynamics (MD) simulations of peptides and proteins in dielectric continua. Sample simulations of an α-helical decapeptide with and without explicit solvent demonstrate the high efficiency of HADES-MD. Addressing the folding of this peptide by replica exchange MD we study the properties of HADES by comparing melting curves, secondary structure motifs and salt bridges with explicit solvent results. Despite the unoptimized ad hoc parametrization of HADES, calculated reaction field energies correlate well with numerical grid solutions of the dielectric Poisson equation.

  14. How Molecular Size Impacts RMSD Applications in Molecular Dynamics Simulations.

    PubMed

    Sargsyan, Karen; Grauffel, Cédric; Lim, Carmay

    2017-04-11

    The root-mean-square deviation (RMSD) is a similarity measure widely used in analysis of macromolecular structures and dynamics. As increasingly larger macromolecular systems are being studied, dimensionality effects such as the "curse of dimensionality" (a diminishing ability to discriminate pairwise differences between conformations with increasing system size) may exist and significantly impact RMSD-based analyses. For such large bimolecular systems, whether the RMSD or other alternative similarity measures might suffer from this "curse" and lose the ability to discriminate different macromolecular structures had not been explicitly addressed. Here, we show such dimensionality effects for both weighted and nonweighted RMSD schemes. We also provide a mechanism for the emergence of the "curse of dimensionality" for RMSD from the law of large numbers by showing that the conformational distributions from which RMSDs are calculated become increasingly similar as the system size increases. Our findings suggest the use of weighted RMSD schemes for small proteins (less than 200 residues) and nonweighted RMSD for larger proteins when analyzing molecular dynamics trajectories.

  15. In situ structure and dynamics of DNA origami determined through molecular dynamics simulations

    PubMed Central

    Yoo, Jejoong; Aksimentiev, Aleksei

    2013-01-01

    The DNA origami method permits folding of long single-stranded DNA into complex 3D structures with subnanometer precision. Transmission electron microscopy, atomic force microscopy, and recently cryo-EM tomography have been used to characterize the properties of such DNA origami objects, however their microscopic structures and dynamics have remained unknown. Here, we report the results of all-atom molecular dynamics simulations that characterized the structural and mechanical properties of DNA origami objects in unprecedented microscopic detail. When simulated in an aqueous environment, the structures of DNA origami objects depart from their idealized targets as a result of steric, electrostatic, and solvent-mediated forces. Whereas the global structural features of such relaxed conformations conform to the target designs, local deformations are abundant and vary in magnitude along the structures. In contrast to their free-solution conformation, the Holliday junctions in the DNA origami structures adopt a left-handed antiparallel conformation. We find the DNA origami structures undergo considerable temporal fluctuations on both local and global scales. Analysis of such structural fluctuations reveals the local mechanical properties of the DNA origami objects. The lattice type of the structures considerably affects global mechanical properties such as bending rigidity. Our study demonstrates the potential of all-atom molecular dynamics simulations to play a considerable role in future development of the DNA origami field by providing accurate, quantitative assessment of local and global structural and mechanical properties of DNA origami objects. PMID:24277840

  16. In situ structure and dynamics of DNA origami determined through molecular dynamics simulations.

    PubMed

    Yoo, Jejoong; Aksimentiev, Aleksei

    2013-12-10

    The DNA origami method permits folding of long single-stranded DNA into complex 3D structures with subnanometer precision. Transmission electron microscopy, atomic force microscopy, and recently cryo-EM tomography have been used to characterize the properties of such DNA origami objects, however their microscopic structures and dynamics have remained unknown. Here, we report the results of all-atom molecular dynamics simulations that characterized the structural and mechanical properties of DNA origami objects in unprecedented microscopic detail. When simulated in an aqueous environment, the structures of DNA origami objects depart from their idealized targets as a result of steric, electrostatic, and solvent-mediated forces. Whereas the global structural features of such relaxed conformations conform to the target designs, local deformations are abundant and vary in magnitude along the structures. In contrast to their free-solution conformation, the Holliday junctions in the DNA origami structures adopt a left-handed antiparallel conformation. We find the DNA origami structures undergo considerable temporal fluctuations on both local and global scales. Analysis of such structural fluctuations reveals the local mechanical properties of the DNA origami objects. The lattice type of the structures considerably affects global mechanical properties such as bending rigidity. Our study demonstrates the potential of all-atom molecular dynamics simulations to play a considerable role in future development of the DNA origami field by providing accurate, quantitative assessment of local and global structural and mechanical properties of DNA origami objects.

  17. Molecular dynamics simulation of polyacrylamides in potassium montmorillonite clay hydrates

    NASA Astrophysics Data System (ADS)

    Zhang, Junfang; Rivero, Mayela; Choi, S. K.

    2007-02-01

    We present molecular dynamics simulation results for polyacrylamide in potassium montmorillonite clay-aqueous systems. Interlayer molecular structure and dynamics properties are investigated. The number density profile, radial distribution function, root-mean-square deviation (RMSD), mean-square displacement (MSD) and diffusion coefficient are reported. The calculations are conducted in constant NVT ensembles, at T = 300 K and with layer spacing of 40 Å. Our simulation results showed that polyacrylamides had little impact on the structure of interlayer water. Density profiles and radial distribution function indicated that hydration shells were formed. In the presence of polyacrylamides more potassium counterions move close to the clay surface while water molecules move away, indicating that potassium counterions are hydrated to a lesser extent than the system in which no polyacrylamides were added. The diffusion coefficients for potassium and water decreased when polyacrylamides were added.

  18. Molecular dynamics simulations on networks of heparin and collagen.

    PubMed

    Kulke, Martin; Geist, Norman; Friedrichs, Wenke; Langel, Walter

    2017-06-01

    Synthetic scaffolds containing collagen (Type I) are of increasing interest for bone tissue engineering, especially for highly porous biomaterials in combination with glycosaminoglycans. In experiments the integration of heparin during the fibrillogenesis resulted in different types of collagen fibrils, but models for this aggregation on a molecular scale were only tentative. We conducted molecular dynamic simulations investigating the binding of heparin to collagen and the influence of the telopeptides during collagen aggregation. This aims at explaining experimental findings on a molecular level. Novel structures for N- and C-telopeptides were developed with the TIGER2 replica exchange algorithm and dihedral principle component analysis. We present an extended statistical analysis of the mainly electrostatic interaction between heparin and collagen and identify several binding sites. Finally, we propose a molecular mechanism for the influence of glycosaminoglycans on the morphology of collagen fibrils. Proteins 2017; 85:1119-1130. © 2017 Wiley Periodicals, Inc. © 2017 Wiley Periodicals, Inc.

  19. Accelerated sampling by infinite swapping of path integral molecular dynamics with surface hopping

    NASA Astrophysics Data System (ADS)

    Lu, Jianfeng; Zhou, Zhennan

    2018-02-01

    To accelerate the thermal equilibrium sampling of multi-level quantum systems, the infinite swapping limit of a recently proposed multi-level ring polymer representation is investigated. In the infinite swapping limit, the ring polymer evolves according to an averaged Hamiltonian with respect to all possible surface index configurations of the ring polymer and thus connects the surface hopping approach to the mean-field path-integral molecular dynamics. A multiscale integrator for the infinite swapping limit is also proposed to enable efficient sampling based on the limiting dynamics. Numerical results demonstrate the huge improvement of sampling efficiency of the infinite swapping compared with the direct simulation of path-integral molecular dynamics with surface hopping.

  20. Molecular dynamics simulations of a K+ channel blocker: Tc1 toxin from Tityus cambridgei.

    PubMed

    Grottesi, Alessandro; Sansom, Mark S P

    2003-01-30

    Toxins that block voltage-gated potassium (Kv) channels provide a possible template for improved homology models of the Kv pore. In assessing the interactions of Kv channels and their toxins it is important to determine the dynamic flexibility of the toxins. Multiple 10 ns duration molecular dynamics simulations combined with essential dynamics analysis have been used to explore the flexibility of four different Kv channel-blocking toxins. Three toxins (Tc1, AgTx and ChTx) share a common fold. They also share a common pattern of conformational dynamics, as revealed by essential dynamics analysis of the simulation results. This suggests that some aspects of dynamic behaviour are conserved across a single protein fold class. In each of these three toxins, the residue exhibiting minimum flexibility corresponds to a conserved lysine residue that is suggested to interact with the filter domain of the channel. Thus, comparative simulations reveal functionally important conservation of molecular dynamics as well as protein fold across a family of related toxins.

  1. Molecular structures and intramolecular dynamics of pentahalides

    NASA Astrophysics Data System (ADS)

    Ischenko, A. A.

    2017-03-01

    This paper reviews advances of modern gas electron diffraction (GED) method combined with high-resolution spectroscopy and quantum chemical calculations in studies of the impact of intramolecular dynamics in free molecules of pentahalides. Some recently developed approaches to the electron diffraction data interpretation, based on direct incorporation of the adiabatic potential energy surface parameters to the diffraction intensity are described. In this way, complementary data of different experimental and computational methods can be directly combined for solving problems of the molecular structure and its dynamics. The possibility to evaluate some important parameters of the adiabatic potential energy surface - barriers to pseudorotation and saddle point of intermediate configuration from diffraction intensities in solving the inverse GED problem is demonstrated on several examples. With increasing accuracy of the electron diffraction intensities and the development of the theoretical background of electron scattering and data interpretation, it has become possible to investigate complex nuclear dynamics in fluxional systems by the GED method. Results of other research groups are also included in the discussion.

  2. Molecular dynamics and principal components of potassium binding with human telomeric intra-molecular G-quadruplex.

    PubMed

    Wang, Zhiguo; Chen, Ruping; Hou, Ling; Li, Jianfeng; Liu, Jun-Ping

    2015-06-01

    Telomere assumes intra-molecular G-quadruplex that is a significant drug target for inhibiting telomerase maintenance of telomeres in cancer. Metal cations have been recognized as playing important roles in stabilizing G-quadruplex, but their binding processes to human telomeric G-quadruplex remain uncharacterized. To investigate the detailed binding procedures, molecular dynamics simulations were conducted on the hybrid [3 + 1] form-one human telomeric intra-molecular G-quadruplex. We show here that the binding of a potassium ion to a G-tetrad core is mediated by two alternative pathways. Principal component analysis illustrated the dominant concerted motions of G-quadruplex occurred at the loop domains. MM-PBSA calculations revealed that binding was energetically favorable and driven by the electrostatic interactions. The lower binding site was found more constructive favorable for binding. Our data provide useful information on a potassium-mediated stable structure of human telomeric intra-molecular G-quadruplex, implicating in ion disorder associated conformational changes and targeted drug design.

  3. Multiscale simulations of patchy particle systems combining Molecular Dynamics, Path Sampling and Green's Function Reaction Dynamics

    NASA Astrophysics Data System (ADS)

    Bolhuis, Peter

    Important reaction-diffusion processes, such as biochemical networks in living cells, or self-assembling soft matter, span many orders in length and time scales. In these systems, the reactants' spatial dynamics at mesoscopic length and time scales of microns and seconds is coupled to the reactions between the molecules at microscopic length and time scales of nanometers and milliseconds. This wide range of length and time scales makes these systems notoriously difficult to simulate. While mean-field rate equations cannot describe such processes, the mesoscopic Green's Function Reaction Dynamics (GFRD) method enables efficient simulation at the particle level provided the microscopic dynamics can be integrated out. Yet, many processes exhibit non-trivial microscopic dynamics that can qualitatively change the macroscopic behavior, calling for an atomistic, microscopic description. The recently developed multiscale Molecular Dynamics Green's Function Reaction Dynamics (MD-GFRD) approach combines GFRD for simulating the system at the mesocopic scale where particles are far apart, with microscopic Molecular (or Brownian) Dynamics, for simulating the system at the microscopic scale where reactants are in close proximity. The association and dissociation of particles are treated with rare event path sampling techniques. I will illustrate the efficiency of this method for patchy particle systems. Replacing the microscopic regime with a Markov State Model avoids the microscopic regime completely. The MSM is then pre-computed using advanced path-sampling techniques such as multistate transition interface sampling. I illustrate this approach on patchy particle systems that show multiple modes of binding. MD-GFRD is generic, and can be used to efficiently simulate reaction-diffusion systems at the particle level, including the orientational dynamics, opening up the possibility for large-scale simulations of e.g. protein signaling networks.

  4. Molecular origin of limiting shear stress of elastohydrodynamic lubrication oil film studied by molecular dynamics

    NASA Astrophysics Data System (ADS)

    Washizu, Hitoshi; Ohmori, Toshihide; Suzuki, Atsushi

    2017-06-01

    All-atom molecular dynamics simulations of an elastohydrodynamic lubrication oil film are performed to study the effect of pressure. Fluid molecules of n-hexane are confined between two solid plates under a constant normal force of 0.1-8.0 GPa. Traction simulations are performed by applying relative sliding motion to the solid plates. A transition in the traction behavior is observed around 0.5-2.0 GPa, which corresponds to the viscoelastic region to the plastic-elastic region, which are experimentally observed. This phase transition is related to the suppression of the fluctuation in molecular motion.

  5. Polymer Fluid Dynamics: Continuum and Molecular Approaches.

    PubMed

    Bird, R B; Giacomin, A J

    2016-06-07

    To solve problems in polymer fluid dynamics, one needs the equations of continuity, motion, and energy. The last two equations contain the stress tensor and the heat-flux vector for the material. There are two ways to formulate the stress tensor: (a) One can write a continuum expression for the stress tensor in terms of kinematic tensors, or (b) one can select a molecular model that represents the polymer molecule and then develop an expression for the stress tensor from kinetic theory. The advantage of the kinetic theory approach is that one gets information about the relation between the molecular structure of the polymers and the rheological properties. We restrict the discussion primarily to the simplest stress tensor expressions or constitutive equations containing from two to four adjustable parameters, although we do indicate how these formulations may be extended to give more complicated expressions. We also explore how these simplest expressions are recovered as special cases of a more general framework, the Oldroyd 8-constant model. Studying the simplest models allows us to discover which types of empiricisms or molecular models seem to be worth investigating further. We also explore equivalences between continuum and molecular approaches. We restrict the discussion to several types of simple flows, such as shearing flows and extensional flows, which are of greatest importance in industrial operations. Furthermore, if these simple flows cannot be well described by continuum or molecular models, then it is not necessary to lavish time and energy to apply them to more complex flow problems.

  6. DeePMD-kit: A deep learning package for many-body potential energy representation and molecular dynamics

    NASA Astrophysics Data System (ADS)

    Wang, Han; Zhang, Linfeng; Han, Jiequn; E, Weinan

    2018-07-01

    Recent developments in many-body potential energy representation via deep learning have brought new hopes to addressing the accuracy-versus-efficiency dilemma in molecular simulations. Here we describe DeePMD-kit, a package written in Python/C++ that has been designed to minimize the effort required to build deep learning based representation of potential energy and force field and to perform molecular dynamics. Potential applications of DeePMD-kit span from finite molecules to extended systems and from metallic systems to chemically bonded systems. DeePMD-kit is interfaced with TensorFlow, one of the most popular deep learning frameworks, making the training process highly automatic and efficient. On the other end, DeePMD-kit is interfaced with high-performance classical molecular dynamics and quantum (path-integral) molecular dynamics packages, i.e., LAMMPS and the i-PI, respectively. Thus, upon training, the potential energy and force field models can be used to perform efficient molecular simulations for different purposes. As an example of the many potential applications of the package, we use DeePMD-kit to learn the interatomic potential energy and forces of a water model using data obtained from density functional theory. We demonstrate that the resulted molecular dynamics model reproduces accurately the structural information contained in the original model.

  7. Molecular dynamics analysis of transitions between rotational isomers in polymethylene

    NASA Astrophysics Data System (ADS)

    Zúñiga, Ignacio; Bahar, Ivet; Dodge, Robert; Mattice, Wayne L.

    1991-10-01

    Molecular dynamics trajectories have been computed and analyzed for linear chains, with sizes ranging from C10H22 to C100H202, and for cyclic C100H200. All hydrogen atoms are included discretely. All bond lengths, bond angles, and torsion angles are variable. Hazard plots show a tendency, at very short times, for correlations between rotational isomeric transitions at bond i and i±2, in much the same manner as in the Brownian dynamics simulations reported by Helfand and co-workers. This correlation of next nearest neighbor bonds in isolated polyethylene chains is much weaker than the correlation found for next nearest neighbor CH-CH2 bonds in poly(1,4-trans-butadiene) confined to the channel formed by crystalline perhydrotriphenylene [Dodge and Mattice, Macromolecules 24, 2709 (1991)]. Less than half of the rotational isomeric transitions observed in the entire trajectory for C50H102 can be described as strongly coupled next nearest neighbor transitions. If correlated motions are identified with successive transitions, which occur within a time interval of Δt≤1 ps, only 18% of the transitions occur through cooperative motion of bonds i and i±2. An analysis of the entire data set of 2482 rotational isomeric state transitions, observed in a 3.7 ns trajectory for C50H102 at 400 K, was performed using a formalism that treats the transitions at different bonds as being independent. On time scales of 0.1 ns or longer, the analysis based on independent bonds accounts reasonably well for the results from the molecular dynamics simulations. At shorter times the molecular dynamics simulation reveals a higher mobility than implied by the analysis assuming independent bonds, presumably due to the influence of correlations that are important at shorter times.

  8. The Molecular and Cellular Basis of Taste Coding in the Legs of Drosophila

    PubMed Central

    Ling, Frederick; Dahanukar, Anupama; Weiss, Linnea A.; Kwon, Jae Young

    2014-01-01

    To understand the principles of taste coding, it is necessary to understand the functional organization of the taste organs. Although the labellum of the Drosophila melanogaster head has been described in detail, the tarsal segments of the legs, which collectively contain more taste sensilla than the labellum, have received much less attention. We performed a systematic anatomical, physiological, and molecular analysis of the tarsal sensilla of Drosophila. We construct an anatomical map of all five tarsal segments of each female leg. The taste sensilla of the female foreleg are systematically tested with a panel of 40 diverse compounds, yielding a response matrix of ∼500 sensillum–tastant combinations. Six types of sensilla are characterized. One type was tuned remarkably broadly: it responded to 19 of 27 bitter compounds tested, as well as sugars; another type responded to neither. The midleg is similar but distinct from the foreleg. The response specificities of the tarsal sensilla differ from those of the labellum, as do n-dimensional taste spaces constructed for each organ, enhancing the capacity of the fly to encode and respond to gustatory information. We examined the expression patterns of all 68 gustatory receptors (Grs). A total of 28 Gr–GAL4 drivers are expressed in the legs. We constructed a receptor-to-sensillum map of the legs and a receptor-to-neuron map. Fourteen Gr–GAL4 drivers are expressed uniquely in the bitter-sensing neuron of the sensillum that is tuned exceptionally broadly. Integration of the molecular and physiological maps provides insight into the underlying basis of taste coding. PMID:24849350

  9. Four new topological indices based on the molecular path code.

    PubMed

    Balaban, Alexandru T; Beteringhe, Adrian; Constantinescu, Titus; Filip, Petru A; Ivanciuc, Ovidiu

    2007-01-01

    The sequence of all paths pi of lengths i = 1 to the maximum possible length in a hydrogen-depleted molecular graph (which sequence is also called the molecular path code) contains significant information on the molecular topology, and as such it is a reasonable choice to be selected as the basis of topological indices (TIs). Four new (or five partly new) TIs with progressively improved performance (judged by correctly reflecting branching, centricity, and cyclicity of graphs, ordering of alkanes, and low degeneracy) have been explored. (i) By summing the squares of all numbers in the sequence one obtains Sigmaipi(2), and by dividing this sum by one plus the cyclomatic number, a Quadratic TI is obtained: Q = Sigmaipi(2)/(mu+1). (ii) On summing the Square roots of all numbers in the sequence one obtains Sigmaipi(1/2), and by dividing this sum by one plus the cyclomatic number, the TI denoted by S is obtained: S = Sigmaipi(1/2)/(mu+1). (iii) On dividing terms in this sum by the corresponding topological distances, one obtains the Distance-reduced index D = Sigmai{pi(1/2)/[i(mu+1)]}. Two similar formulas define the next two indices, the first one with no square roots: (iv) distance-Attenuated index: A = Sigmai{pi/[i(mu + 1)]}; and (v) the last TI with two square roots: Path-count index: P = Sigmai{pi(1/2)/[i(1/2)(mu + 1)]}. These five TIs are compared for their degeneracy, ordering of alkanes, and performance in QSPR (for all alkanes with 3-12 carbon atoms and for all possible chemical cyclic or acyclic graphs with 4-6 carbon atoms) in correlations with six physical properties and one chemical property.

  10. Molecular dynamics simulations of biological membranes and membrane proteins using enhanced conformational sampling algorithms.

    PubMed

    Mori, Takaharu; Miyashita, Naoyuki; Im, Wonpil; Feig, Michael; Sugita, Yuji

    2016-07-01

    This paper reviews various enhanced conformational sampling methods and explicit/implicit solvent/membrane models, as well as their recent applications to the exploration of the structure and dynamics of membranes and membrane proteins. Molecular dynamics simulations have become an essential tool to investigate biological problems, and their success relies on proper molecular models together with efficient conformational sampling methods. The implicit representation of solvent/membrane environments is reasonable approximation to the explicit all-atom models, considering the balance between computational cost and simulation accuracy. Implicit models can be easily combined with replica-exchange molecular dynamics methods to explore a wider conformational space of a protein. Other molecular models and enhanced conformational sampling methods are also briefly discussed. As application examples, we introduce recent simulation studies of glycophorin A, phospholamban, amyloid precursor protein, and mixed lipid bilayers and discuss the accuracy and efficiency of each simulation model and method. This article is part of a Special Issue entitled: Membrane Proteins edited by J.C. Gumbart and Sergei Noskov. Copyright © 2016 The Authors. Published by Elsevier B.V. All rights reserved.

  11. Molecular dynamics simulations of biological membranes and membrane proteins using enhanced conformational sampling algorithms☆

    PubMed Central

    Mori, Takaharu; Miyashita, Naoyuki; Im, Wonpil; Feig, Michael; Sugita, Yuji

    2016-01-01

    This paper reviews various enhanced conformational sampling methods and explicit/implicit solvent/membrane models, as well as their recent applications to the exploration of the structure and dynamics of membranes and membrane proteins. Molecular dynamics simulations have become an essential tool to investigate biological problems, and their success relies on proper molecular models together with efficient conformational sampling methods. The implicit representation of solvent/membrane environments is reasonable approximation to the explicit all-atom models, considering the balance between computational cost and simulation accuracy. Implicit models can be easily combined with replica-exchange molecular dynamics methods to explore a wider conformational space of a protein. Other molecular models and enhanced conformational sampling methods are also briefly discussed. As application examples, we introduce recent simulation studies of glycophorin A, phospholamban, amyloid precursor protein, and mixed lipid bilayers and discuss the accuracy and efficiency of each simulation model and method. This article is part of a Special Issue entitled: Membrane Proteins. Guest Editors: J.C. Gumbart and Sergei Noskov. PMID:26766517

  12. Molecular Dynamics Simulations of Shear Induced Transformations in Nitromethane

    NASA Astrophysics Data System (ADS)

    Larentzos, James; Steele, Brad

    2017-06-01

    Recent experiments demonstrate that NM undergoes explosive chemical initiation under compressive shear stress. The atomistic dynamics of the shear response of single-crystalline and bi-crystalline nitromethane (NM) are simulated using molecular dynamics simulations under high pressure conditions to aid in interpreting these experiments. The atomic interactions are described using a recently re-optimized ReaxFF-lg potential trained specifically for NM under pressure. The simulations demonstrate that the NM crystal transforms into a disordered state upon sufficient application of shear stress; its maximum value, shear angle, and atomic-scale dynamics being highly dependent on crystallographic orientation of the applied shear. Shear simulations in bi-crystalline NM show more complex behavior resulting in the appearance of the disordered state at the grain boundary.

  13. Molecular Dynamics Simulations of Shear Induced Transformations in Nitromethane

    NASA Astrophysics Data System (ADS)

    Larentzos, James; Steele, Brad

    Recent experiments demonstrate that NM undergoes explosive chemical initiation under compressive shear stress. The atomistic dynamics of the shear response of single-crystalline and bi-crystalline nitromethane (NM) are simulated using molecular dynamics simulations under high pressure conditions to aid in interpreting these experiments. The atomic interactions are described using a recently re-optimized ReaxFF-lg potential trained specifically for NM under pressure. The simulations demonstrate that the NM crystal transforms into a disordered state upon sufficient application of shear stress; its maximum value, shear angle, and atomic-scale dynamics being highly dependent on crystallographic orientation of the applied shear. Shear simulations in bi-crystalline NM show more complex behavior resulting in the appearance of the disordered state at the grain boundary.

  14. Dynamical beam manipulation based on 2-bit digitally-controlled coding metasurface

    PubMed Central

    Huang, Cheng; Sun, Bo; Pan, Wenbo; Cui, Jianhua; Wu, Xiaoyu; Luo, Xiangang

    2017-01-01

    Recently, a concept of digital metamaterials has been proposed to manipulate field distribution through proper spatial mixtures of digital metamaterial bits. Here, we present a design of 2-bit digitally-controlled coding metasurface that can effectively modulate the scattered electromagnetic wave and realize different far-field beams. Each meta-atom of this metasurface integrates two pin diodes, and by tuning their operating states, the metasurface has four phase responses of 0, π/2, π, and 3π/2, corresponding to four basic digital elements “00”, “01”, “10”, and “11”, respectively. By designing the coding sequence of the above digital element array, the reflected beam can be arbitrarily controlled. The proposed 2-bit digital metasurface has been demonstrated to possess capability of achieving beam deflection, multi-beam and beam diffusion, and the dynamical switching of these different scattering patterns is completed by a programmable electric source. PMID:28176870

  15. Molecular Dynamics and Morphology of High Performance Elastomers and Fibers by Solid State NMR

    DTIC Science & Technology

    2016-06-30

    Distribution Unlimited UU UU UU UU 30-06-2016 1-Sep-2015 31-May-2016 Final Report: Molecular Dynamics and Morphology of High - Performance Elastomers and...non peer-reviewed journals: Final Report: Molecular Dynamics and Morphology of High -Performance Elastomers and Fibers by Solid-State NMR Report Title...Kanbargi 0.50 0.50 1 PERCENT_SUPPORTEDNAME FTE Equivalent: Total Number: Sub Contractors (DD882) Names of Faculty Supported Names of Under Graduate

  16. The ALI-ARMS Code for Modeling Atmospheric non-LTE Molecular Band Emissions: Current Status and Applications

    NASA Technical Reports Server (NTRS)

    Kutepov, A. A.; Feofilov, A. G.; Manuilova, R. O.; Yankovsky, V. A.; Rezac, L.; Pesnell, W. D.; Goldberg, R. A.

    2008-01-01

    The Accelerated Lambda Iteration (ALI) technique was developed in stellar astrophysics at the beginning of 1990s for solving the non-LTE radiative transfer problem in atomic lines and multiplets in stellar atmospheres. It was later successfully applied to modeling the non-LTE emissions and radiative cooling/heating in the vibrational-rotational bands of molecules in planetary atmospheres. Similar to the standard lambda iterations ALI operates with the matrices of minimal dimension. However, it provides higher convergence rate and stability due to removing from the iterating process the photons trapped in the optically thick line cores. In the current ALI-ARMS (ALI for Atmospheric Radiation and Molecular Spectra) code version additional acceleration of calculations is provided by utilizing the opacity distribution function (ODF) approach and "decoupling". The former allows replacing the band branches by single lines of special shape, whereas the latter treats non-linearity caused by strong near-resonant vibration-vibrational level coupling without additional linearizing the statistical equilibrium equations. Latest code application for the non-LTE diagnostics of the molecular band emissions of Earth's and Martian atmospheres as well as for the non-LTE IR cooling/heating calculations are discussed.

  17. Molecular Dynamics Information Improves cis-Peptide-Based Function Annotation of Proteins.

    PubMed

    Das, Sreetama; Bhadra, Pratiti; Ramakumar, Suryanarayanarao; Pal, Debnath

    2017-08-04

    cis-Peptide bonds, whose occurrence in proteins is rare but evolutionarily conserved, are implicated to play an important role in protein function. This has led to their previous use in a homology-independent, fragment-match-based protein function annotation method. However, proteins are not static molecules; dynamics is integral to their activity. This is nicely epitomized by the geometric isomerization of cis-peptide to trans form for molecular activity. Hence we have incorporated both static (cis-peptide) and dynamics information to improve the prediction of protein molecular function. Our results show that cis-peptide information alone cannot detect functional matches in cases where cis-trans isomerization exists but 3D coordinates have been obtained for only the trans isomer or when the cis-peptide bond is incorrectly assigned as trans. On the contrary, use of dynamics information alone includes false-positive matches for cases where fragments with similar secondary structure show similar dynamics, but the proteins do not share a common function. Combining the two methods reduces errors while detecting the true matches, thereby enhancing the utility of our method in function annotation. A combined approach, therefore, opens up new avenues of improving existing automated function annotation methodologies.

  18. Molecular dynamics of bacteriorhodopsin.

    PubMed

    Lupo, J A; Pachter, R

    1997-02-01

    A model of bacteriorhodopsin (bR), with a retinal chromophore attached, has been derived for a molecular dynamics simulation. A method for determining atomic coordinates of several ill-defined strands was developed using a structure prediction algorithm based on a sequential Kalman filter technique. The completed structure was minimized using the GROMOS force field. The structure was then heated to 293 K and run for 500 ps at constant temperature. A comparison with the energy-minimized structure showed a slow increase in the all-atom RMS deviation over the first 200 ps, leveling off to approximately 2.4 A relative to the starting structure. The final structure yielded a backbone-atom RMS deviation from the crystallographic structure of 2.8 A. The residue neighbors of the chromophore atoms were followed as a function of time. The set of persistent near-residue neighbors supports the theory that differences in pKa values control access to the Schiff base proton, rather than formation of a counterion complex.

  19. Reaction Analysis of Shocked Nitromethane using Extended Lagrangian Born-Oppenheimer Molecular Dynamics

    NASA Astrophysics Data System (ADS)

    Perriot, Romain; Kober, Ed; Mniszewski, Sue; Martinez, Enrique; Niklasson, Anders; Yang, Ping; McGrane, Shawn; Cawkwell, Marc

    2017-06-01

    Characterizing the complex, rapid reactions of energetic materials under conditions of high temperatures and pressures presents strong experimental and computational challenges. The recently developed extended Lagrangian Born-Oppenheimer molecular dynamics formalism enables the long-term conservation of the total energy in microcanonical trajectories, and using a density functional tight binding formulation provides good chemical accuracy. We use this combined approach to study the evolution of temperature, pressure, and chemical species in shock-compressed liquid nitromethane over hundreds of picoseconds. The chemical species seen in nitromethane under shock compression are compared with those seen under static high temperature conditions. A reduced-order representation of the complex sequence of chemical reactions that characterize this system has been developed from the molecular dynamics simulations by focusing on classes of chemical reactions rather than specific molecular species. Time-resolved infra-red vibrational spectra were also computed from the molecular trajectories and compared to the chemical analysis. These spectra provide a time history of the species present in the system that can be compared directly with recent experiments at LANL.

  20. A high performance system for molecular dynamics simulation of biomolecules using a special-purpose computer.

    PubMed

    Komeiji, Y; Yokoyama, H; Uebayasi, M; Taiji, M; Fukushige, T; Sugimoto, D; Takata, R; Shimizu, A; Itsukashi, K

    1996-01-01

    GRAPE (GRavity PipE) processors are special purpose computers for simulation of classical particles. The performance of MD-GRAPE, one of the GRAPEs developed for molecular dynamics, was investigated. The effective speed of MD-GRAPE was equivalent to approximately 6 Gflops. The precision of MD-GRAPE was good judging from the acceptable fluctuation of the total energy. Then a software named PEACH (Program for Energetic Analysis of bioCHemical molecules) was developed for molecular dynamics of biomolecules in combination with MD-GRAPE. Molecular dynamics simulation was performed for several protein-solvent systems with different sizes. Simulation of the largest system investigated (27,000 atoms) took only 5 sec/step. Thus, the PEACH-GRAPE system is expected to be useful in accurate and reliable simulation of large biomolecules.

  1. Ensemble Sampling vs. Time Sampling in Molecular Dynamics Simulations of Thermal Conductivity

    DOE PAGES

    Gordiz, Kiarash; Singh, David J.; Henry, Asegun

    2015-01-29

    In this report we compare time sampling and ensemble averaging as two different methods available for phase space sampling. For the comparison, we calculate thermal conductivities of solid argon and silicon structures, using equilibrium molecular dynamics. We introduce two different schemes for the ensemble averaging approach, and show that both can reduce the total simulation time as compared to time averaging. It is also found that velocity rescaling is an efficient mechanism for phase space exploration. Although our methodology is tested using classical molecular dynamics, the ensemble generation approaches may find their greatest utility in computationally expensive simulations such asmore » first principles molecular dynamics. For such simulations, where each time step is costly, time sampling can require long simulation times because each time step must be evaluated sequentially and therefore phase space averaging is achieved through sequential operations. On the other hand, with ensemble averaging, phase space sampling can be achieved through parallel operations, since each ensemble is independent. For this reason, particularly when using massively parallel architectures, ensemble sampling can result in much shorter simulation times and exhibits similar overall computational effort.« less

  2. Structural analysis, molecular docking and molecular dynamics of an edematogenic lectin from Centrolobium microchaete seeds.

    PubMed

    Neco, Antonio Hadson Bastos; Pinto-Junior, Vanir Reis; Araripe, David Alencar; Santiago, Mayara Queiroz; Osterne, Vinicius Jose Silva; Lossio, Claudia Figueiredo; Nobre, Clareane Avelino Simplicio; Oliveira, Messias Vital; Silva, Mayara Torquato Lima; Martins, Maria Gleiciane Queiroz; Cajazeiras, Joao Batista; Marques, Gabriela Fernandes Oliveira; Costa, Diego Rabelo; Nascimento, Kyria Santiago; Assreuy, Ana Maria Sampaio; Cavada, Benildo Sousa

    2018-05-24

    Lectins represent a class of proteins or glycoproteins capable of reversibly binding to carbohydrates. Seed lectins from the Dalbergieae tribe (Leguminosae) have structural variability, carbohydrate specificity, and biological effects, such as inflammation, vasorelaxation and cancer antigen binding. To comprehensively address these factors, the present work aimed to establish and characterize the three-dimensional structure of Centrolobium microchaete lectin (CML) by homology modeling, investigate protein-carbohydrate interactions and evaluate its inflammatory effect on mice. Molecular docking was performed to analyze interactions of the lectin with monosaccharides, disaccharides and N-glycans. Two dimannosides, methyl mannose-1,3-α-D-mannose (MDM) and mannose-1,3-α-D-mannose (M13), were used in molecular dynamics (MD) simulations to study the behavior of the carbohydrate-recognition domain (CRD) over time. Results showed an expanded domain within which hydrophobic interactions with the methyl group in the MDM molecule were established, thus revealing novel interactions for mannose-specific Dalbergieae lectins. To examine its biological activities, CML was purified in a single step by affinity chromatography on Sepharose-mannose matrix. The lectin demonstrated inflammatory response in the paw edema model and stimulated leukocyte migration to the animal peritoneal cavities, an effect elicited by CRD. For the first time, this work reports the molecular dynamics of a lectin from the Dalbergieae tribe. Copyright © 2018 Elsevier B.V. All rights reserved.

  3. Geometric integration in Born-Oppenheimer molecular dynamics.

    PubMed

    Odell, Anders; Delin, Anna; Johansson, Börje; Cawkwell, Marc J; Niklasson, Anders M N

    2011-12-14

    Geometric integration schemes for extended Lagrangian self-consistent Born-Oppenheimer molecular dynamics, including a weak dissipation to remove numerical noise, are developed and analyzed. The extended Lagrangian framework enables the geometric integration of both the nuclear and electronic degrees of freedom. This provides highly efficient simulations that are stable and energy conserving even under incomplete and approximate self-consistent field (SCF) convergence. We investigate three different geometric integration schemes: (1) regular time reversible Verlet, (2) second order optimal symplectic, and (3) third order optimal symplectic. We look at energy conservation, accuracy, and stability as a function of dissipation, integration time step, and SCF convergence. We find that the inclusion of dissipation in the symplectic integration methods gives an efficient damping of numerical noise or perturbations that otherwise may accumulate from finite arithmetics in a perfect reversible dynamics. © 2011 American Institute of Physics

  4. Thermal conductivity of water: Molecular dynamics and generalized hydrodynamics results

    NASA Astrophysics Data System (ADS)

    Bertolini, Davide; Tani, Alessandro

    1997-10-01

    Equilibrium molecular dynamics simulations have been carried out in the microcanonical ensemble at 300 and 255 K on the extended simple point charge (SPC/E) model of water [Berendsen et al., J. Phys. Chem. 91, 6269 (1987)]. In addition to a number of static and dynamic properties, thermal conductivity λ has been calculated via Green-Kubo integration of the heat current time correlation functions (CF's) in the atomic and molecular formalism, at wave number k=0. The calculated values (0.67+/-0.04 W/mK at 300 K and 0.52+/-0.03 W/mK at 255 K) are in good agreement with the experimental data (0.61 W/mK at 300 K and 0.49 W/mK at 255 K). A negative long-time tail of the heat current CF, more apparent at 255 K, is responsible for the anomalous decrease of λ with temperature. An analysis of the dynamical modes contributing to λ has shown that its value is due to two low-frequency exponential-like modes, a faster collisional mode, with positive contribution, and a slower one, which determines the negative long-time tail. A comparison of the molecular and atomic spectra of the heat current CF has suggested that higher-frequency modes should not contribute to λ in this temperature range. Generalized thermal diffusivity DT(k) decreases as a function of k, after an initial minor increase at k=kmin. The k dependence of the generalized thermodynamic properties has been calculated in the atomic and molecular formalisms. The observed differences have been traced back to intramolecular or intermolecular rotational effects and related to the partial structure functions. Finally, from the results we calculated it appears that the SPC/E model gives results in better agreement with experimental data than the transferable intermolecular potential with four points TIP4P water model [Jorgensen et al., J. Chem. Phys. 79, 926 (1983)], with a larger improvement for, e.g., diffusion, viscosities, and dielectric properties and a smaller one for thermal conductivity. The SPC/E model shares

  5. Probing antibody internal dynamics with fluorescence anisotropy and molecular dynamics simulations.

    PubMed

    Kortkhonjia, Ekaterine; Brandman, Relly; Zhou, Joe Zhongxiang; Voelz, Vincent A; Chorny, Ilya; Kabakoff, Bruce; Patapoff, Thomas W; Dill, Ken A; Swartz, Trevor E

    2013-01-01

    The solution dynamics of antibodies are critical to antibody function. We explore the internal solution dynamics of antibody molecules through the combination of time-resolved fluorescence anisotropy experiments on IgG1 with more than two microseconds of all-atom molecular dynamics (MD) simulations in explicit water, an order of magnitude more than in previous simulations. We analyze the correlated motions with a mutual information entropy quantity, and examine state transition rates in a Markov-state model, to give coarse-grained descriptors of the motions. Our MD simulations show that while there are many strongly correlated motions, antibodies are highly flexible, with F(ab) and F(c) domains constantly forming and breaking contacts, both polar and non-polar. We find that salt bridges break and reform, and not always with the same partners. While the MD simulations in explicit water give the right time scales for the motions, the simulated motions are about 3-fold faster than the experiments. Overall, the picture that emerges is that antibodies do not simply fluctuate around a single state of atomic contacts. Rather, in these large molecules, different atoms come in contact during different motions.

  6. Modification of S-Adenosyl-l-Homocysteine as Inhibitor of Nonstructural Protein 5 Methyltransferase Dengue Virus Through Molecular Docking and Molecular Dynamics Simulation

    PubMed Central

    Tambunan, Usman Sumo Friend; Nasution, Mochammad Arfin Fardiansyah; Azhima, Fauziah; Parikesit, Arli Aditya; Toepak, Erwin Prasetya; Idrus, Syarifuddin; Kerami, Djati

    2017-01-01

    Dengue fever is still a major threat worldwide, approximately threatening two-fifths of the world’s population in tropical and subtropical countries. Nonstructural protein 5 (NS5) methyltransferase enzyme plays a vital role in the process of messenger RNA capping of dengue by transferring methyl groups from S-adenosyl-l-methionine to N7 atom of the guanine bases of RNA and the RNA ribose group of 2′OH, resulting in S-adenosyl-l-homocysteine (SAH). The modification of SAH compound was screened using molecular docking and molecular dynamics simulation, along with computational ADME-Tox (absorption, distribution, metabolism, excretion, and toxicity) test. The 2 simulations were performed using Molecular Operating Environment (MOE) 2008.10 software, whereas the ADME-Tox test was performed using various software. The modification of SAH compound was done using several functional groups that possess different polarities and properties, resulting in 3460 ligands to be docked. After conducting docking simulation, we earned 3 best ligands (SAH-M331, SAH-M2696, and SAH-M1356) based on ΔGbinding and molecular interactions, which show better results than the standard ligands. Moreover, the results of molecular dynamics simulation show that the best ligands are still able to maintain the active site residue interaction with the binding site until the end of the simulation. After a series of molecular docking and molecular dynamics simulation were performed, we concluded that SAH-M1356 ligand is the most potential SAH-based compound to inhibit NS5 methyltransferase enzyme for treating dengue fever. PMID:28469408

  7. Molecular dynamics simulation of nonlinear spectroscopies of intermolecular motions in liquid water.

    PubMed

    Yagasaki, Takuma; Saito, Shinji

    2009-09-15

    Water is the most extensively studied of liquids because of both its ubiquity and its anomalous thermodynamic and dynamic properties. The properties of water are dominated by hydrogen bonds and hydrogen bond network rearrangements. Fundamental information on the dynamics of liquid water has been provided by linear infrared (IR), Raman, and neutron-scattering experiments; molecular dynamics simulations have also provided insights. Recently developed higher-order nonlinear spectroscopies open new windows into the study of the hydrogen bond dynamics of liquid water. For example, the vibrational lifetimes of stretches and a bend, intramolecular features of water dynamics, can be accurately measured and are found to be on the femtosecond time scale at room temperature. Higher-order nonlinear spectroscopy is expressed by a multitime correlation function, whereas traditional linear spectroscopy is given by a one-time correlation function. Thus, nonlinear spectroscopy yields more detailed information on the dynamics of condensed media than linear spectroscopy. In this Account, we describe the theoretical background and methods for calculating higher order nonlinear spectroscopy; equilibrium and nonequilibrium molecular dynamics simulations, and a combination of both, are used. We also present the intermolecular dynamics of liquid water revealed by fifth-order two-dimensional (2D) Raman spectroscopy and third-order IR spectroscopy. 2D Raman spectroscopy is sensitive to couplings between modes; the calculated 2D Raman signal of liquid water shows large anharmonicity in the translational motion and strong coupling between the translational and librational motions. Third-order IR spectroscopy makes it possible to examine the time-dependent couplings. The 2D IR spectra and three-pulse photon echo peak shift show the fast frequency modulation of the librational motion. A significant effect of the translational motion on the fast frequency modulation of the librational motion is

  8. Stabilities and Dynamics of Protein Folding Nuclei by Molecular Dynamics Simulation

    NASA Astrophysics Data System (ADS)

    Song, Yong-Shun; Zhou, Xin; Zheng, Wei-Mou; Wang, Yan-Ting

    2017-07-01

    To understand how the stabilities of key nuclei fragments affect protein folding dynamics, we simulate by molecular dynamics (MD) simulation in aqueous solution four fragments cut out of a protein G, including one α-helix (seqB: KVFKQYAN), two β-turns (seqA: LNGKTLKG and seqC: YDDATKTF), and one β-strand (seqD: DGEWTYDD). The Markov State Model clustering method combined with the coarse-grained conformation letters method are employed to analyze the data sampled from 2-μs equilibrium MD simulation trajectories. We find that seqA and seqB have more stable structures than their native structures which become metastable when cut out of the protein structure. As expected, seqD alone is flexible and does not have a stable structure. Throughout our simulations, the native structure of seqC is stable but cannot be reached if starting from a structure other than the native one, implying a funnel-shape free energy landscape of seqC in aqueous solution. All the above results suggest that different nuclei have different formation dynamics during protein folding, which may have a major contribution to the hierarchy of protein folding dynamics. Supported by the National Basic Research Program of China under Grant No. 2013CB932804, the National Natural Science Foundation of China under Grant No. 11421063, and the CAS Biophysics Interdisciplinary Innovation Team Project

  9. Validating clustering of molecular dynamics simulations using polymer models.

    PubMed

    Phillips, Joshua L; Colvin, Michael E; Newsam, Shawn

    2011-11-14

    Molecular dynamics (MD) simulation is a powerful technique for sampling the meta-stable and transitional conformations of proteins and other biomolecules. Computational data clustering has emerged as a useful, automated technique for extracting conformational states from MD simulation data. Despite extensive application, relatively little work has been done to determine if the clustering algorithms are actually extracting useful information. A primary goal of this paper therefore is to provide such an understanding through a detailed analysis of data clustering applied to a series of increasingly complex biopolymer models. We develop a novel series of models using basic polymer theory that have intuitive, clearly-defined dynamics and exhibit the essential properties that we are seeking to identify in MD simulations of real biomolecules. We then apply spectral clustering, an algorithm particularly well-suited for clustering polymer structures, to our models and MD simulations of several intrinsically disordered proteins. Clustering results for the polymer models provide clear evidence that the meta-stable and transitional conformations are detected by the algorithm. The results for the polymer models also help guide the analysis of the disordered protein simulations by comparing and contrasting the statistical properties of the extracted clusters. We have developed a framework for validating the performance and utility of clustering algorithms for studying molecular biopolymer simulations that utilizes several analytic and dynamic polymer models which exhibit well-behaved dynamics including: meta-stable states, transition states, helical structures, and stochastic dynamics. We show that spectral clustering is robust to anomalies introduced by structural alignment and that different structural classes of intrinsically disordered proteins can be reliably discriminated from the clustering results. To our knowledge, our framework is the first to utilize model polymers

  10. Validating clustering of molecular dynamics simulations using polymer models

    PubMed Central

    2011-01-01

    Background Molecular dynamics (MD) simulation is a powerful technique for sampling the meta-stable and transitional conformations of proteins and other biomolecules. Computational data clustering has emerged as a useful, automated technique for extracting conformational states from MD simulation data. Despite extensive application, relatively little work has been done to determine if the clustering algorithms are actually extracting useful information. A primary goal of this paper therefore is to provide such an understanding through a detailed analysis of data clustering applied to a series of increasingly complex biopolymer models. Results We develop a novel series of models using basic polymer theory that have intuitive, clearly-defined dynamics and exhibit the essential properties that we are seeking to identify in MD simulations of real biomolecules. We then apply spectral clustering, an algorithm particularly well-suited for clustering polymer structures, to our models and MD simulations of several intrinsically disordered proteins. Clustering results for the polymer models provide clear evidence that the meta-stable and transitional conformations are detected by the algorithm. The results for the polymer models also help guide the analysis of the disordered protein simulations by comparing and contrasting the statistical properties of the extracted clusters. Conclusions We have developed a framework for validating the performance and utility of clustering algorithms for studying molecular biopolymer simulations that utilizes several analytic and dynamic polymer models which exhibit well-behaved dynamics including: meta-stable states, transition states, helical structures, and stochastic dynamics. We show that spectral clustering is robust to anomalies introduced by structural alignment and that different structural classes of intrinsically disordered proteins can be reliably discriminated from the clustering results. To our knowledge, our framework is the

  11. Characterization of Hydrophobic Interactions of Polymers with Water and Phospholipid Membranes Using Molecular Dynamics Simulations

    NASA Astrophysics Data System (ADS)

    Drenscko, Mihaela

    Polymers and lipid membranes are both essential soft materials. The structure and hydrophobicity/hydrophilicity of polymers, as well as the solvent they are embedded in, ultimately determines their size and shape. Understating the variation of shape of the polymer as well as its interactions with model biological membranes can assist in understanding the biocompatibility of the polymer itself. Computer simulations, in particular molecular dynamics, can aid in characterization of the interaction of polymers with solvent, as well as polymers with model membranes. In this thesis, molecular dynamics serve to describe polymer interactions with a solvent (water) and with a lipid membrane. To begin with, we characterize the hydrophobic collapse of single polystyrene chains in water using molecular dynamics simulations. Specifically, we calculate the potential of mean force for the collapse of a single polystyrene chain in water using metadynamics, comparing the results between all atomistic with coarse-grained molecular simulation. We next explore the scaling behavior of the collapsed globular shape at the minimum energy configuration, characterized by the radius of gyration, as a function of chain length. The exponent is close to one third, consistent with that predicted for a polymer chain in bad solvent. We also explore the scaling behavior of the Solvent Accessible Surface Area (SASA) as a function of chain length, finding a similar exponent for both all-atomistic and coarse-grained simulations. Furthermore, calculation of the local water density as a function of chain length near the minimum energy configuration suggests that intermediate chain lengths are more likely to form dewetted states, as compared to shorter or longer chain lengths. Next, in order to investigate the molecular interactions between single hydrophobic polymer chains and lipids in biological membranes and at lipid membrane/solvent interface, we perform a series of molecular dynamics simulations of

  12. Light curves for bump Cepheids computed with a dynamically zoned pulsation code

    NASA Technical Reports Server (NTRS)

    Adams, T. F.; Castor, J. I.; Davis, C. G.

    1980-01-01

    The dynamically zoned pulsation code developed by Castor, Davis, and Davison was used to recalculate the Goddard model and to calculate three other Cepheid models with the same period (9.8 days). This family of models shows how the bumps and other features of the light and velocity curves change as the mass is varied at constant period. The use of a code that is capable of producing reliable light curves demonstrates that the light and velocity curves for 9.8 day Cepheid models with standard homogeneous compositions do not show bumps like those that are observed unless the mass is significantly lower than the 'evolutionary mass.' The light and velocity curves for the Goddard model presented here are similar to those computed independently by Fischel, Sparks, and Karp. They should be useful as standards for future investigators.

  13. Study on the Characteristics of Gas Molecular Mean Free Path in Nanopores by Molecular Dynamics Simulations

    PubMed Central

    Liu, Qixin; Cai, Zhiyong

    2014-01-01

    This paper presents studies on the characteristics of gas molecular mean free path in nanopores by molecular dynamics simulation. Our study results indicate that the mean free path of all molecules in nanopores depend on both the radius of the nanopore and the gas-solid interaction strength. Besides mean free path of all molecules in the nanopore, this paper highlights the gas molecular mean free path at different positions of the nanopore and the anisotropy of the gas molecular mean free path at nanopores. The molecular mean free path varies with the molecule’s distance from the center of the nanopore. The least value of the mean free path occurs at the wall surface of the nanopore. The present paper found that the gas molecular mean free path is anisotropic when gas is confined in nanopores. The radial gas molecular mean free path is much smaller than the mean free path including all molecular collisions occuring in three directions. Our study results also indicate that when gas is confined in nanopores the gas molecule number density does not affect the gas molecular mean free path in the same way as it does for the gas in unbounded space. These study results may bring new insights into understanding the gas flow’s characteristic at nanoscale. PMID:25046745

  14. Quantum molecular dynamics simulation of shock-wave experiments in aluminum

    NASA Astrophysics Data System (ADS)

    Minakov, D. V.; Levashov, P. R.; Khishchenko, K. V.; Fortov, V. E.

    2014-06-01

    We present quantum molecular dynamics calculations of principal, porous, and double shock Hugoniots, release isentropes, and sound velocity behind the shock front for aluminum. A comprehensive analysis of available shock-wave data is performed; the agreement and discrepancies of simulation results with measurements are discussed. Special attention is paid to the melting region of aluminum along the principal Hugoniot; the boundaries of the melting zone are estimated using the self-diffusion coefficient. Also, we make a comparison with a high-quality multiphase equation of state for aluminum. Independent semiempirical and first-principle models are very close to each other in caloric variables (pressure, density, particle velocity, etc.) but the equation of state gives higher temperature on the principal Hugoniot and release isentropes than ab initio calculations. Thus, the quantum molecular dynamics method can be used for calibration of semiempirical equations of state in case of lack of experimental data.

  15. Application of two dimensional periodic molecular dynamics to interfaces.

    NASA Astrophysics Data System (ADS)

    Gay, David H.; Slater, Ben; Catlow, C. Richard A.

    1997-08-01

    We have applied two-dimensional molecular dynamics to the surface of a crystalline aspartame and the interface between the crystal face and a solvent (water). This has allowed us to look at the dynamic processes at the surface. Understanding the surface structure and properties are important to controlling the crystal morphology. The thermodynamic ensemble was constant Number, surface Area and Temperature (NAT). The calculations have been carried out using a 2D Ewald summation and 2D periodic boundary conditions for the short range potentials. The equations of motion integration has been carried out using the standard velocity Verlet algorithm.

  16. A Series of Molecular Dynamics and Homology Modeling Computer Labs for an Undergraduate Molecular Modeling Course

    ERIC Educational Resources Information Center

    Elmore, Donald E.; Guayasamin, Ryann C.; Kieffer, Madeleine E.

    2010-01-01

    As computational modeling plays an increasingly central role in biochemical research, it is important to provide students with exposure to common modeling methods in their undergraduate curriculum. This article describes a series of computer labs designed to introduce undergraduate students to energy minimization, molecular dynamics simulations,…

  17. Protonation-induced stereoisomerism in nicotine: Conformational studies using classical (AMBER) and ab initio (Car Parrinello) molecular dynamics

    NASA Astrophysics Data System (ADS)

    Hammond, Philip S.; Wu, Yudong; Harris, Rebecca; Minehardt, Todd J.; Car, Roberto; Schmitt, Jeffrey D.

    2005-01-01

    A variety of biologically active small molecules contain prochiral tertiary amines, which become chiral centers upon protonation. S-nicotine, the prototypical nicotinic acetylcholine receptor agonist, produces two diastereomers on protonation. Results, using both classical (AMBER) and ab initio (Car-Parrinello) molecular dynamical studies, illustrate the significant differences in conformational space explored by each diastereomer. As is expected, this phenomenon has an appreciable effect on nicotine's energy hypersurface and leads to differentiation in molecular shape and divergent sampling. Thus, protonation induced isomerism can produce dynamic effects that may influence the behavior of a molecule in its interaction with a target protein. We also examine differences in the conformational dynamics for each diastereomer as quantified by both molecular dynamics methods.

  18. Molecular dynamics simulations of single siloxane dendrimers: Molecular structure and intramolecular mobility of terminal groups

    NASA Astrophysics Data System (ADS)

    Kurbatov, A. O.; Balabaev, N. K.; Mazo, M. A.; Kramarenko, E. Yu.

    2018-01-01

    Molecular dynamics simulations of two types of isolated siloxane dendrimers of various generations (from the 2nd to the 8th) have been performed for temperatures ranging from 150 K to 600 K. The first type of dendrimer molecules has short spacers consisting of a single oxygen atom. In the dendrimers of the second type, spacers are longer and comprised of two oxygen atoms separated by a single silicon atom. A comparative analysis of molecular macroscopic parameters such as the gyration radius and the shape factor as well as atom distributions within dendrimer interior has been performed for varying generation number, temperature, and spacer length. It has been found that the short-spacer dendrimers of the 7th and 8th generations have a stressed central part with elongated bonds and deformed valence angles. Investigation of the time evolution of radial displacements of the terminal Si atoms has shown that a fraction of the Si groups have a reduced mobility. Therefore, rather long time trajectories (of the order of tens of nanoseconds) are required to study dendrimer intramolecular dynamics.

  19. Dynamical heterogeneities of rotational motion in room temperature ionic liquids evidenced by molecular dynamics simulations

    NASA Astrophysics Data System (ADS)

    Usui, Kota; Hunger, Johannes; Bonn, Mischa; Sulpizi, Marialore

    2018-05-01

    Room temperature ionic liquids (RTILs) have been shown to exhibit spatial heterogeneity or structural heterogeneity in the sense that they form hydrophobic and ionic domains. Yet studies of the relationship between this structural heterogeneity and the ˜picosecond motion of the molecular constituents remain limited. In order to obtain insight into the time scales relevant to this structural heterogeneity, we perform molecular dynamics simulations of a series of RTILs. To investigate the relationship between the structures, i.e., the presence of hydrophobic and ionic domains, and the dynamics, we gradually increase the size of the hydrophobic part of the cation from ethylammonium nitrate (EAN), via propylammonium nitrate (PAN), to butylammonium nitrate (BAN). The two ends of the organic cation, namely, the charged Nhead-H group and the hydrophobic Ctail-H group, exhibit rotational dynamics on different time scales, evidencing dynamical heterogeneity. The dynamics of the Nhead-H group is slower because of the strong coulombic interaction with the nitrate counter-ionic anions, while the dynamics of the Ctail-H group is faster because of the weaker van der Waals interaction with the surrounding atoms. In particular, the rotation of the Nhead-H group slows down with increasing cationic chain length, while the rotation of the Ctail-H group shows little dependence on the cationic chain length, manifesting that the dynamical heterogeneity is enhanced with a longer cationic chain. The slowdown of the Nhead-H group with increasing cationic chain length is associated with a lower number of nitrate anions near the Nhead-H group, which presumably results in the increase of the energy barrier for the rotation. The sensitivity of the Nhead-H rotation to the number of surrounding nitrate anions, in conjunction with the varying number of nitrate anions, gives rise to a broad distribution of Nhead-H reorientation times. Our results suggest that the asymmetry of the cations and the

  20. Fiber lubrication: A molecular dynamics simulation study

    NASA Astrophysics Data System (ADS)

    Liu, Hongyi

    Molecular and mesoscopic level description of friction and lubrication remains a challenge because of difficulties in the phenomenological understanding of to the behaviors of solid-liquid interfaces during sliding. Fortunately, there is the computational simulation approach opens an opportunity to predict and analyze interfacial phenomena, which were studied with molecular dynamics (MD) and mesoscopic dynamics (MesoDyn) simulations. Polypropylene (PP) and cellulose are two of most common polymers in textile fibers. Confined amorphous surface layers of PP and cellulose were built successfully with xenon crystals which were used to compact the polymers. The physical and surface properties of the PP and cellulose surface layers were investigated by MD simulations, including the density, cohesive energy, volumetric thermal expansion, and contact angle with water. The topology method was employed to predict the properties of poly(alkylene glycol) (PAG) diblock copolymers and Pluronic triblock copolymers used as lubricants on surfaces. Density, zero shear viscosity, shear module, cohesive energy and solubility parameter were predicted with each block copolymer. Molecular dynamics simulations were used to study the interaction energy per unit contact area of block copolymer melts with PP and cellulose surfaces. The interaction energy is defined as the ratio of interfacial interaction energy to the contact area. Both poly(proplene oxide) (PPO) and poly(ethylene oxide) (PEO) segments provided a lipophilic character to both PP and cellulose surfaces. The PPO/PEO ratio and the molecular weight were found to impact the interaction energy on both PP and cellulose surfaces. In aqueous solutions, the interaction energy is complicated due to the presence of water and the cross interactions between the multiple molecular components. The polymer-water-surface (PWS) calculation method was proposed to calculate such complex systems. In a contrast with a vacuum condition, the presence

  1. Molecular dynamics of liquid crystals

    NASA Astrophysics Data System (ADS)

    Sarman, Sten

    1997-02-01

    We derive Green-Kubo relations for the viscosities of a nematic liquid crystal. The derivation is based on the application of a Gaussian constraint algorithm that makes the director angular velocity of a liquid crystal a constant of motion. Setting this velocity equal to zero means that a director-based coordinate system becomes an inertial frame and that the constraint torques do not do any work on the system. The system consequently remains in equilibrium. However, one generates a different equilibrium ensemble. The great advantage of this ensemble is that the Green-Kubo relations for the viscosities become linear combinations of time correlation function integrals, whereas they are complicated rational functions in the conventional canonical ensemble. This facilitates the numerical evaluation of the viscosities by molecular dynamics simulations.

  2. Molecular dynamics simulations reveal the conformational dynamics of Arabidopsis thaliana BRI1 and BAK1 receptor-like kinases.

    PubMed

    Moffett, Alexander S; Bender, Kyle W; Huber, Steven C; Shukla, Diwakar

    2017-07-28

    The structural motifs responsible for activation and regulation of eukaryotic protein kinases in animals have been studied extensively in recent years, and a coherent picture of their activation mechanisms has begun to emerge. In contrast, non-animal eukaryotic protein kinases are not as well understood from a structural perspective, representing a large knowledge gap. To this end, we investigated the conformational dynamics of two key Arabidopsis thaliana receptor-like kinases, brassinosteroid-insensitive 1 (BRI1) and BRI1-associated kinase 1 (BAK1), through extensive molecular dynamics simulations of their fully phosphorylated kinase domains. Molecular dynamics simulations calculate the motion of each atom in a protein based on classical approximations of interatomic forces, giving researchers insight into protein function at unparalleled spatial and temporal resolutions. We found that in an otherwise "active" BAK1 the αC helix is highly disordered, a hallmark of deactivation, whereas the BRI1 αC helix is moderately disordered and displays swinging behavior similar to numerous animal kinases. An analysis of all known sequences in the A. thaliana kinome found that αC helix disorder may be a common feature of plant kinases. © 2017 by The American Society for Biochemistry and Molecular Biology, Inc.

  3. Surface induced molecular dynamics of thin lipid films confined to submicron cavities: A 1H multiple-quantum NMR study

    NASA Astrophysics Data System (ADS)

    Jagadeesh, B.; Prabhakar, A.; Demco, D. E.; Buda, A.; Blümich, B.

    2005-03-01

    The dynamics and molecular order of thin lipid (lecithin) films confined to 200, 100 and 20 nm cylindrical pores with varying surface coverage, were investigated by 1H multiple-quantum NMR. The results show that the molecular dynamics in the surface controlled layers are less hindered compared to those in the bulk. Dynamic heterogeneity among terminal CH 3 groups is evident. Enhanced dynamic freedom is observed for films with area per molecule, ˜ 128 Å 2. The results are discussed in terms of changes in the lipid molecular organization with respect to surface concentration, its plausible motional modes and dynamic heterogeneity.

  4. Crossed Molecular Beam Studies and Dynamics of Decomposition of Chemically Activated Radicals

    DOE R&D Accomplishments Database

    Lee, Y. T.

    1973-09-01

    The power of the crossed molecular beams method in the investigation of the dynamics of chemical reactions lies mainly in the direct observation of the consequences of single collisions of well controlled reactant molecules. The primary experimental observations which provide information on reaction dynamics are the measurements of angular and velocity distributions of reaction products.

  5. A molecular dynamics approach to barrodiffusion

    NASA Astrophysics Data System (ADS)

    Cooley, James; Marciante, Mathieu; Murillo, Michael

    2016-10-01

    Unexpected phenomena in the reaction rates for Inertial Confinement Fusion (ICF) capsules have led to a renewed interest in the thermo-dynamically driven diffusion process for the past 10 years, often described collectively as barodiffusion. In the current context, barodiffusion would manifest as a process that separates ions of differing mass and charge ratios due to pressure and temperature gradients set-up through shock structures in the capsule core. Barrodiffusion includes additional mass transfer terms that account for the irreversible transport of species due to gradients in the system, both thermodynamic and electric e.g, i = - ρD [ ∇c +kp ∇ln(pi) +kT(i) ∇ln(Ti) +kt(e) ∇ln(Te) +eke/Ti ∇ϕ ] . Several groups have attacked this phenomena using continuum scale models and supplemented with kinetic theory to derive coefficients for the different diffusion terms based on assumptions about the collisional processes. In contrast, we have applied a molecular dynamics (MD) simulation to this system to gain a first-principle understanding of the rate kinetics and to assess the accuracy of the differin

  6. GASFLOW: A Computational Fluid Dynamics Code for Gases, Aerosols, and Combustion, Volume 3: Assessment Manual

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Müller, C.; Hughes, E. D.; Niederauer, G. F.

    1998-10-01

    Los Alamos National Laboratory (LANL) and Forschungszentrum Karlsruhe (FzK) are developing GASFLOW, a three-dimensional (3D) fluid dynamics field code as a best- estimate tool to characterize local phenomena within a flow field. Examples of 3D phenomena include circulation patterns; flow stratification; hydrogen distribution mixing and stratification; combustion and flame propagation; effects of noncondensable gas distribution on local condensation and evaporation; and aerosol entrainment, transport, and deposition. An analysis with GASFLOW will result in a prediction of the gas composition and discrete particle distribution in space and time throughout the facility and the resulting pressure and temperature loadings on the wallsmore » and internal structures with or without combustion. A major application of GASFLOW is for predicting the transport, mixing, and combustion of hydrogen and other gases in nuclear reactor containment and other facilities. It has been applied to situations involving transporting and distributing combustible gas mixtures. It has been used to study gas dynamic behavior in low-speed, buoyancy-driven flows, as well as sonic flows or diffusion dominated flows; and during chemically reacting flows, including deflagrations. The effects of controlling such mixtures by safety systems can be analyzed. The code version described in this manual is designated GASFLOW 2.1, which combines previous versions of the United States Nuclear Regulatory Commission code HMS (for Hydrogen Mixing Studies) and the Department of Energy and FzK versions of GASFLOW. The code was written in standard Fortran 90. This manual comprises three volumes. Volume I describes the governing physical equations and computational model. Volume II describes how to use the code to set up a model geometry, specify gas species and material properties, define initial and boundary conditions, and specify different outputs, especially graphical displays. Sample problems are included

  7. Path integral molecular dynamic simulation of flexible molecular systems in their ground state: Application to the water dimer

    NASA Astrophysics Data System (ADS)

    Schmidt, Matthew; Roy, Pierre-Nicholas

    2018-03-01

    We extend the Langevin equation Path Integral Ground State (LePIGS), a ground state quantum molecular dynamics method, to simulate flexible molecular systems and calculate both energetic and structural properties. We test the approach with the H2O and D2O monomers and dimers. We systematically optimize all simulation parameters and use a unity trial wavefunction. We report ground state energies, dissociation energies, and structural properties using three different water models, two of which are empirically based, q-TIP4P/F and q-SPC/Fw, and one which is ab initio, MB-pol. We demonstrate that our energies calculated from LePIGS can be merged seamlessly with low temperature path integral molecular dynamics calculations and note the similarities between the two methods. We also benchmark our energies against previous diffusion Monte Carlo calculations using the same potentials and compare to experimental results. We further demonstrate that accurate vibrational energies of the H2O and D2O monomer can be calculated from imaginary time correlation functions generated from the LePIGS simulations using solely the unity trial wavefunction.

  8. DynamO: a free O(N) general event-driven molecular dynamics simulator.

    PubMed

    Bannerman, M N; Sargant, R; Lue, L

    2011-11-30

    Molecular dynamics algorithms for systems of particles interacting through discrete or "hard" potentials are fundamentally different to the methods for continuous or "soft" potential systems. Although many software packages have been developed for continuous potential systems, software for discrete potential systems based on event-driven algorithms are relatively scarce and specialized. We present DynamO, a general event-driven simulation package, which displays the optimal O(N) asymptotic scaling of the computational cost with the number of particles N, rather than the O(N) scaling found in most standard algorithms. DynamO provides reference implementations of the best available event-driven algorithms. These techniques allow the rapid simulation of both complex and large (>10(6) particles) systems for long times. The performance of the program is benchmarked for elastic hard sphere systems, homogeneous cooling and sheared inelastic hard spheres, and equilibrium Lennard-Jones fluids. This software and its documentation are distributed under the GNU General Public license and can be freely downloaded from http://marcusbannerman.co.uk/dynamo. Copyright © 2011 Wiley Periodicals, Inc.

  9. Prediction of purification of biopharmeceuticals with molecular dynamics

    NASA Astrophysics Data System (ADS)

    Ustach, Vincent; Faller, Roland

    Purification of biopharmeceuticals remains the most expensive part of protein-based drug production. In ion exchange chromatography (IEX), prediction of the elution ionic strength of host cell and target proteins has the potential to reduce the parameter space for scale-up of protein production. The complex shape and charge distribution of proteins and pores complicates predictions of the interactions in these systems. All-atom molecular dynamics methods are beyond the scope of computational limits for mass transport regimes. We present a coarse-grained model for proteins for prediction of elution pH and ionic strength. By extending the raspberry model for colloid particles to surface shapes and charge distributions of proteins, we can reproduce the behavior of proteins in IEX. The average charge states of titratatable amino acid residues at relevant pH values are determined by extrapolation from all-atom molecular dynamics at pH 7. The pH specific all-atom electrostatic field is then mapped onto the coarse-grained surface beads of the raspberry particle. The hydrodynamics are reproduced with the lattice-Boltzmann scheme. This combination of methods allows very long simulation times. The model is being validated for known elution procedures by comparing the data with experiments. Defense Threat Reduction Agency (Grant Number HDTRA1-15-1-0054).

  10. Attosecond vacuum UV coherent control of molecular dynamics

    PubMed Central

    Ranitovic, Predrag; Hogle, Craig W.; Rivière, Paula; Palacios, Alicia; Tong, Xiao-Ming; Toshima, Nobuyuki; González-Castrillo, Alberto; Martin, Leigh; Martín, Fernando; Murnane, Margaret M.; Kapteyn, Henry

    2014-01-01

    High harmonic light sources make it possible to access attosecond timescales, thus opening up the prospect of manipulating electronic wave packets for steering molecular dynamics. However, two decades after the birth of attosecond physics, the concept of attosecond chemistry has not yet been realized; this is because excitation and manipulation of molecular orbitals requires precisely controlled attosecond waveforms in the deep UV, which have not yet been synthesized. Here, we present a unique approach using attosecond vacuum UV pulse-trains to coherently excite and control the outcome of a simple chemical reaction in a deuterium molecule in a non-Born–Oppenheimer regime. By controlling the interfering pathways of electron wave packets in the excited neutral and singly ionized molecule, we unambiguously show that we can switch the excited electronic state on attosecond timescales, coherently guide the nuclear wave packets to dictate the way a neutral molecule vibrates, and steer and manipulate the ionization and dissociation channels. Furthermore, through advanced theory, we succeed in rigorously modeling multiscale electron and nuclear quantum control in a molecule. The observed richness and complexity of the dynamics, even in this very simplest of molecules, is both remarkable and daunting, and presents intriguing new possibilities for bridging the gap between attosecond physics and attochemistry. PMID:24395768

  11. Autoinhibitory mechanisms of ERG studied by molecular dynamics simulations

    NASA Astrophysics Data System (ADS)

    Lu, Yan; Salsbury, Freddie R.

    2015-01-01

    ERG, an ETS-family transcription factor, acts as a regulator of differentiation of early hematopoietic cells. It contains an autoinhibitory domain, which negatively regulates DNA-binding. The mechanism of autoinhibitory is still illusive. To understand the mechanism, we study the dynamical properties of ERG protein by molecular dynamics simulations. These simulations suggest that DNA binding autoinhibition associates with the internal dynamics of ERG. Specifically, we find that (1), The N-C terminal correlation in the inhibited ERG is larger than that in uninhibited ERG that contributes to the autoinhibition of DNA-binding. (2), DNA-binding changes the property of the N-C terminal correlation from being anti-correlated to correlated, that is, changing the relative direction of the correlated motions and (3), For the Ets-domain specifically, the inhibited and uninhibited forms exhibit essentially the same dynamics, but the binding of the DNA decreases the fluctuation of the Ets-domain. We also find from PCA analysis that the three systems, even with quite different dynamics, do have highly similar free energy surfaces, indicating that they share similar conformations.

  12. Low molecular weight oligomers of amyloid peptides display β-barrel conformations: A replica exchange molecular dynamics study in explicit solvent

    NASA Astrophysics Data System (ADS)

    De Simone, Alfonso; Derreumaux, Philippe

    2010-04-01

    The self-assembly of proteins and peptides into amyloid fibrils is connected to over 40 pathological conditions including neurodegenerative diseases and systemic amyloidosis. Diffusible, low molecular weight protein and peptide oligomers that form in the early steps of aggregation appear to be the harmful cytotoxic species in the molecular etiology of these diseases. So far, the structural characterization of these oligomers has remained elusive owing to their transient and dynamic features. We here address, by means of full atomistic replica exchange molecular dynamics simulations, the energy landscape of heptamers of the amyloidogenic peptide NHVTLSQ from the beta-2 microglobulin protein. The simulations totaling 5 μs show that low molecular weight oligomers in explicit solvent consist of β-barrels in equilibrium with amorphous states and fibril-like assemblies. The results, also accounting for the influence of the pH on the conformational properties, provide a strong evidence of the formation of transient β-barrel assemblies in the early aggregation steps of amyloid-forming systems. Our findings are discussed in terms of oligomers cytotoxicity.

  13. Enhanced sampling of molecular dynamics simulation of peptides and proteins by double coupling to thermal bath.

    PubMed

    Chen, Changjun; Huang, Yanzhao; Xiao, Yi

    2013-01-01

    Low sampling efficiency in conformational space is the well-known problem for conventional molecular dynamics. It greatly increases the difficulty for molecules to find the transition path to native state, and costs amount of CPU time. To accelerate the sampling, in this paper, we re-couple the critical degrees of freedom in the molecule to environment temperature, like dihedrals in generalized coordinates or nonhydrogen atoms in Cartesian coordinate. After applying to ALA dipeptide model, we find that this modified molecular dynamics greatly enhances the sampling behavior in the conformational space and provides more information about the state-to-state transition, while conventional molecular dynamics fails to do so. Moreover, from the results of 16 independent 100 ns simulations by the new method, it shows that trpzip2 has one-half chances to reach the naive state in all the trajectories, which is greatly higher than conventional molecular dynamics. Such an improvement would provide a potential way for searching the conformational space or predicting the most stable states of peptides and proteins.

  14. Effect of PEO molecular weight on the miscibility and dynamics in epoxy/PEO blends.

    PubMed

    Lu, Shoudong; Zhang, Rongchun; Wang, Xiaoliang; Sun, Pingchuan; Lv, Weifeng; Liu, Qingjie; Jia, Ninghong

    2015-11-01

    In this work, the effect of poly(ethylene oxide) (PEO) molecular weight in blends of epoxy (ER) and PEO on the miscibility, inter-chain weak interactions and local dynamics were systematically investigated by multi-frequency temperature modulation DSC and solid-state NMR techniques. We found that the molecular weight (M(w)) of PEO was a crucial factor in controlling the miscibility, chain dynamics and hydrogen bonding interactions between PEO and ER. A critical PEO molecular weight (M(crit)) around 4.5k was found. PEO was well miscible with ER when the molecular weight was below M(crit), where the chain motion of PEO was restricted due to strong inter-chain hydrogen bonding interactions. However, for the blends with high molecular weight PEO (M(w) > M(crit)), the miscibility between PEO and ER was poor, and most of PEO chains were considerably mobile. Finally, polarization inversion spin exchange at magic angle (PISEMA) solid-state NMR experiment further revealed the different mobility of the PEO in ER/PEO blends with different molecular weight of PEO at molecular level. Based on the DSC and NMR results, a tentative model was proposed to illustrate the miscibility in ER/PEO blends.

  15. Consistent View of Protein Fluctuations from All-Atom Molecular Dynamics and Coarse-Grained Dynamics with Knowledge-Based Force-Field.

    PubMed

    Jamroz, Michal; Orozco, Modesto; Kolinski, Andrzej; Kmiecik, Sebastian

    2013-01-08

    It is widely recognized that atomistic Molecular Dynamics (MD), a classical simulation method, captures the essential physics of protein dynamics. That idea is supported by a theoretical study showing that various MD force-fields provide a consensus picture of protein fluctuations in aqueous solution [Rueda, M. et al. Proc. Natl. Acad. Sci. U.S.A. 2007, 104, 796-801]. However, atomistic MD cannot be applied to most biologically relevant processes due to its limitation to relatively short time scales. Much longer time scales can be accessed by properly designed coarse-grained models. We demonstrate that the aforementioned consensus view of protein dynamics from short (nanosecond) time scale MD simulations is fairly consistent with the dynamics of the coarse-grained protein model - the CABS model. The CABS model employs stochastic dynamics (a Monte Carlo method) and a knowledge-based force-field, which is not biased toward the native structure of a simulated protein. Since CABS-based dynamics allows for the simulation of entire folding (or multiple folding events) in a single run, integration of the CABS approach with all-atom MD promises a convenient (and computationally feasible) means for the long-time multiscale molecular modeling of protein systems with atomistic resolution.

  16. Molecular dynamics study of Al and Ni 3Al sputtering by Al clusters bombardment

    NASA Astrophysics Data System (ADS)

    Zhurkin, Eugeni E.; Kolesnikov, Anton S.

    2002-06-01

    The sputtering of Al and Ni 3Al (1 0 0) surfaces induced by impact of Al ions and Al N clusters ( N=2,4,6,9,13,55) with energies of 100 and 500 eV/atom is studied at atomic scale by means of classical molecular dynamics (MD). The MD code we used implements many-body tight binding potential splined to ZBL at short distances. Special attention has been paid to model dense cascades: we used quite big computation cells with lateral periodic and damped boundary conditions. In addition, long simulation times (10-25 ps) and representative statistics (up to 1000 runs per each case) were considered. The total sputtering yields, energy and time spectrums of sputtered particles, as well as preferential sputtering of compound target were analyzed, both in the linear and non-linear regimes. The significant "cluster enhancement" of sputtering yield was found for cluster sizes N⩾13. In parallel, we estimated collision cascade features depending on cluster size in order to interpret the nature of observed non-linear effects.

  17. Clustering effects in ionic polymers: Molecular dynamics simulations.

    PubMed

    Agrawal, Anupriya; Perahia, Dvora; Grest, Gary S

    2015-08-01

    Ionic clusters control the structure, dynamics, and transport in soft matter. Incorporating a small fraction of ionizable groups in polymers substantially reduces the mobility of the macromolecules in melts. These ionic groups often associate into random clusters in melts, where the distribution and morphology of the clusters impact the transport in these materials. Here, using molecular dynamic simulations we demonstrate a clear correlation between cluster size and morphology with the polymer mobility in melts of sulfonated polystyrene. We show that in low dielectric media ladderlike clusters that are lower in energy compared with spherical assemblies are formed. Reducing the electrostatic interactions by enhancing the dielectric constant leads to morphological transformation from ladderlike clusters to globular assemblies. Decrease in electrostatic interaction significantly enhances the mobility of the polymer.

  18. Insights into structural and dynamical features of water at halloysite interfaces probed by DFT and classical molecular dynamics simulations.

    PubMed

    Presti, Davide; Pedone, Alfonso; Mancini, Giordano; Duce, Celia; Tiné, Maria Rosaria; Barone, Vincenzo

    2016-01-21

    Density functional theory calculations and classical molecular dynamics simulations have been used to investigate the structure and dynamics of water molecules on kaolinite surfaces and confined in the interlayer of a halloysite model of nanometric dimension. The first technique allowed us to accurately describe the structure of the tetrahedral-octahedral slab of kaolinite in vacuum and in interaction with water molecules and to assess the performance of two widely employed empirical force fields to model water/clay interfaces. Classical molecular dynamics simulations were used to study the hydrogen bond network structure and dynamics of water adsorbed on kaolinite surfaces and confined in the halloysite interlayer. The results are in nice agreement with the few experimental data available in the literature, showing a pronounced ordering and reduced mobility of water molecules at the hydrophilic octahedral surfaces of kaolinite and confined in the halloysite interlayer, with respect to water interacting with the hydrophobic tetrahedral surfaces and in the bulk. Finally, this investigation provides new atomistic insights into the structural and dynamical properties of water-clay interfaces, which are of fundamental importance for both natural processes and industrial applications.

  19. Molecular-dynamics Simulation-based Cohesive Zone Representation of Intergranular Fracture Processes in Aluminum

    NASA Technical Reports Server (NTRS)

    Yamakov, Vesselin I.; Saether, Erik; Phillips, Dawn R.; Glaessgen, Edward H.

    2006-01-01

    A traction-displacement relationship that may be embedded into a cohesive zone model for microscale problems of intergranular fracture is extracted from atomistic molecular-dynamics simulations. A molecular-dynamics model for crack propagation under steady-state conditions is developed to analyze intergranular fracture along a flat 99 [1 1 0] symmetric tilt grain boundary in aluminum. Under hydrostatic tensile load, the simulation reveals asymmetric crack propagation in the two opposite directions along the grain boundary. In one direction, the crack propagates in a brittle manner by cleavage with very little or no dislocation emission, and in the other direction, the propagation is ductile through the mechanism of deformation twinning. This behavior is consistent with the Rice criterion for cleavage vs. dislocation blunting transition at the crack tip. The preference for twinning to dislocation slip is in agreement with the predictions of the Tadmor and Hai criterion. A comparison with finite element calculations shows that while the stress field around the brittle crack tip follows the expected elastic solution for the given boundary conditions of the model, the stress field around the twinning crack tip has a strong plastic contribution. Through the definition of a Cohesive-Zone-Volume-Element an atomistic analog to a continuum cohesive zone model element - the results from the molecular-dynamics simulation are recast to obtain an average continuum traction-displacement relationship to represent cohesive zone interaction along a characteristic length of the grain boundary interface for the cases of ductile and brittle decohesion. Keywords: Crack-tip plasticity; Cohesive zone model; Grain boundary decohesion; Intergranular fracture; Molecular-dynamics simulation

  20. Molecular Dynamics Simulations of the Temperature Induced Unfolding of Crambin Follow the Arrhenius Equation.

    PubMed

    Dalby, Andrew; Shamsir, Mohd Shahir

    2015-01-01

    Molecular dynamics simulations have been used extensively to model the folding and unfolding of proteins. The rates of folding and unfolding should follow the Arrhenius equation over a limited range of temperatures. This study shows that molecular dynamic simulations of the unfolding of crambin between 500K and 560K do follow the Arrhenius equation. They also show that while there is a large amount of variation between the simulations the average values for the rate show a very high degree of correlation.