Q (software)

Last updated
Q
Original author(s) Johan Åqvist, John Marelius, Paul Bauer, Lynn Kamerlin
Developer(s) The Q development team at Uppsala University, Sweden
Uppsala Molekylmekaniska HB
Initial release1999;24 years ago (1999)
Stable release
6.0 / 2017;6 years ago (2017)
Written in Fortran
Operating system Linux, macOS, Windows by Cygwin, any other Unix variety
Platform x86, x86-64
Available inEnglish
Type Molecular dynamics simulation
License open source GNU General Public License version 2 (GPLv2)
Website github.com/qusers/Q6

Q is a computer software package for molecular dynamics (MD) simulation (current release: Q6). Unlike other MD codes, it has specialized since its conception (Marelius et al. 1998) on three specific types of free energy calculations. These calculations are based on the methods: empirical valence bond (EVB), free energy perturbation (FEP), and linear interaction energy (LIE), as well as, more recently, also path integral calculations using the bisection quantum classical path (BQCP) approach.

Contents

The methods in which the program specializes can return quantitative calculations of the energy balance which occurs in proteins and nucleic acids. It can provide insight into key problems in biochemistry such as, energetic details on parts of the translation mechanism in mitochondrial ribosomes (Lind et al. 2013), or details in enzymatic reactions (Mones et al. 2013), among others.

The program is similar to GROMACS in being force-field agnostic, meaning that it provides no force-field, but can rather use common force-fields such as CHARMM, AMBER, OPLS, and GROMOS.

The software provides one main utility for molecular dynamics called qdyn, and various subprograms such as qprep (to prepare input files from X-ray coordinates), qfep (to process MD calculations for FEP), and others.

General command to run

The general command to run Q is very similar to that of other MD programs and its syntax for a dynamics run is as follows:

qdyn inputfile.inp > outputfile.out

qdyn – This is the name of the main program which runs dynamics.

inputfile.inp – This is a text file which specifies all options to the program such as how long are the simulation and the time-steps, what temperature is being simulated, and many others.

outputfile.out – This is the output file which gives a detailed account of the energetic results. The verbosity of the information in the output file is controlled in the input file. The output places emphasis on reporting on nonbonded interactions such as van der Waals force and electrostatics interactions in detail on the solvent, the solution, and the interactions among them.

See also

Related Research Articles

Computational chemistry is a branch of chemistry that uses computer simulation to assist in solving chemical problems. It uses methods of theoretical chemistry, incorporated into computer programs, to calculate the structures and properties of molecules, groups of molecules, and solids. It is essential because, apart from relatively recent results concerning the hydrogen molecular ion, the quantum many-body problem cannot be solved analytically, much less in closed form. While computational results normally complement the information obtained by chemical experiments, it can in some cases predict hitherto unobserved chemical phenomena. It is widely used in the design of new drugs and materials.

<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">AMBER</span>

Assisted Model Building with Energy Refinement (AMBER) is a family of force fields for molecular dynamics of biomolecules originally developed by Peter Kollman's group at the University of California, San Francisco.

GROningen MOlecular Simulation (GROMOS) is the name of a force field for molecular dynamics simulation, and a related computer software package. Both are developed at the University of Groningen, and at the Computer-Aided Chemistry Group at the Laboratory for Physical Chemistry at the Swiss Federal Institute of Technology (ETH Zurich). At Groningen, Herman Berendsen was involved in its development.

Chemistry at Harvard Macromolecular Mechanics (CHARMM) is the name of a widely used set of force fields for molecular dynamics, and the name for the molecular dynamics simulation and analysis computer software package associated with them. The CHARMM Development Project involves a worldwide network of developers working with Martin Karplus and his group at Harvard to develop and maintain the CHARMM program. Licenses for this software are available, for a fee, to people and groups working in academia.

<span class="mw-page-title-main">Molecular mechanics</span> Use of classical mechanics to model molecular systems

Molecular mechanics uses classical mechanics to model molecular systems. The Born–Oppenheimer approximation is assumed valid and the potential energy of all systems is calculated as a function of the nuclear coordinates using force fields. Molecular mechanics can be used to study molecule systems ranging in size and complexity from small to large biological systems or material assemblies with many thousands to millions of atoms.

<span class="mw-page-title-main">Molecular modelling</span> Discovering chemical properties by physical simulations

Molecular modelling encompasses all methods, theoretical and computational, used to model or mimic the behaviour of molecules. The methods are used in the fields of computational chemistry, drug design, computational biology and materials science to study molecular systems ranging from small chemical systems to large biological molecules and material assemblies. The simplest calculations can be performed by hand, but inevitably computers are required to perform molecular modelling of any reasonably sized system. The common feature of molecular modelling methods is the atomistic level description of the molecular systems. This may include treating atoms as the smallest individual unit, or explicitly modelling protons and neutrons with its quarks, anti-quarks and gluons and electrons with its photons.

<span class="mw-page-title-main">Force field (chemistry)</span> Concept on molecular modeling

