diff --git a/.nojekyll b/.nojekyll new file mode 100644 index 0000000..e69de29 diff --git a/about.html b/about.html deleted file mode 100644 index e871aa2..0000000 --- a/about.html +++ /dev/null @@ -1,215 +0,0 @@ ---- -layout: page -title: About OpenMM ---- - -
-
-
-
- -

About OpenMM

-

- Backed by researchers and developers from Stanford University, MSKCC, UPF, and others around the world. -

-
-
-
-
- -
-
-
-

Custom Forces

-

- Want a custom force between two atoms? No problem. Write your force expressions in string format, and OpenMM will generate blazing fast code to do just that. No more hand-writing GPU kernels. -

-
-
-

Highly Optimized

-

- OpenMM is optimized for the latest generation of compute hardware, including AMD (via OpenCL) and NVIDIA (via CUDA) GPUs. We also heavily optimize for CPUs using intrinsics. -

-
-
-

Portable

-

- We strive to make our binaries as portable as possible. We've tested OpenMM on many flavors of Linux, OS X, and even Windows. -

-
-
- -
-
-
from simtk.openmm.app import *
-from simtk.openmm import *
-from simtk.unit import *
-from sys import stdout
-
-pdb = PDBFile('input.pdb')
-forcefield = ForceField('amber99sb.xml', 'tip3p.xml')
-system = forcefield.createSystem(pdb.topology, nonbondedMethod=PME, nonbondedCutoff=1*nanometer, constraints=HBonds)
-integrator = LangevinIntegrator(300*kelvin, 1/picosecond, 0.002*picoseconds)
-simulation = Simulation(pdb.topology, system, integrator)
-simulation.context.setPositions(pdb.positions)
-simulation.minimizeEnergy()
-simulation.reporters.append(PDBReporter('output.pdb', 1000))
-simulation.reporters.append(StateDataReporter(stdout, 1000, step=True, potentialEnergy=True, temperature=True))
-simulation.step(10000)
-
- -
- -
The cornerstone for the Omnia suite of tools for predictive biomolecular simulation. Learn more
- -
- - - - - - -
- -
-

Current Citation

- Peter Eastman, Jason Swails, John D. Chodera, Robert T. McGibbon, Yutong Zhao, Kyle A. Beauchamp, Lee-Ping Wang, Andrew C. Simmonett, Matthew P. Harrigan, Chaya D. Stern, Rafal P. Wiewiora, Bernard R. Brooks, Vijay S. Pande. OpenMM 7: Rapid Development of High Performance Algorithms for Molecular Dynamics. PLoS Comput. Biol. 13:e1005659, 2017. - -

More publications

-
- -
- - -

A community of researchers and developers supporting OpenMM.

-
-
    -
  • John Chodera (MSKCC)
  • -
  • Karmen Condic-Jurkic (MSKCC)
  • -
  • Peter Eastman (Stanford)
  • -
  • Gianni de Fabritiis (Pompeu Fabra)
  • -
  • Emilio Gallicchio (Brooklyn College)
  • -
  • Tom Markland (Stanford)
  • -
  • Justin McCallum (UCalgary)
  • -
  • Vijay Pande (Stanford)
  • -
-
-
-
    -
  • Jean-Philip Piquemal (Sorbonne)
  • -
  • Jay Ponder (WashU)
  • -
  • Josh Rackers (Sandia)
  • -
  • Pengyu Ren (UT Austin)
  • -
  • Julia Rice (IBM)
  • -
  • Andy Simmonett (NIH)
  • -
  • Bill Swope (IBM)
  • -
-
-
- - -
OpenMM is currently (May 2020-Apr 2021) funded by a Chan Zuckerberg Initiative Essential Open Source Software for Science grant
- -
- -

Trusted and used by scientists around the world.

-
- -
- -
-
-
-
- - -

Performance on DHFR measured in ns/day. Details.

