• Stars
    star
    1,277
  • Rank 36,858 (Top 0.8 %)
  • Language
    Python
  • License
    Other
  • Created over 9 years ago
  • Updated 3 months ago

Reviews

There are no reviews yet. Be the first to send feedback to the community and the maintainers!

Repository Details

MDAnalysis is a Python library to analyze molecular dynamics simulations.

MDAnalysis Repository README

Powered by NumFOCUS Github Actions Build Status Github Actions Cron Job Status Github Actions Linters Status Coverage Status

Documentation (latest release) Documentation (development version) User Google Group Developer Google Group Anaconda ASV Benchmarks

MDAnalysis is a Python library for the analysis of computer simulations of many-body systems at the molecular scale, spanning use cases from interactions of drugs with proteins to novel materials. It is widely used in the scientific community and is written by scientists for scientists.

It works with a wide range of popular simulation packages including Gromacs, Amber, NAMD, CHARMM, DL_Poly, HooMD, LAMMPS and many others — see the lists of supported trajectory formats and topology formats. MDAnalysis also includes widely used analysis algorithms in the MDAnalysis.analysis module.

The MDAnalysis project uses an open governance model and is fiscally sponsored by NumFOCUS. Consider making a tax-deductible donation to help the project pay for developer time, professional services, travel, workshops, and a variety of other needs.

NumFOCUS (Fiscally Sponsored Project)

This project is bound by a Code of Conduct.

Powered by MDAnalysis

If you use MDAnalysis in your project consider letting your users and the world know about it by displaying the MDAnalysis badge! Embedding code is available for different markups.

Example analysis script

import MDAnalysis as mda

# Load simulation results with a single line
u = mda.Universe('topol.tpr','traj.trr')

# Select atoms
ag = u.select_atoms('name OH')

# Atom data made available as Numpy arrays
ag.positions
ag.velocities
ag.forces

# Iterate through trajectories
for ts in u.trajectory:
    print(ag.center_of_mass())

Documentation

New users should read the Quickstart Guide and might want to look at our videos, in which core developers explain various aspects of MDAnalysis.

All users should read the User Guide.

Developers may also want to refer to the MDAnalysis API docs.

A growing number of tutorials are available that explain how to conduct RMSD calculations, structural alignment, distance and contact analysis, and many more.

Installation and availability

The latest release can be installed via pip or conda as described in the Installation Quick Start.

Source code is hosted in a git repository at https://github.com/MDAnalysis/mdanalysis and is available under the GNU General Public License, version 2 (see the file LICENSE).

Contributing

Please report bugs or enhancement requests through the Issue Tracker. Questions can also be asked on the user mailing list.

If you are a new developer who would like to start contributing to MDAnalysis get in touch on the developer mailing list. To set up a development environment and run the test suite read the developer guide.

Citation

When using MDAnalysis in published work, please cite the following two papers:

  • R. J. Gowers, M. Linke, J. Barnoud, T. J. E. Reddy, M. N. Melo, S. L. Seyler, D. L. Dotson, J. Domanski, S. Buchoux, I. M. Kenney, and O. Beckstein. MDAnalysis: A Python package for the rapid analysis of molecular dynamics simulations. In S. Benthall and S. Rostrup, editors, Proceedings of the 15th Python in Science Conference, pages 102-109, Austin, TX, 2016. SciPy. doi:10.25080/Majora-629e541a-00e
  • N. Michaud-Agrawal, E. J. Denning, T. B. Woolf, and O. Beckstein. MDAnalysis: A Toolkit for the Analysis of Molecular Dynamics Simulations. J. Comput. Chem. 32 (2011), 2319--2327. doi:10.1002/jcc.21787

For citations of included algorithms and sub-modules please see the references.

More Repositories

1

WorkshopMDMLEdinburgh2022

Jupyter Notebook
63
star
2

solvation-analysis

A comprehensive tool for analyzing liquid solvation structure.
Python
45
star
3

MDAnalysisCookbook

Examples and tutorials of using MDAnalysis
41
star
4

pmda

Parallel algorithms for MDAnalysis
Python
31
star
5

WorkshopPrace2021

Materials for the 2021 PRACE Workshop @ SurfSARA
Jupyter Notebook
31
star
6

panedr

