LAMMPS

Last updated
Large-scale Atomic/Molecular Massively Parallel Simulator
Original author(s) Steve Plimpton, Aidan Thompson, Stan Moore, Axel Kohlmeyer, Richard Berger
Developer(s) Sandia National Laboratories
Temple University
Initial release1995;29 years ago (1995)
Stable release
2August2023 / August 2, 2023;6 months ago (2023-08-02)
Repository github.com/lammps/lammps
Written in C++
Operating system Cross-platform: Linux, macOS, Windows, FreeBSD, Solaris
Platform x86, x86-64, ARM, POWER9
Size 534 MB
Available inEnglish
Type Molecular dynamics
License GNU General Public License
Website www.lammps.org

Large-scale Atomic/Molecular Massively Parallel Simulator (LAMMPS) is a molecular dynamics program from Sandia National Laboratories. [1] LAMMPS makes use of Message Passing Interface (MPI) for parallel communication and is free and open-source software, distributed under the terms of the GNU General Public License. [1]

Contents

LAMMPS was originally developed under a Cooperative Research and Development Agreement between two laboratories from United States Department of Energy and three other laboratories from private sector firms. [1] As of 2016, it is maintained and distributed by researchers at the Sandia National Laboratories and Temple University. [1]

Features

For computing efficiency, LAMMPS uses neighbor lists (Verlet lists) to keep track of nearby particles. The lists are optimized for systems with particles that repel at short distances, so that the local density of particles never grows too large. [2]

On parallel computers, LAMMPS uses spatial-decomposition techniques to partition the simulation domain into small 3D sub-domains, one of which is assigned to each processor. Processors communicate and store ghost atom information for atoms that border their subdomain. LAMMPS is most efficient (in a parallel computing sense) for systems whose particles fill a 3D rectangular box with approximately uniform density. Lots of accelerators are supported by LAMMPS, including GPU (CUDA, OpenCL, HIP, SYCL), Intel Xeon Phi, and OpenMP, due to its integration with Trilinos.

LAMMPS also allows for coupled spin and molecular dynamics in an accelerated fashion. [3]

LAMMPS is coupled to many analysis tools and engines as well. [4] [5] [6] LAMMPS also can be coupled with free energy calculators, such as PLUMED and Colvar. [7] [8]

See also

Related Research Articles

<span class="mw-page-title-main">Sandia National Laboratories</span> National laboratory in Albuquerque, New Mexico.

Sandia National Laboratories (SNL), also known as Sandia, is one of three research and development laboratories of the United States Department of Energy's National Nuclear Security Administration (NNSA). Headquartered in Kirtland Air Force Base in Albuquerque, New Mexico, it has a second principal facility next to Lawrence Livermore National Laboratory in Livermore, California, and a test facility in Waimea, Kauai, Hawaii. Sandia is owned by the U.S. federal government but privately managed and operated by National Technology and Engineering Solutions of Sandia, a wholly owned subsidiary of Honeywell International.

<span class="mw-page-title-main">Molecular dynamics</span> Computer simulations to discover and understand chemical properties

Molecular dynamics (MD) is a computer simulation method for analyzing the physical movements of atoms and molecules. The atoms and molecules are allowed to interact for a fixed period of time, giving a view of the dynamic "evolution" of the system. In the most common version, the trajectories of atoms and molecules are determined by numerically solving Newton's equations of motion for a system of interacting particles, where forces between the particles and their potential energies are often calculated using interatomic potentials or molecular mechanical force fields. The method is applied mostly in chemical physics, materials science, and biophysics.

GROMACS is a molecular dynamics package mainly designed for simulations of proteins, lipids, and nucleic acids. It was originally developed in the Biophysical Chemistry department of University of Groningen, and is now maintained by contributors in universities and research centers worldwide. GROMACS is one of the fastest and most popular software packages available, and can run on central processing units (CPUs) and graphics processing units (GPUs). It is free, open-source software released under the GNU General Public License (GPL), and starting with version 4.6, the GNU Lesser General Public License (LGPL).