-
-
- - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - -
Simulation TypeCUDA (Titan X Pascal)CUDA (Titan V)CPU (Core i7-7740X)
Implicit, 2 fs92710049.4
Implicit, 5 fs HMR1528143723.2
Explicit-RF, 2 fs62669720.2
Explicit-RF, 5 fs HMR1118107145.6
Explicit-PME, 2 fs39341916.5
Explicit-PME, 5 fs HMR75278537.9
-
-
diff --git a/benchmarks.json b/benchmarks.json new file mode 100644 index 0000000..f9f7df3 --- /dev/null +++ b/benchmarks.json @@ -0,0 +1,12 @@ +{ +"dhfr": + [ + ["Simulation type" , "CUDA Titan X", "CUDA Titan V", "OpenCL Titan X", "OpenCL Titan V", "OpenCL Radeon", "CPU"], + ["Implicit, 2 fs" , 927, 1004, 672, 834, 403, 9.4], + ["Implicit, 5 fs HMR" , 1528, 1437, 771, 1089, 521, 23.2], + ["Explicit-RF, 2 fs" , 626, 697, 496, 627, 295, 20.2], + ["Explicit-RF, 5 fs HMR" , 1118, 1071, 677, 893, 463, 45.6], + ["Explicit-PME, 2 fs" , 393, 419, 316, 324, 163, 16.5], + ["Explicit-PME, 5 fs HMR", 752, 785, 496, 617, 317, 37.9] + ] +} \ No newline at end of file diff --git a/benchmarks.vue b/benchmarks.vue new file mode 100644 index 0000000..3d9dec5 --- /dev/null +++ b/benchmarks.vue @@ -0,0 +1,116 @@ + + + \ No newline at end of file diff --git a/development.vue b/development.vue new file mode 100644 index 0000000..5e1a5fa --- /dev/null +++ b/development.vue @@ -0,0 +1,100 @@ + + + \ No newline at end of file diff --git a/documentation.html b/documentation.html deleted file mode 100644 index 6cd56cb..0000000 --- a/documentation.html +++ /dev/null @@ -1,114 +0,0 @@ ---- -layout: page -title: OpenMM Documentation ---- -
-
-
-
- -

Documentation

-

Resources for finding your way around OpenMM.

-
-
-
-
- -
-
-
-
- -

The easiest way to get started is to familiarize yourself with the User Guide, which contains basics about installing OpenMM, making sure that it runs smoothly, and running a couple of example simulations.

-
-
-

- User Guide -

-

- Start here if it's your first time using OpenMM. These documents will get you up and running simulations in short order. -

-
-
-

- Dev Guide -

-

- This section provides in-depth information on the code-base and how to contribute to the development of OpenMM itself. -

-
-
-

- Python API - -

-

- The Python API provides information about the classes and methods available to Python developers. -

-
-
-

- C++ API - -

-

- The C++ API provides information about OpenMM's C++ interface. -

-
-
- - -

Every year, we hold several OpenMM workshops at Stanford University. After you have successfully installed OpenMM, here are some introductory videos from previous workshops.

-

Introduction to OpenMM

- -

Running Simulations with OpenMM

- -

- More videos -

- - -

Visit the OpenMM GitHub repo to stay up to date with the latest development version of OpenMM.

-

Development Snapshot Documentation

-
-
-

- User Guide -

-

- Start here if it's your first time using OpenMM. These documents will get you up and running simulations in short order. -

-
-
-

- Dev Guide -

-

- This section provides in-depth information on the code-base and how to contribute to the development of OpenMM itself. -

-
-
-

- Python API - -

-

- The Python API provides information about the classes and methods available to Python developers. -

-
-
-

- C++ API - -

-

- The C++ API provides information about OpenMM's C++ interface. -

-
-
- -
-
-
-
diff --git a/documentation.vue b/documentation.vue new file mode 100644 index 0000000..e7ac767 --- /dev/null +++ b/documentation.vue @@ -0,0 +1,176 @@ + + + \ No newline at end of file diff --git a/ecosystem.vue b/ecosystem.vue new file mode 100644 index 0000000..a650daa --- /dev/null +++ b/ecosystem.vue @@ -0,0 +1,153 @@ + \ No newline at end of file diff --git a/example.py b/example.py new file mode 100644 index 0000000..e8d265d --- /dev/null +++ b/example.py @@ -0,0 +1,15 @@ +from simtk.openmm.app import * +from simtk.openmm import * +from simtk.unit import * +from sys import stdout + +pdb = PDBFile('input.pdb') +forcefield = ForceField('amber99sb.xml', 'tip3p.xml') +system = forcefield.createSystem(pdb.topology, nonbondedMethod=PME, nonbondedCutoff=1*nanometer, constraints=HBonds) +integrator = LangevinIntegrator(300*kelvin, 1/picosecond, 0.002*picoseconds) +simulation = Simulation(pdb.topology, system, integrator) +simulation.context.setPositions(pdb.positions) +simulation.minimizeEnergy() +simulation.reporters.append(PDBReporter('output.pdb', 1000)) +simulation.reporters.append(StateDataReporter(stdout, 1000, step=True, potentialEnergy=True, temperature=True)) +simulation.step(10000) \ No newline at end of file diff --git a/home.vue b/home.vue new file mode 100644 index 0000000..effd105 --- /dev/null +++ b/home.vue @@ -0,0 +1,61 @@ + + + \ No newline at end of file diff --git a/index.html b/index.html index c27eaca..b076e5c 100644 --- a/index.html +++ b/index.html @@ -1,80 +1,108 @@ ---- -layout: page -title: OpenMM ---- - -
-
-
-
- -
-
- -

OpenMM

-

