All Projects → TinkerTools → tinker

TinkerTools / tinker

Licence: other
Tinker: Software Tools for Molecular Design

Programming Languages

fortran
972 projects
c
50402 projects - #5 most used programming language
Makefile
30231 projects
TeX
3793 projects
C++
36643 projects - #6 most used programming language
ocaml
1615 projects

Projects that are alternatives of or similar to tinker

tinker9
Tinker9: Next Generation of Tinker with GPU Support
Stars: ✭ 31 (-60.76%)
Mutual labels:  molecular-dynamics, force-fields, molecular-mechanics, molecular-modeling, biomolecular-simulation
nequip
NequIP is a code for building E(3)-equivariant interatomic potentials
Stars: ✭ 312 (+294.94%)
Mutual labels:  molecular-dynamics, force-fields
physical validation
Physical validation of molecular simulations
Stars: ✭ 37 (-53.16%)
Mutual labels:  molecular-dynamics, molecular-mechanics
enspara
Modeling molecular ensembles with scalable data structures and parallel computing
Stars: ✭ 28 (-64.56%)
Mutual labels:  molecular-dynamics, molecular-modeling
uf3
UF3: a python library for generating ultra-fast interatomic potentials
Stars: ✭ 19 (-75.95%)
Mutual labels:  molecular-dynamics, force-fields
NNPOps
High-performance operations for neural network potentials
Stars: ✭ 48 (-39.24%)
Mutual labels:  molecular-dynamics, molecular-modeling
MDBenchmark
Quickly generate, start and analyze benchmarks for molecular dynamics simulations.
Stars: ✭ 64 (-18.99%)
Mutual labels:  molecular-dynamics
covid
MolSSI SARS-CoV-2 Biomolecular Simulation Data and Algorithm Store
Stars: ✭ 24 (-69.62%)
Mutual labels:  molecular-dynamics
Clapeyron.jl
Clapeyron (formerly OpenSAFT) provides a framework for the development and use of fluid-thermodynamic models, including SAFT, cubic, activity, multi-parameter, and COSMO-SAC.
Stars: ✭ 81 (+2.53%)
Mutual labels:  molecular-modeling
foyer
A package for atom-typing as well as applying and disseminating forcefields
Stars: ✭ 78 (-1.27%)
Mutual labels:  molecular-dynamics
pytraj
Python interface of cpptraj
Stars: ✭ 106 (+34.18%)
Mutual labels:  molecular-dynamics
perses
Experiments with expanded ensembles to explore chemical space
Stars: ✭ 99 (+25.32%)
Mutual labels:  molecular-dynamics
MolecularGraph.jl
Graph-based molecule modeling toolkit for cheminformatics
Stars: ✭ 144 (+82.28%)
Mutual labels:  molecular-modeling
SCEMa
HMM implementation featuring Deal.II (FE) and LAMMPS (MD)
Stars: ✭ 14 (-82.28%)
Mutual labels:  molecular-dynamics
MDToolbox.jl
MDToolbox.jl: A Julia package for molecular dynamics trajectories analysis and modeling of biomolecules
Stars: ✭ 15 (-81.01%)
Mutual labels:  molecular-dynamics
mbuild
A hierarchical, component based molecule builder
Stars: ✭ 119 (+50.63%)
Mutual labels:  molecular-dynamics
AdaptivePELE
AdaptivePELE is a Python package aimed at enhancing the sampling of molecular simulations
Stars: ✭ 14 (-82.28%)
Mutual labels:  molecular-dynamics
votca
The source of the votca-csg and xtp packages
Stars: ✭ 28 (-64.56%)
Mutual labels:  molecular-dynamics
pylj
Teaching Utility for Classical Atomistic Simulation.
Stars: ✭ 23 (-70.89%)
Mutual labels:  molecular-dynamics
libra-code
quantum-dynamics-hub.github.io/libra/index.html
Stars: ✭ 33 (-58.23%)
Mutual labels:  molecular-dynamics

Tinker: Software Tools for Molecular Design

Introduction