<span class="mw-page-title-main">Scientific visualization</span> Interdisciplinary branch of science concerned with presenting scientific data visually

Scientific visualization is an interdisciplinary branch of science concerned with the visualization of scientific phenomena. It is also considered a subset of computer graphics, a branch of computer science. The purpose of scientific visualization is to graphically illustrate scientific data to enable scientists to understand, illustrate, and glean insight from their data. Research into how people read and misread various types of visualizations is helping to determine what types and features of visualizations are most understandable and effective in conveying information.

ScientificPython is an open source library of scientific tools for the Python programming language. Its development started in 1995.

NWChem is an ab initio computational chemistry software package which includes quantum chemical and molecular dynamics functionality. It was designed to run on high-performance parallel supercomputers as well as conventional workstation clusters. It aims to be scalable both in its ability to treat large problems efficiently, and in its usage of available parallel computing resources. NWChem has been developed by the Molecular Sciences Software group of the Theory, Modeling & Simulation program of the Environmental Molecular Sciences Laboratory (EMSL) at the Pacific Northwest National Laboratory (PNNL). The early implementation was funded by the EMSL Construction Project.

Tinker, previously stylized as TINKER, is a suite of computer software applications for molecular dynamics simulation. The codes provide a complete and general set of tools for molecular mechanics and molecular dynamics, with some special features for biomolecules. The core of the software is a modular set of callable routines which allow manipulating coordinates and evaluating potential energy and derivatives via straightforward means.

<span class="mw-page-title-main">Computational engineering</span>

Computational Engineering is an emerging discipline that deals with the development and application of computational models for engineering, known as Computational Engineering Models or CEM. Computational engineering uses computers to solve engineering design problems important to a variety of industries. At this time, various different approaches are summarized under the term Computational Engineering, including using computational geometry and virtual design for engineering tasks, often coupled with a simulation-driven approach In Computational Engineering, algorithms solve mathematical and logical models that describe engineering challenges, sometimes coupled with some aspect of AI, specifically Reinforcement Learning.

<span class="mw-page-title-main">Molecular modeling on GPUs</span> Using graphics processing units for molecular simulations

Molecular modeling on GPU is the technique of using a graphics processing unit (GPU) for molecular simulations.

Desmond is a software package developed at D. E. Shaw Research to perform high-speed molecular dynamics simulations of biological systems on conventional computer clusters. The code uses novel parallel algorithms and numerical methods to achieve high performance on platforms containing multiple processors, but may also be executed on a single computer.

<span class="mw-page-title-main">Metadynamics</span> Scientific computer simulation method

Metadynamics is a computer simulation method in computational physics, chemistry and biology. It is used to estimate the free energy and other state functions of a system, where ergodicity is hindered by the form of the system's energy landscape. It was first suggested by Alessandro Laio and Michele Parrinello in 2002 and is usually applied within molecular dynamics simulations. MTD closely resembles a number of newer methods such as adaptively biased molecular dynamics, adaptive reaction coordinate forces and local elevation umbrella sampling. More recently, both the original and well-tempered metadynamics were derived in the context of importance sampling and shown to be a special case of the adaptive biasing potential setting. MTD is related to the Wang–Landau sampling.

MADNESS is a high-level software environment for the solution of integral and differential equations in many dimensions using adaptive and fast harmonic analysis methods with guaranteed precision based on multiresolution analysis and separated representations .

eOn BOINC based volunteer computing project

eOn was a volunteer computing project running on the Berkeley Open Infrastructure for Network Computing (BOINC) platform, which uses theoretical chemistry techniques to solve problems in condensed matter physics and materials science. It was a project of the Institute for Computational Engineering and Sciences at the University of Texas.

<span class="mw-page-title-main">Tachyon (software)</span>

Tachyon is a parallel/multiprocessor ray tracing software. It is a parallel ray tracing library for use on distributed memory parallel computers, shared memory computers, and clusters of workstations. Tachyon implements rendering features such as ambient occlusion lighting, depth-of-field focal blur, shadows, reflections, and others. It was originally developed for the Intel iPSC/860 by John Stone for his M.S. thesis at University of Missouri-Rolla. Tachyon subsequently became a more functional and complete ray tracing engine, and it is now incorporated into a number of other open source software packages such as VMD, and SageMath. Tachyon is released under a permissive license.