- A high performance toolkit for molecular simulation. Use it as a library, or as an application. We include extensive language bindings for Python, C, C++, and even Fortran. The code is open source and actively maintained on Github, licensed under MIT and LGPL. Part of the Omnia suite of tools for predictive biomolecular simulation. -

-

- About - Forum - Github -

-
-
-
-
-
-

Extreme Flexibility. Extreme Speed.

-
-
-

- Extreme flexibility through custom forces and integrators. Extreme performance through GPU Acceleration, with optimizations for AMD, NVIDIA, and Intel Integrated GPUs. It's fast on CPUs too. See the benchmarks. -

-
-
-
-
-
-

- Install -

-

- Install using the conda Python package manager that powers the Omnia ecosystem. -

-
-
-

- Docs -

-

- For more information about the science, the code base, and the API behind OpenMM. -

-
-
-

- Support -

-

- For more information about filing bug reports, requesting new features, and other issues. -

-
-
-

- Resources -

-

- Explore additional libraries and third-party tools built around OpenMM. -

-
-
-

- Tutorials -

-

- Get started right away with OpenMM tutorials. -

-
-
+ + + + + + + + + + + + + + + OpenMM + + +
+ + + + + + + mdi-home-outline + Home + + + mdi-newspaper-variant-outline + News + + + mdi-speedometer + Benchmarks + + mdi-book-open-page-variant-outline + Documentation + + + mdi-school-outline + Tutorials + + + mdi-vector-combine + Ecosystem + + + mdi-account-group-outline + Development + + + + + + + + + + + + + + + + + + Copyright © 2017-{{ new Date().getFullYear() }}, OpenMM team. + Report an issue. + Designed by raimis. + + + +
+ + + + + + + + + + + \ No newline at end of file diff --git a/news.vue b/news.vue new file mode 100644 index 0000000..3bd97d9 --- /dev/null +++ b/news.vue @@ -0,0 +1,20 @@ + + + \ No newline at end of file diff --git a/resources.html b/resources.html deleted file mode 100644 index 4ecd87a..0000000 --- a/resources.html +++ /dev/null @@ -1,33 +0,0 @@ ---- -layout: page -title: Resources ---- - -
-
-
-
- -

Resources

-

Resources that make it easier to use OpenMM.

-
-
-
-
- -
-
-
-
-

The OpenMM team has reviewed the links on this page, but we encourage the community to add their own.

- -

Omnia An open source ecosystem built around OpenMM.

-

OpenMMTools Integrators, enhanced sampling methods, test systems, and alchemical factories for OpenMM.

-

OpenMM Setup A graphical application to set up and run simulations with OpenMM. Includes pull-down menus, pop-up tips, error checking, and live script building capabilities.

-

PME Optimizer A script to optimize the performance of PME. It runs a series of simulations and selects the parameters that give best performance for simulating a particular system on particular hardware.

-

OpenMM-MD A general purpose script (with lots of comments) that uses the OpenMM Python module to drive MD simulations. Simulation options are handled via an input file. To facilitate use of the script, the available options are always printed out for you to see, along with documentation.

-
-
-
-
diff --git a/slide.vue b/slide.vue new file mode 100644 index 0000000..cb7de68 --- /dev/null +++ b/slide.vue @@ -0,0 +1,14 @@ + + + \ No newline at end of file diff --git a/support.html b/support.html deleted file mode 100644 index 0f9492b..0000000 --- a/support.html +++ /dev/null @@ -1,29 +0,0 @@ ---- -layout: page -title: OpenMM Support ---- - -
-
-
-
-

Support

-

For help on submitting bug reports, requesting features, etc.

-
-
-
-
- -
-
-
- -

Use the Issue Tracker to file bug reports. Please include as much information about your hardware, simulation parameters, and system as possible. It is highly recommended to included serialized XML files of your System, Integrator, and State objects.

-

For general help on how to use OpenMM, check out our forum or refer to our FAQ for common errors.

-

If you'd like to request a new feature to be included into the next version of OpenMM, please use the Issue Tracker. Note that we have a review process, and while we will consider all requests, we cannot guarantee that they will be implemented.

-

A list of recommended hardware is available here.

- -

We encourage developers to use our Github Repository's Issue Tracker. Note that the discussion is highly technical and is not suitable for most users.