Reads Gromacs EDR file to populate a pandas dataframe
Python
30
star
7

membrane-curvature

MDAnalysis tool to calculate membrane curvature.
Python
29
star
8

GridDataFormats

GridDataFormats is a pure Python library to handle data on a regular grid using commonly used file formats in molecular simulations.
Python
29
star
9

MDAPackmol

MDAnalysis wrapper around Packmol
Python
25
star
10

UserGuide

User Guide for MDAnalysis
Python
22
star
11

mdacli

Command line interface for MDAnalysis
Python
19
star
12

MDAKits

The MDAnalysis Toolkits Registry
Python
15
star
13

MDAnalysis.github.io

MDAnalysis home page mdanalysis.org as GitHub pages.
CSS
14
star
14

MDAnalysisData

Access to data for workshops and extended tests of MDAnalysis.
Python
14
star
15

WorkshopHackathon2018

Materials, issues and things for the 2018 Workshop and Hackathon
Jupyter Notebook
14
star
16

pytng

Python bindings for TNG file format
C
13
star
17

MDAnalysisMolSSIWorkshop-Intermediate2Day

Jupyter Notebook
12
star
18

MDAnalysisTutorial

Tutorial for MDAnalysis.
Jupyter Notebook
11
star
19

distopia

SIMD instructions for faster distance calculations.
C++
10
star
20

stride

STRIDE: Protein secondary structure assignment from atomic coordinates
C
10
star
21

transport-analysis

A Python package to compute and analyze transport properties.
Python
9
star
22

cookiecutter-mdakit

Cookiecutter for Python packages based on MDAnalysis
Python
7
star
23

cellgrid

Python
7
star
24

RotamerConvolveMD

Analysis of molecular dynamics trajectories or conformational ensembles in terms of spin-label distances as probed in double electron-electron resonance (DEER) experiments.
Python
7
star
25

MDAnalysisWorkshop-Intro0.5Day

Materials for 0.5-day MDAnalysis workshops
Jupyter Notebook
6
star
26

waterdynamics

Analysis of water dynamics in molecular dynamics trajectories and water interactions with other molecules.
Python
5
star
27

mdahole2

An MDAKit implementing a Python interface for the HOLE program.
Python
5
star
28

pystride

Python bindings to STRIDE
Python
4
star
29

UGM2023

Materials for the 2023 MDAnalysis User Group Meeting
Jupyter Notebook
4
star
30

mdalint

Proof of concept for a MDAnalysis linter
Python
4
star
31

binder-notebook

Notebooks for interactive use on https://mybinder.org/
Jupyter Notebook
4
star
32

dssp

DSSP - Secondary structure analysis
C++
3
star
33

pyQuteMol

port of C++ QuteMol
Python
3
star
34

RDKitConverter-benchmark

Benchmark for the RDKitConverter's inferring of bond orders and charges
HTML
3
star
35

scipy-2016

Accepted proposal for a talk at SciPy 2016
TeX
2
star
36

mdakits-whitepaper

MDAKits whitepaper (LaTeX sources).
TeX
2
star
37

MDAnalysisSandbox

testing reporsitory for workshops
Python
2
star
38

benchmarks

Performance benchmarks of MDAnalysis provided by ASV.
Shell
2
star
39

MDAnalysisWorkshop-Intro1Day

Materials for 1-day MDAnalysis workshops
Jupyter Notebook
2
star
40

SPIDAL-MDAnalysis-Midas-tutorial

Tutorial for SPIDAL presentation at workshop, showing how to use Midas radical.pilot to analyze an ensemble of MD trajectories with Path Similarity Analysis (as implemented in MDAnalysis).
Python
1
star
41

.github

MDAnalysis Org profile
1
star
42

mdanalysis-sphinx-theme

The official MDAnalysis Sphinx documentation theme.
Sass
1
star
43

mdgeomkit

Simple cookie-cutter based MDAKit (for Workshop teaching)
Python
1
star
44

UGM2024

Materials for the 2024 MDAnalysis User Group Meeting
1
star
45

binder-env-userguide

Binder environment of the User Guide
1
star
46

mdanalysis-compatible-python

Python
1
star
47

mda-xdrlib

Stand-alone XDRLIB module (from cpython 3.10.8)
Python
1
star
48

get-latest-python-version

Python
1
star