In the context of chemistry and molecular modelling, a force field is a computational method that is used to estimate the forces between atoms within molecules and also between molecules. More precisely, the force field refers to the functional form and parameter sets used to calculate the potential energy of a system of atoms or coarse-grained particles in molecular mechanics, molecular dynamics, or Monte Carlo simulations. The parameters for a chosen energy function may be derived from experiments in physics and chemistry, calculations in quantum mechanics, or both. Force fields are interatomic potentials and utilize the same concept as force fields in classical physics, with the difference that the force field parameters in chemistry describe the energy landscape, from which the acting forces on every particle are derived as a gradient of the potential energy with respect to the particle coordinates.

Car–Parrinello molecular dynamics or CPMD refers to either a method used in molecular dynamics or the computational chemistry software package used to implement this method.

Free energy perturbation (FEP) is a method based on statistical mechanics that is used in computational chemistry for computing free energy differences from molecular dynamics or Metropolis Monte Carlo simulations.

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

Molecular Dynamics of Mixtures (MDynaMix) is a computer software package for general purpose molecular dynamics to simulate mixtures of molecules, interacting by AMBER- and CHARMM-like force fields in periodic boundary conditions. Algorithms are included for NVE, NVT, NPT, anisotropic NPT ensembles, and Ewald summation to treat electrostatic interactions. The code was written in a mix of Fortran 77 and 90. The package runs on Unix and Unix-like (Linux) workstations, clusters of workstations, and on Windows in sequential mode.

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

CP2K is a freely available (GPL) quantum chemistry and solid state physics program package, written in Fortran 2008, to perform atomistic simulations of solid state, liquid, molecular, periodic, material, crystal, and biological systems. It provides a general framework for different methods: density functional theory (DFT) using a mixed Gaussian and plane waves approach (GPW) via LDA, GGA, MP2, or RPA levels of theory, classical pair and many-body potentials, semi-empirical and tight-binding Hamiltonians, as well as Quantum Mechanics/Molecular Mechanics (QM/MM) hybrid schemes relying on the Gaussian Expansion of the Electrostatic Potential (GEEP). The Gaussian and Augmented Plane Waves method (GAPW) as an extension of the GPW method allows for all-electron calculations. CP2K can do simulations of molecular dynamics, metadynamics, Monte Carlo, Ehrenfest dynamics, vibrational analysis, core level spectroscopy, energy minimization, and transition state optimization using NEB or dimer method.

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.

Biochemical and Organic Simulation System (BOSS) is a general-purpose molecular modeling program that performs molecular mechanics calculations, Metropolis Monte Carlo statistical mechanics simulations, and semiempirical Austin Model 1 (AM1), PM3, and PDDG/PM3 quantum mechanics calculations. The molecular mechanics calculations cover energy minimizations, normal mode analysis and conformational searching with the Optimized Potentials for Liquid Simulations (OPLS) force fields. BOSS is developed by Prof. William L. Jorgensen at Yale University, and distributed commercially by Cemcomco, LLC and Schrödinger, Inc.

<span class="mw-page-title-main">Ascalaph Designer</span>

Ascalaph Designer is a computer program for general purpose molecular modelling for molecular design and simulations. It provides a graphical environment for the common programs of quantum and classical molecular modelling ORCA, NWChem, Firefly, CP2K and MDynaMix . The molecular mechanics calculations cover model building, energy optimizations and molecular dynamics. Firefly covers a wide range of quantum chemistry methods. Ascalaph Designer is free and open-source software, released under the GNU General Public License, version 2 (GPLv2).

MacroModel is a computer program for molecular modelling of organic compounds and biopolymers. It features various chemistry force fields, plus energy minimizing algorithms, to predict geometry and relative conformational energies of molecules. MacroModel is maintained by Schrödinger, LLC.

<span class="mw-page-title-main">Empirical valence bond</span> Method of calculating chemical reaction free energies

In theoretical chemistry, the Empirical Valence Bond (EVB) approach is an approximation for calculating free-energies of a chemical reaction in condensed-phase. It was first developed by Israeli chemist Arieh Warshel, and was inspired by the way Marcus theory uses potential surfaces to calculate the probability of electron transfer.

In the context of chemistry and molecular modelling, the Interface force field (IFF) is a force field for classical molecular simulations of atoms, molecules, and assemblies up to the large nanometer scale, covering compounds from across the periodic table. It employs a consistent classical Hamiltonian energy function for metals, oxides, and organic compounds, linking biomolecular and materials simulation platforms into a single platform. The reliability is often higher than that of density functional theory calculations at more than a million times lower computational cost. IFF includes a physical-chemical interpretation for all parameters as well as a surface model database that covers different cleavage planes and surface chemistry of included compounds. The Interface Force Field is compatible with force fields for the simulation of primarily organic compounds and can be used with common molecular dynamics and Monte Carlo codes. Structures and energies of included chemical elements and compounds are rigorously validated and property predictions are up to a factor of 100 more accurate relative to earlier models.

<span class="mw-page-title-main">Johan Åqvist</span>

Johan Åqvist is a Swedish biochemist and academic. He is a professor of theoretical chemistry in the Department of Cell and Molecular Biology at Uppsala University and a member of the Royal Swedish Academy of Sciences as of 2023. He also served as chair of the Nobel Committee for Chemistry between 2021 and 2023.

References