-
-
-
diff --git a/top.vue b/top.vue new file mode 100644 index 0000000..3a0acdf --- /dev/null +++ b/top.vue @@ -0,0 +1,15 @@ + \ No newline at end of file diff --git a/tutorial.vue b/tutorial.vue new file mode 100644 index 0000000..d909b08 --- /dev/null +++ b/tutorial.vue @@ -0,0 +1,17 @@ + + + \ No newline at end of file diff --git a/tutorials.vue b/tutorials.vue new file mode 100644 index 0000000..f64ad0c --- /dev/null +++ b/tutorials.vue @@ -0,0 +1,56 @@ + + + \ No newline at end of file diff --git a/tutorials/alchemical-free-energy/index.md b/tutorials/alchemical-free-energy/index.md index ce3959b..275f154 100644 --- a/tutorials/alchemical-free-energy/index.md +++ b/tutorials/alchemical-free-energy/index.md @@ -1,9 +1,8 @@ ---- -layout: nicepage -title: Alchemical free energy calculations -lead: Computing the free energy of inserting a Lennard-Jones particle in a Lennard-Jones fluid ---- +# Alchemical free energy calculations +*Computing the free energy of inserting a Lennard-Jones particle in a Lennard-Jones fluid.* + +This tutorial is described in [OpenMM 7](http://dx.doi.org/10.1371/journal.pcbi.1005659) publication. ## Files The code for this example can be downloaded here: diff --git a/tutorials/b2ar_membrane/charmm_example.md b/tutorials/b2ar_membrane/charmm_example.md index 261996b..b9dafdf 100644 --- a/tutorials/b2ar_membrane/charmm_example.md +++ b/tutorials/b2ar_membrane/charmm_example.md @@ -1,7 +1,4 @@ ---- -layout: nicepage -title: Using CHARMM input files in OpenMM and a CHARMM-GUI example ---- +# Using CHARMM input files in OpenMM and a CHARMM-GUI example OpenMM can directly read CHARMM input files through the use of the `simtk.openmm.app` layer. This enables the use of all the powerful setup tools in the CHARMM ecosystem that a user might be familiar with such as the [CHARMM-GUI](http://onlinelibrary.wiley.com/doi/10.1002/jcc.20945/abstract), [VMD](http://www.sciencedirect.com/science/article/pii/0263785596000185?via%3Dihub), [CGenFF program](https://cgenff.paramchem.org/) diff --git a/tutorials/b2ar_membrane/index.md b/tutorials/b2ar_membrane/index.md index f971f8d..6697a52 100644 --- a/tutorials/b2ar_membrane/index.md +++ b/tutorials/b2ar_membrane/index.md @@ -1,9 +1,8 @@ ---- -layout: nicepage -title: Using OpenMM 7 to simulate the beta-2-adrenergic receptor -lead: Use CHARMM-GUI to set up a membrane protein simulation for OpenMM +# Beta-2-adrenergic receptor (B2AR) membrane protein simulation with CHARMM ---- +*Use CHARMM-GUI to set up a membrane protein simulation for OpenMM.* + +This tutorial is described in [OpenMM 7](http://dx.doi.org/10.1371/journal.pcbi.1005659) publication. ## Files diff --git a/tutorials/hkmt_tip4pew/index.md b/tutorials/hkmt_tip4pew/index.md index 7fd7a00..d81b932 100644 --- a/tutorials/hkmt_tip4pew/index.md +++ b/tutorials/hkmt_tip4pew/index.md @@ -1,8 +1,8 @@ ---- -layout: nicepage -title: Simulating a histone methyltransferase with TIP4P-Ew -lead: Simulating a protein with a multisite water model ---- +# Histone methyltransferase simulation with a multisite water model (TIP4P-Ew) + +*Simulating a protein with a multisite water model.* + +This tutorial is described in [OpenMM 7](http://dx.doi.org/10.1371/journal.pcbi.1005659) publication. ## Files diff --git a/tutorials/hkmt_zinc/index.md b/tutorials/hkmt_zinc/index.md index 594011d..2a3720e 100644 --- a/tutorials/hkmt_zinc/index.md +++ b/tutorials/hkmt_zinc/index.md @@ -1,8 +1,8 @@ ---- -layout: nicepage -title: Simulating a histone methyltransferase with structural Zn2+ ions -lead: Simulating a protein with structural zinc ions using multisite ions ---- +# Histone methyltransferase simulation with multisite Zn2+ structural ions + +*Simulating a protein with structural zinc ions using multisite ions.* + +This tutorial is described in [OpenMM 7](http://dx.doi.org/10.1371/journal.pcbi.1005659) publication. ## Files diff --git a/tutorials/hsp90_adp_mg/index.md b/tutorials/hsp90_adp_mg/index.md index fe2ca8a..e68a5fd 100644 --- a/tutorials/hsp90_adp_mg/index.md +++ b/tutorials/hsp90_adp_mg/index.md @@ -1,8 +1,6 @@ ---- -layout: nicepage -title: Simulating HSP90 with ADP:Mg2+ -lead: Simulating a protein:ligand complex with multisite solvated ions ---- +# HSP90 with ADP:Mg2+ simulation + +*Simulating a protein:ligand complex with multisite solvated ions.* ## Files @@ -110,7 +108,7 @@ quit os.system('tleap -f leaprc.hsp90') ``` -``` +```plaintext > python zeroBvalues.py This is a simple script designed to zero out the Lennard-Jones