Goma is an open-source, parallel, and scalable multiphysics software package for modeling and simulation of real-life physical processes, with a basis in computational fluid dynamics for problems with evolving geometry. It solves problems in all branches of mechanics, including fluids, solids, and thermal analysis. Goma uses advanced numerical methods, focusing on the low-speed flow regime with coupled phenomena for manufacturing and performance applications. It also provides a flexible software development environment for specialty physics.

Multi-state modeling of biomolecules refers to a series of techniques used to represent and compute the behaviour of biological molecules or complexes that can adopt a large number of possible functional states.

Andres Jaramillo-Botero is a Colombian-American scientist and professor, working in computational chemical physics, known for his contributions to first-principles based modeling, design and characterization of nanoscale materials and devices.

PLUMED is an open-source library implementing enhanced-sampling algorithms, various free-energy methods, and analysis tools for molecular dynamics simulations. It is designed to be used together with ACEMD, AMBER, DL_POLY, GROMACS, LAMMPS, NAMD, OpenMM, ABIN, CP2K, i-PI, PINY-MD, and Quantum ESPRESSO, but it can also be used to together with analysis and visualization tools VMD, HTMD, and OpenPathSampling.

References

  1. 1 2 3 4 "LAMMPS Molecular Dynamics Simulator". Sandia National Laboratories. Retrieved 2022-07-13.
  2. Plimpton, S. (1993-05-01). "Fast parallel algorithms for short-range molecular dynamics". doi:10.2172/10176421.{{cite journal}}: Cite journal requires |journal= (help)
  3. Tranchida, Julien Guy; Wood, Mitchell; Moore, Stan Gerald (2018-09-01). "Coupled Magnetic Spin Dynamics and Molecular Dynamics in a Massively Parallel Framework: LDRD Final Report". doi:10.2172/1493836. OSTI   1493836. S2CID   127973739.{{cite journal}}: Cite journal requires |journal= (help)
  4. Stukowski, Alexander (2009-12-15). "Visualization and analysis of atomistic simulation data with OVITO–the Open Visualization Tool". Modelling and Simulation in Materials Science and Engineering. 18 (1): 015012. doi:10.1088/0965-0393/18/1/015012. ISSN   0965-0393. S2CID   42073422.
  5. Goswami, Rohit; Goswami, Amrita; Singh, Jayant K. (2019). "dSEAMS: Deferred Structural Elucidation Analysis for Molecular Simulations". Journal of Chemical Information and Modeling. arXiv: 1909.09830 . doi:10.1021/acs.jcim.0c00031.s001.
  6. McGibbon, Robert T; Beauchamp, Kyle A; Schwantes, Christian R; Wang, Lee-Ping; Hernández, Carlos X; Harrigan, Matthew P; Lane, Thomas J; Swails, Jason M; Pande, Vijay S (2014-09-09). "MDTraj: a modern, open library for the analysis of molecular dynamics trajectories". Biophysical Journal. 109 (8): 1528–32. bioRxiv   10.1101/008896 . doi:10.1016/j.bpj.2015.08.015. PMC   4623899 . PMID   26488642.
  7. Tribello, Gareth A.; Bonomi, Massimiliano; Branduardi, Davide; Camilloni, Carlo; Bussi, Giovanni (2014-02-01). "PLUMED 2: New feathers for an old bird". Computer Physics Communications. 185 (2): 604–613. arXiv: 1310.0980 . doi:10.1016/j.cpc.2013.09.018. ISSN   0010-4655. S2CID   17904052.
  8. Fiorin, Giacomo; Klein, Michael L.; Hénin, Jérôme (December 2013). "Using collective variables to drive molecular dynamics simulations". Molecular Physics. 111 (22–23): 3345–3362. doi: 10.1080/00268976.2013.813594 . ISSN   0026-8976.