The Tinker molecular modeling software is a complete and general package for molecular mechanics and dynamics, with some special features for biopolymers. Tinker has the ability to use any of several common parameter sets, such as Amber (ff94, ff96, ff98, ff99, ff99SB), CHARMM (19, 22, 22/CMAP), Allinger MM (MM2-1991 and MM3-2000), OPLS (OPLS-UA, OPLS-AA), Merck Molecular Force Field (MMFF), Liam Dang's polarizable model, and the AMOEBA, AMOEBA+ and HIPPO polarizable atomic multipole force fields. Parameter sets for other widely-used force fields are under consideration for future releases.

The Tinker software contains a variety of interesting algorithms such as: flexible implementation of atomic multipole-based electrostatics with explicit dipole polarizability, various continuum solvation treatments including several generalized Born (GB/SA) models, generalized Kirkwood implicit solvation for AMOEBA, an interface to APBS for Poisson-Boltzmann calculations, efficient truncated Newton (TNCG) local optimization, surface areas and volumes with derivatives, free energy calculations via the Bennett Acceptance Ratio (BAR) method, normal mode vibrational analysis, minimization in Cartesian, torsional or rigid body space, symplectic RESPA multiple time step integration for molecular dynamics, velocity Verlet stochastic dynamics, pairwise neighbor lists and splined spherical energy cutoff methods, particle mesh Ewald (PME) summation for partial charges and polarizable multipoles, a novel reaction field treatment of long range electrostatics, fast distance geometry metrization with better sampling than standard methods, Elber's reaction path algorithm, potential smoothing and search (PSS) methods for global optimization, Monte Carlo Minimization (MCM) for efficient potential surface scanning, tools for fitting charge, multipole and polarization models to QM-based electrostatic potentials and more....

Current Release

Tinker 8 is a major update of the Ponder Lab tool set for molecular mechanics and dynamics calculations. An important change in this new version is the switch from old-style common blocks to Fortran modules. Use of modules and greatly increased use of dynamic memory allocation means Tinker can now support very large molecular systems. Tinker 8 also implements improved OpenMP parallelization throughout additional parts of the code. Additional big improvements include parallel neighbor list building and updating, and big reduction in iteration needed to converge AMOEBA polarization via an efficient PCG solver. Other changes from the previous Tinker version include new and updated force field parameter sets and numerous minor additions and bug fixes, many of them suggested by users of the package. Please note that as with prior new releases, version 8 is neither backward nor forward compatible with earlier versions of Tinker. In particular, older versions of parameter files should not be used with Tinker 8 executables and vice versa. We strongly suggest users switch to Tinker 8 with its many important new features and bug fixes.

Building from Source Code

Tinker is provided as a complete source distribution. After unpacking the release, you can build a set of Tinker executables on almost any machine with a Fortran compiler. Makefiles, a cmake configure script, as well as standalone scripts to compile, build object libraries, and link executables on a wide variety of machine-CPU-operating system combinations are provided. To build using the Tinker Makefile, just copy /make/Makefile into the /source area of the distribution. Small changes are needed near the top of the file to set directory names and activate the appropriate operating system and compiler. Then issue the "make" command while in the /source directory. As noted below, the FFTW libraries must be available before building Tinker.

Tinker requires two object libraries from the FFTW Fourier transform package, libfftw3.a and libfftw3_threads.a. The FFTW libraries must be available in the one of the locations searched by the Tinker Makefile prior to building Tinker executables. While we do not provide the required FFTW libraries with the Tinker distribution, they are easy to build from the included FFTW source. Just follow the instructions in the /fftw/0README file. Optional support for APBS Poisson-Boltzmann calculations within Tinker requires object libraries from the APBS 1.3 software package, but this is not included in the default Tinker build.

If you do not want to build Tinker youself, pre-built Tinker executables for Linux, macOS, and Windows are available for download from https://dasher.wustl.edu/tinker/. They should run on most recent vintage machines using these operating systems, and can handle a maximum of 1 million atoms provided sufficient memory is available. The Linux executables require at least glibc-2.6 or later. Note starting with Tinker 8, we no longer provide pre-built executables for any 32-bit operating systems.

Note that the project description data, including the texts, logos, images, and/or trademarks, for each open source project belongs to its rightful owner. If you wish to add or remove any projects, please contact us at [email protected].