All Projects → choderalab → openmm-tutorials

choderalab / openmm-tutorials

Licence: MIT license
Quickstart Python tutorials helping molecular dynamics practitioners get up to speed with OpenMM

Programming Languages

Jupyter Notebook
11667 projects

Projects that are alternatives of or similar to openmm-tutorials

fahbench
Folding@home GPU benchmark
Stars: ✭ 32 (-13.51%)
Mutual labels:  molecular-dynamics, openmm
grand
A Python module for carrying out GCMC insertions and deletions of water molecules in OpenMM.
Stars: ✭ 23 (-37.84%)
Mutual labels:  molecular-dynamics, openmm
perses
Experiments with expanded ensembles to explore chemical space
Stars: ✭ 99 (+167.57%)
Mutual labels:  molecular-dynamics, openmm
Colvars
Collective variables module for molecular simulation and analysis programs
Stars: ✭ 99 (+167.57%)
Mutual labels:  molecular-dynamics
Torchmd
End-To-End Molecular Dynamics (MD) Engine using PyTorch
Stars: ✭ 99 (+167.57%)
Mutual labels:  molecular-dynamics
Hoomd Blue
Molecular dynamics and Monte Carlo soft matter simulation on GPUs.
Stars: ✭ 143 (+286.49%)
Mutual labels:  molecular-dynamics
Loos
LOOS: a lightweight object-oriented structure analysis library
Stars: ✭ 63 (+70.27%)
Mutual labels:  molecular-dynamics
Chemlab
The chemistry library you were waiting for
Stars: ✭ 187 (+405.41%)
Mutual labels:  molecular-dynamics
Espresso
The ESPResSo package
Stars: ✭ 130 (+251.35%)
Mutual labels:  molecular-dynamics
Molecular Design Toolkit
Notebook-integrated tools for molecular simulation and visualization
Stars: ✭ 123 (+232.43%)
Mutual labels:  molecular-dynamics
Plumed2
Development version of plumed 2
Stars: ✭ 178 (+381.08%)
Mutual labels:  molecular-dynamics
Lumol
Universal extensible molecular simulation engine
Stars: ✭ 120 (+224.32%)
Mutual labels:  molecular-dynamics
Gromacswrapper
GromacsWrapper is a python package that wraps system calls to Gromacs tools into thin classes. This allows for fairly seamless integration of the gromacs tools (v4.6.x, v5.x, 2016.x, 2018.x, 2019.x, all with the same Python code) into python scripts.
Stars: ✭ 108 (+191.89%)
Mutual labels:  molecular-dynamics
Vde
Variational Autoencoder for Dimensionality Reduction of Time-Series
Stars: ✭ 148 (+300%)
Mutual labels:  molecular-dynamics
Yank
An open, extensible Python framework for GPU-accelerated alchemical free energy calculations.
Stars: ✭ 101 (+172.97%)
Mutual labels:  molecular-dynamics
Pyemma
🚂 Python API for Emma's Markov Model Algorithms 🚂
Stars: ✭ 200 (+440.54%)
Mutual labels:  molecular-dynamics
Molly.jl
Molecular simulation in Julia
Stars: ✭ 99 (+167.57%)
Mutual labels:  molecular-dynamics
Freud
Powerful, efficient particle trajectory analysis in scientific Python.
Stars: ✭ 118 (+218.92%)
Mutual labels:  molecular-dynamics
Openff Toolkit
The Open Forcefield Toolkit provides implementations of the SMIRNOFF format, parameterization engine, and other tools. Documentation available at http://open-forcefield-toolkit.readthedocs.io
Stars: ✭ 138 (+272.97%)
Mutual labels:  molecular-dynamics
awesome-molecular-dynamics
😎 A curated list of awesome Molecular Dynamics libraries, tools and software.
Stars: ✭ 76 (+105.41%)
Mutual labels:  molecular-dynamics

Python tutorials for OpenMM

This guide is a set of Jupyter notebooks intended to help researchers already familiar with molecular dynamics simulation learn how to use OpenMM in their research and software projects.

Getting started

We recommend you use miniconda and the conda package manager. If you don't already have miniconda installed, you can easily install it from the terminal:

# For Mac OS X, substitute `MacOSX` for `Linux` below
wget https://repo.continuum.io/miniconda/Miniconda3-latest-Linux-x86_64.sh
bash -b ./Miniconda3-latest-Linux-x86_64.sh -p $HOME/miniconda
export PATH=$HOME/miniconda/bin:$PATH

Install the dependencies with conda:

conda install --yes -c omnia -c conda-forge jupyter notebook openmm mdtraj nglview

Tutorial modules

More resources

Be sure to check out the OpenMM Documentation site http://docs.openmm.org, which contains an excellent User Guide, Python API reference, and more tutorials.

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].