diff --git a/2.8.0-dev0/_downloads/899668c9e2e17d4c2fc64131d19cdebc/auxiliary-1.pdf b/2.8.0-dev0/_downloads/899668c9e2e17d4c2fc64131d19cdebc/auxiliary-1.pdf index 10c9bc10..bcbabc09 100644 Binary files a/2.8.0-dev0/_downloads/899668c9e2e17d4c2fc64131d19cdebc/auxiliary-1.pdf and b/2.8.0-dev0/_downloads/899668c9e2e17d4c2fc64131d19cdebc/auxiliary-1.pdf differ diff --git a/2.8.0-dev0/examples/analysis/hydrogen_bonds/hbonds.html b/2.8.0-dev0/examples/analysis/hydrogen_bonds/hbonds.html index 59271cf1..9b6e52ba 100644 --- a/2.8.0-dev0/examples/analysis/hydrogen_bonds/hbonds.html +++ b/2.8.0-dev0/examples/analysis/hydrogen_bonds/hbonds.html @@ -266,7 +266,7 @@
the donor-hydrogen-acceptor angle (\(\theta_{DHA}\)) must be greater than a specified cutoff, typically 150°
NMP: residues 30-59 (blue)
LID: residues 122-159 (yellow)
[26]:
In stand-alone use, an auxiliary reader allows you to iterate over each step in a set of auxiliary data.
@@ -460,7 +460,7 @@The ‘description’ of any or all the auxiliaries added to a trajectory can be @@ -575,7 +575,7 @@
In [45]: import matplotlib.pyplot as plt
In [46]: plt.plot(temp["Time"], temp["Temperature"])
-Out[46]: [<matplotlib.lines.Line2D at 0x7f3006abf310>]
+Out[46]: [<matplotlib.lines.Line2D at 0x7ffbb2006650>]
In [47]: plt.ylabel("Temperature [K]")
Out[47]: Text(0, 0.5, 'Temperature [K]')
diff --git a/2.8.0-dev0/index.html b/2.8.0-dev0/index.html
index 98158853..114896f2 100644
--- a/2.8.0-dev0/index.html
+++ b/2.8.0-dev0/index.html
@@ -192,7 +192,7 @@
Welcome to MDAnalysis User Guide’s documentation!
MDAnalysis version: 2.8.0-dev0
-Last updated: Nov 05, 2024
+Last updated: Nov 08, 2024
MDAnalysis (www.mdanalysis.org) is a Python
toolkit to analyse molecular dynamics files and trajectories in many popular formats. MDAnalysis can write
most of these formats, too, together with atom selections for use in visualisation tools or other analysis programs.
diff --git a/2.8.0-dev0/reading_and_writing.html b/2.8.0-dev0/reading_and_writing.html
index 1c27a43e..58241710 100644
--- a/2.8.0-dev0/reading_and_writing.html
+++ b/2.8.0-dev0/reading_and_writing.html
@@ -320,13 +320,13 @@
Building trajectories in memoryIn [16]: universe.atoms.positions
Out[16]:
-array([[0.35116178, 0.81360424, 0.00479816],
- [0.86135435, 0.34042415, 0.5056929 ],
- [0.47003326, 0.88686156, 0.90016526],
+array([[0.22084172, 0.69380623, 0.6204634 ],
+ [0.32873678, 0.3500816 , 0.8036403 ],
+ [0.8358787 , 0.2957448 , 0.07027348],
...,
- [0.14932597, 0.07840037, 0.8601466 ],
- [0.18089604, 0.6468601 , 0.36272588],
- [0.77760845, 0.9033261 , 0.27372673]], dtype=float32)
+ [0.16618489, 0.35975078, 0.5305598 ],
+ [0.47995117, 0.5262336 , 0.41377455],
+ [0.38143802, 0.57584035, 0.6608682 ]], dtype=float32)
or they can be directly passed in when creating a Universe.
@@ -334,13 +334,13 @@C
N
CA
CA
O
C
N
THY
RG
RC5
A
DC3
THY
DA5
DT3
RU5
ADE
DG3
RU3
DA3
G
RC5
DT3
DC
RA5
RC
DA3
U
RU
RA
DA
DC5
URA
RG3
RG5
RA5
DG5
T
RC3
RA
C
A
RA3
DC3
RU5
DT5
DT
RG
URA
DG
GUA
U
RC3
RA3
CYT
DA
DG3
DC
ADE
DG5
DT
GUA
RU
RG3
DT5
DG
DA5
RG5
T
O3’
O5’
P
O3’
C3’
C5’
P
O5’
O2
N4
C2
N9
N2
O4
O6
C5
C4
O2
N1
N3
N7
C5
C2
C6
C4
N6
N7
N3
C8
N2
N9
O6
N4
O4
C5M
C3’
C1’
O4’
C2’
C3’
C4’
C1’
O4’
To mark an expected failure, use pytest.mark.xfail()
decorator:
To mark an expected failure, use pytest.mark.xfail()
decorator:
@pytest.mark.xfail
def tested_expected_failure():
assert 1 == 2
To manually fail a test, make a call to pytest.fail()
:
To manually fail a test, make a call to pytest.fail()
:
def test_open(self, tmpdir):
outfile = str(tmpdir.join('lammps-writer-test.dcd'))
try:
@@ -452,7 +452,7 @@ Failing tests
Skipping tests
-To skip tests based on a condition, use pytest.mark.skipif(condition)
decorator:
+To skip tests based on a condition, use pytest.mark.skipif(condition)
decorator:
import numpy as np
try:
from numpy import shares_memory
@@ -467,7 +467,7 @@ Skipping testsassert not np.shares_memory(original.ts.positions, copy.ts.positions)
-To skip a test if a module is not available for importing, use pytest.importorskip('module_name')
+To skip a test if a module is not available for importing, use pytest.importorskip('module_name')
def test_write_trajectory_netCDF4(self, universe, outfile):
pytest.importorskip("netCDF4")
return self._test_write_trajectory(universe, outfile)
@@ -477,7 +477,7 @@ Skipping tests
Fixtures
-Use fixtures as much as possible to reuse “resources” between test methods/functions. Pytest fixtures are functions that run before each test function that uses that fixture. A fixture is typically set up with the pytest.fixture()
decorator, over a function that returns the object you need:
+Use fixtures as much as possible to reuse “resources” between test methods/functions. Pytest fixtures are functions that run before each test function that uses that fixture. A fixture is typically set up with the pytest.fixture()
decorator, over a function that returns the object you need:
@pytest.fixture
def universe(self):
return mda.Universe(self.ref_filename)
diff --git a/dev/_downloads/899668c9e2e17d4c2fc64131d19cdebc/auxiliary-1.pdf b/dev/_downloads/899668c9e2e17d4c2fc64131d19cdebc/auxiliary-1.pdf
index 10c9bc10..bcbabc09 100644
Binary files a/dev/_downloads/899668c9e2e17d4c2fc64131d19cdebc/auxiliary-1.pdf and b/dev/_downloads/899668c9e2e17d4c2fc64131d19cdebc/auxiliary-1.pdf differ
diff --git a/dev/examples/analysis/hydrogen_bonds/hbonds.html b/dev/examples/analysis/hydrogen_bonds/hbonds.html
index 59271cf1..9b6e52ba 100644
--- a/dev/examples/analysis/hydrogen_bonds/hbonds.html
+++ b/dev/examples/analysis/hydrogen_bonds/hbonds.html
@@ -266,7 +266,7 @@ Hydrogen bonds\(r_{DA}\)) must be less than a specified cutoff, typically 3 Å
the donor-hydrogen-acceptor angle (\(\theta_{DHA}\)) must be greater than a specified cutoff, typically 150°
-
+
Find water-water hydrogen bonds
diff --git a/dev/examples/constructing_universe.html b/dev/examples/constructing_universe.html
index bc7b55f1..aad4b968 100644
--- a/dev/examples/constructing_universe.html
+++ b/dev/examples/constructing_universe.html
@@ -715,7 +715,7 @@ Adding a new segmentNMP: residues 30-59 (blue)
LID: residues 122-159 (yellow)
-
+
[26]:
diff --git a/dev/formats/auxiliary.html b/dev/formats/auxiliary.html
index c3c3b9d4..b15de9ed 100644
--- a/dev/formats/auxiliary.html
+++ b/dev/formats/auxiliary.html
@@ -261,7 +261,7 @@ Reading data directlyIn [3]: aux = mda.auxiliary.core.auxreader(XVG_BZ2)
In [4]: aux
-Out[4]: <MDAnalysis.auxiliary.XVG.XVGReader at 0x7f3006abf340>
+Out[4]: <MDAnalysis.auxiliary.XVG.XVGReader at 0x7ffbb2284c70>
In stand-alone use, an auxiliary reader allows you to iterate over each step in a set of auxiliary data.
@@ -460,7 +460,7 @@ Recreating auxiliariesIn [30]: del aux
In [31]: mda.auxiliary.core.auxreader(**description)
-Out[31]: <MDAnalysis.auxiliary.XVG.XVGReader at 0x7f300cf8d210>
+Out[31]: <MDAnalysis.auxiliary.XVG.XVGReader at 0x7ffbb1e508b0>
The ‘description’ of any or all the auxiliaries added to a trajectory can be
@@ -575,7 +575,7 @@
Standalone UsageIn [45]: import matplotlib.pyplot as plt
In [46]: plt.plot(temp["Time"], temp["Temperature"])
-Out[46]: [<matplotlib.lines.Line2D at 0x7f3006abf310>]
+Out[46]: [<matplotlib.lines.Line2D at 0x7ffbb2006650>]
In [47]: plt.ylabel("Temperature [K]")
Out[47]: Text(0, 0.5, 'Temperature [K]')
diff --git a/dev/index.html b/dev/index.html
index 98158853..114896f2 100644
--- a/dev/index.html
+++ b/dev/index.html
@@ -192,7 +192,7 @@
Welcome to MDAnalysis User Guide’s documentation!
MDAnalysis version: 2.8.0-dev0
-Last updated: Nov 05, 2024
+Last updated: Nov 08, 2024
MDAnalysis (www.mdanalysis.org) is a Python
toolkit to analyse molecular dynamics files and trajectories in many popular formats. MDAnalysis can write
most of these formats, too, together with atom selections for use in visualisation tools or other analysis programs.
diff --git a/dev/reading_and_writing.html b/dev/reading_and_writing.html
index 1c27a43e..58241710 100644
--- a/dev/reading_and_writing.html
+++ b/dev/reading_and_writing.html
@@ -320,13 +320,13 @@
Building trajectories in memoryIn [16]: universe.atoms.positions
Out[16]:
-array([[0.35116178, 0.81360424, 0.00479816],
- [0.86135435, 0.34042415, 0.5056929 ],
- [0.47003326, 0.88686156, 0.90016526],
+array([[0.22084172, 0.69380623, 0.6204634 ],
+ [0.32873678, 0.3500816 , 0.8036403 ],
+ [0.8358787 , 0.2957448 , 0.07027348],
...,
- [0.14932597, 0.07840037, 0.8601466 ],
- [0.18089604, 0.6468601 , 0.36272588],
- [0.77760845, 0.9033261 , 0.27372673]], dtype=float32)
+ [0.16618489, 0.35975078, 0.5305598 ],
+ [0.47995117, 0.5262336 , 0.41377455],
+ [0.38143802, 0.57584035, 0.6608682 ]], dtype=float32)
or they can be directly passed in when creating a Universe.
@@ -334,13 +334,13 @@ Building trajectories in memoryIn [18]: universe2.atoms.positions
Out[18]:
-array([[0.35116178, 0.81360424, 0.00479816],
- [0.86135435, 0.34042415, 0.5056929 ],
- [0.47003326, 0.88686156, 0.90016526],
+array([[0.22084172, 0.69380623, 0.6204634 ],
+ [0.32873678, 0.3500816 , 0.8036403 ],
+ [0.8358787 , 0.2957448 , 0.07027348],
...,
- [0.14932597, 0.07840037, 0.8601466 ],
- [0.18089604, 0.6468601 , 0.36272588],
- [0.77760845, 0.9033261 , 0.27372673]], dtype=float32)
+ [0.16618489, 0.35975078, 0.5305598 ],
+ [0.47995117, 0.5262336 , 0.41377455],
+ [0.38143802, 0.57584035, 0.6608682 ]], dtype=float32)
diff --git a/dev/searchindex.js b/dev/searchindex.js
index 87e5d1d5..0126d8a7 100644
--- a/dev/searchindex.js
+++ b/dev/searchindex.js
@@ -1 +1 @@
-Search.setIndex({"alltitles": {"1. Define __init__": [[16, "1.-Define-__init__"]], "2. Define your analysis in _single_frame() and other methods": [[16, "2.-Define-your-analysis-in-_single_frame()-and-other-methods"]], "2D averaging": [[48, "2D-averaging"]], "AMBER specification": [[86, "amber-specification"]], "ATOM/HETATM fields": [[81, "id2"]], "Accessing auxiliary attributes": [[57, "accessing-auxiliary-attributes"]], "Accessing the results": [[26, "Accessing-the-results"]], "Acknowledgments": [[50, "Acknowledgments"]], "Adding TopologyAttrs": [[109, "adding-topologyattrs"]], "Adding a Residue or Segment to a Universe": [[0, "adding-a-residue-or-segment-to-a-universe"]], "Adding a new segment": [[50, "Adding-a-new-segment"]], "Adding bonds": [[50, "Adding-bonds"]], "Adding changes to the UserGuide": [[4, "adding-changes-to-the-userguide"]], "Adding custom TopologyAttrs": [[0, "adding-custom-topologyattrs"]], "Adding new documentation": [[4, "adding-new-documentation"]], "Adding positions": [[50, "Adding-positions"]], "Adding to a Universe": [[109, "adding-to-a-universe"]], "Adding topology attributes": [[50, "Adding-topology-attributes"]], "Adding your code to MDAnalysis": [[3, "adding-your-code-to-mdanalysis"]], "Adding your documentation to MDAnalysis": [[3, "adding-your-documentation-to-mdanalysis"]], "Additional datasets": [[100, "additional-datasets"]], "Advanced preview with gh-pages": [[4, "advanced-preview-with-gh-pages"]], "Advanced topology concepts": [[0, null]], "Aligning a structure to another": [[9, null]], "Aligning a structure with align.alignto": [[9, "Aligning-a-structure-with-align.alignto"]], "Aligning a trajectory to a reference": [[10, null]], "Aligning a trajectory to itself": [[11, null]], "Aligning a trajectory to the first frame": [[11, "Aligning-a-trajectory-to-the-first-frame"]], "Aligning a trajectory to the third frame": [[11, "Aligning-a-trajectory-to-the-third-frame"]], "Aligning a trajectory with AlignTraj": [[10, "Aligning-a-trajectory-with-AlignTraj"]], "Aligning the trajectory to a reference": [[14, "Aligning-the-trajectory-to-a-reference"]], "Aligning trajectories": [[46, "Aligning-trajectories"]], "Alignments and RMS fitting": [[7, "alignments-and-rms-fitting"], [8, null]], "All distances between two selections": [[23, null]], "All distances within a selection": [[24, null]], "Analysing pore dimensions with HOLE2": [[30, null]], "Analysing the density of water around the protein": [[48, "Analysing-the-density-of-water-around-the-protein"]], "Analysis": [[6, null], [7, null], [53, "Analysis"]], "Apply the analysis per block": [[15, "Apply-the-analysis-per-block"]], "Assertions": [[108, "assertions"]], "Atom selection language": [[1, "atom-selection-language"], [106, null]], "Atom-wise distances between matching AtomGroups": [[22, null]], "AtomGroup": [[1, null]], "AtomGroup positions and methods": [[53, "AtomGroup-positions-and-methods"]], "Attributes parsed from AMBER keywords": [[86, "id1"]], "Automatic citations with duecredit": [[53, "Automatic-citations-with-duecredit"]], "Automatically building documentation": [[4, "automatically-building-documentation"]], "Auxiliary files": [[57, null]], "Average radial distribution functions": [[36, null]], "Azure": [[108, "azure"]], "Background": [[12, "Background"], [13, "Background"], [14, "Background"], [15, "Background"], [18, "Background"], [19, "Background"], [20, "Background"], [21, "Background"], [30, "Background"]], "Base units in MDAnalysis": [[113, "id1"]], "Before transformation": [[55, "Before-transformation"]], "Block analysis function": [[15, "Block-analysis-function"]], "Bonds": [[87, "bonds"]], "Bonds, Angles, Dihedrals, Impropers": [[60, "bonds-angles-dihedrals-impropers"]], "Boolean": [[106, "boolean"]], "Branches in MDAnalysis": [[3, "branches-in-mdanalysis"]], "Bug fixes": [[105, "bug-fixes"], [105, "id12"], [105, "id13"]], "Bug fixes and changes": [[105, "bug-fixes-and-changes"]], "Building MDAnalysis": [[3, "building-mdanalysis"]], "Building the documentation": [[3, "building-the-documentation"]], "Building the user guide": [[4, "building-the-user-guide"]], "Building trajectories in memory": [[103, "building-trajectories-in-memory"]], "CONFIG (DL_Poly Config)": [[63, null]], "COOR, NAMBDIN (NAMD binary restart files)": [[64, null]], "CRD (CHARMM CARD files)": [[65, null]], "CRYST1 fields": [[81, "id1"]], "CZI EOSS Performance Improvements:": [[105, "czi-eoss-performance-improvements"]], "Calculate hydrogen bond lifetimes": [[27, "Calculate-hydrogen-bond-lifetimes"]], "Calculating Q1 vs Q2": [[20, "Calculating-Q1-vs-Q2"]], "Calculating RMSF": [[14, "Calculating-RMSF"]], "Calculating atom-to-atom distances between non-matching coordinate arrays": [[23, "Calculating-atom-to-atom-distances-between-non-matching-coordinate-arrays"]], "Calculating atom-wise distances": [[24, "Calculating-atom-wise-distances"]], "Calculating clustering similarity with default settings": [[42, "Calculating-clustering-similarity-with-default-settings"]], "Calculating clustering similarity with multiple methods": [[42, "Calculating-clustering-similarity-with-multiple-methods"]], "Calculating clustering similarity with one method": [[42, "Calculating-clustering-similarity-with-one-method"]], "Calculating dihedral angles": [[37, "Calculating-dihedral-angles"]], "Calculating dimension reduction similarity with default settings": [[44, "Calculating-dimension-reduction-similarity-with-default-settings"]], "Calculating dimension reduction similarity with multiple methods": [[44, "Calculating-dimension-reduction-similarity-with-multiple-methods"]], "Calculating dimension reduction similarity with one method": [[44, "Calculating-dimension-reduction-similarity-with-one-method"]], "Calculating distances for each residue": [[24, "Calculating-distances-for-each-residue"]], "Calculating harmonic similarity": [[45, "Calculating-harmonic-similarity"]], "Calculating hydrogen bond lifetimes": [[27, null]], "Calculating hydrogen bonds: advanced selections": [[28, null]], "Calculating hydrogen bonds: the basics": [[26, null]], "Calculating number of contacts within a cutoff": [[21, "Calculating-number-of-contacts-within-a-cutoff"]], "Calculating residue-to-residue distances": [[23, "Calculating-residue-to-residue-distances"]], "Calculating the Clustering Ensemble Similarity between ensembles": [[42, null]], "Calculating the Dimension Reduction Ensemble Similarity between ensembles": [[44, null]], "Calculating the Harmonic Ensemble Similarity between ensembles": [[45, null]], "Calculating the RDF atom-to-atom": [[40, null]], "Calculating the average radial distribution function for a group of atoms to itself": [[36, "Calculating-the-average-radial-distribution-function-for-a-group-of-atoms-to-itself"]], "Calculating the average radial distribution function for two groups of atoms": [[36, "Calculating-the-average-radial-distribution-function-for-two-groups-of-atoms"]], "Calculating the distance between CA atoms": [[22, "Calculating-the-distance-between-CA-atoms"]], "Calculating the distance with periodic boundary conditions": [[22, "Calculating-the-distance-with-periodic-boundary-conditions"]], "Calculating the pairwise RMSD of a trajectory": [[12, null]], "Calculating the persistence length": [[31, "Calculating-the-persistence-length"]], "Calculating the root mean square deviation of atomic structures": [[13, null]], "Calculating the root mean square fluctuation over a trajectory": [[14, null]], "Calculating the site-specific radial distribution function": [[40, "Calculating-the-site-specific-radial-distribution-function"]], "Calculating the solvent density around a protein": [[48, null]], "Calculating the time constant": [[27, "Calculating-the-time-constant"]], "Canonical attributes": [[109, "canonical-attributes"]], "Centering a trajectory in the box": [[55, null]], "Centering in the box": [[55, "Centering-in-the-box"]], "Centering, aligning, and making molecules whole with on-the-fly transformations": [[48, "Centering,-aligning,-and-making-molecules-whole-with-on-the-fly-transformations"]], "Changes:": [[105, "changes"], [105, "id5"], [105, "id10"], [105, "id17"], [105, "id23"], [105, "id28"], [105, "id33"], [105, "id39"]], "Charge": [[113, "charge"]], "Choosing the chains and backbone atoms": [[31, "Choosing-the-chains-and-backbone-atoms"]], "Cirrus CI": [[108, "cirrus-ci"]], "Citations using Duecredit": [[104, "citations-using-duecredit"]], "Clean up old developer builds of the documentation": [[102, "clean-up-old-developer-builds-of-the-documentation"]], "Code formatting in Python": [[3, "code-formatting-in-python"]], "Codecov": [[108, "codecov"]], "Combine the results": [[15, "Combine-the-results"]], "Committing your code": [[3, "committing-your-code"]], "Communications": [[99, "communications"]], "Comparing different clustering methods": [[43, "Comparing-different-clustering-methods"]], "Comparing different dimensionality reduction methods": [[43, "Comparing-different-dimensionality-reduction-methods"]], "Comparing the geometric similarity of trajectories": [[46, null]], "Completing the release": [[102, "completing-the-release"]], "Computing mass and charge density on each axis": [[49, null]], "Connectivity information": [[109, "connectivity-information"]], "Constants": [[113, "constants"]], "Constructing from AtomGroups": [[114, "constructing-from-atomgroups"]], "Constructing from Atoms": [[1, "constructing-from-atoms"]], "Constructing from scratch": [[114, "constructing-from-scratch"]], "Constructing, modifying, and adding to a Universe": [[50, null]], "Contact analysis: number of contacts within a cutoff": [[21, null]], "Continuous Integration tools": [[108, "continuous-integration-tools"]], "Contributing to MDAnalysis": [[2, null], [16, "Contributing-to-MDAnalysis"]], "Contributing to the main codebase": [[3, null]], "Contributing to the user guide": [[4, null]], "Coordinates": [[58, null], [61, "coordinates"]], "Copying coordinates into a new Universe": [[10, "Copying-coordinates-into-a-new-Universe"]], "Create a blog post outlining the release": [[102, "create-a-blog-post-outlining-the-release"]], "Create a release of the UserGuide": [[102, "create-a-release-of-the-userguide"]], "Creating a Universe": [[114, "creating-a-universe"]], "Creating a blank Universe": [[50, "Creating-a-blank-Universe"]], "Creating a branch": [[3, "creating-a-branch"]], "Creating a development environment": [[3, "creating-a-development-environment"], [4, "creating-a-development-environment"]], "Creating a pull request": [[3, "creating-a-pull-request"]], "Creating an AtomGroup": [[1, "creating-an-atomgroup"]], "Creating an analysis from a function": [[16, "Creating-an-analysis-from-a-function"]], "Creating an average structure": [[14, "Creating-an-average-structure"]], "Creating and populating a Universe with water": [[50, "Creating-and-populating-a-Universe-with-water"]], "Creating with an AtomGroup": [[109, "creating-with-an-atomgroup"]], "Creating your own class": [[16, "Creating-your-own-class"]], "Custom compiler flags and optimised installations": [[100, "custom-compiler-flags-and-optimised-installations"]], "Custom transformations": [[112, "custom-transformations"]], "Custom weights": [[13, "Custom-weights"]], "DATA (LAMMPS)": [[66, null]], "DCD (CHARMM, NAMD, or LAMMPS trajectory)": [[67, null]], "DCD (Flexible LAMMPS trajectory)": [[68, null]], "DMS (Desmond Molecular Structure files)": [[69, null]], "Default values and attribute levels": [[109, "default-values-and-attribute-levels"]], "Define your own function": [[18, "Define-your-own-function"]], "Defining salt bridges": [[18, "Defining-salt-bridges"]], "Defining the groups for contact analysis": [[19, "Defining-the-groups-for-contact-analysis"], [21, "Defining-the-groups-for-contact-analysis"]], "Deleting HOLE files": [[30, "Deleting-HOLE-files"]], "Deleting from a Universe": [[109, "deleting-from-a-universe"]], "Density": [[113, "density"]], "Deprecations:": [[105, "deprecations"], [105, "id6"], [105, "id18"], [105, "id24"], [105, "id29"], [105, "id34"], [105, "id40"]], "Determining the persistence length of a polymer": [[31, null]], "Developer notes": [[86, "developer-notes"], [87, "developer-notes"], [89, "developer-notes"], [91, "developer-notes"]], "Developing in Cython": [[3, "developing-in-cython"]], "Development versions": [[100, "development-versions"]], "Diffusion maps": [[33, "Diffusion-maps"]], "Dimension reduction": [[7, "dimension-reduction"], [32, null]], "Discrete Fr\u00e9chet distances": [[46, "Discrete-Fr\u00e9chet-distances"]], "Distances and contacts": [[7, "distances-and-contacts"], [17, null]], "Documenting changes": [[3, "documenting-changes"]], "Documenting your code": [[3, "documenting-your-code"]], "Doing all this on-the-fly": [[55, "Doing-all-this-on-the-fly"]], "Dynamic selection": [[53, "Dynamic-selection"]], "Dynamic selections": [[106, "dynamic-selections"]], "Dynamically updating AtomGroups": [[1, "dynamically-updating-atomgroups"]], "EDR Files": [[57, "edr-files"]], "Elastic network analysis": [[38, null]], "Empty AtomGroups": [[1, "empty-atomgroups"]], "Enchancements:": [[105, "enchancements"], [105, "id16"]], "Energy": [[113, "energy"]], "Enhancements:": [[105, "enhancements"], [105, "id4"], [105, "id22"], [105, "id26"], [105, "id31"], [105, "id37"]], "Ensure PEP8 compliance (mandatory) and format your code with Darker (optional)": [[3, "ensure-pep8-compliance-mandatory-and-format-your-code-with-darker-optional"]], "Estimating the error in a clustering ensemble similarity analysis": [[42, "Estimating-the-error-in-a-clustering-ensemble-similarity-analysis"]], "Estimating the error in a dimension reduction ensemble similarity analysis": [[44, "Estimating-the-error-in-a-dimension-reduction-ensemble-similarity-analysis"]], "Evaluating convergence": [[43, null]], "Evaluating convergence with similarity measures": [[43, "Evaluating-convergence-with-similarity-measures"]], "Example data": [[5, null]], "Example workflows": [[112, "example-workflows"]], "Examples": [[6, null]], "Failing tests": [[108, "failing-tests"]], "Find all hydrogen bonds": [[27, "Find-all-hydrogen-bonds"], [28, "Find-all-hydrogen-bonds"]], "Find water-water hydrogen bonds": [[26, "Find-water-water-hydrogen-bonds"]], "Fixes:": [[105, "fixes"], [105, "id3"], [105, "id9"], [105, "id15"], [105, "id21"], [105, "id27"], [105, "id32"], [105, "id38"]], "Fixtures": [[108, "fixtures"]], "Force": [[113, "force"]], "Forking": [[3, "forking"]], "Forking and cloning the User Guide": [[4, "forking-and-cloning-the-user-guide"]], "Format overview": [[61, null]], "Format reference": [[59, null]], "Format-specific attributes": [[109, "format-specific-attributes"]], "Fraction of native contacts over a trajectory": [[19, null]], "Fragments": [[98, "fragments"]], "Frame-wise form of the function": [[15, "Frame-wise-form-of-the-function"]], "Frames and trajectories": [[103, "frames-and-trajectories"]], "Frequently asked questions": [[56, null]], "Further analysis": [[26, "Further-analysis"]], "GMS (Gamess trajectory)": [[70, null]], "GRO (GROMACS structure file)": [[71, null]], "GROMACS entries used to create angles.": [[87, "id3"]], "GROMACS entries used to create bonds.": [[87, "id2"]], "GROMACS entries used to create dihedrals.": [[87, "id4"]], "GROMACS entries used to create improper dihedrals.": [[87, "id5"]], "GSD (HOOMD GSD file)": [[72, null]], "General": [[6, null]], "General conventions": [[108, "general-conventions"]], "General rules for importing": [[101, "general-rules-for-importing"]], "Generating paths": [[46, "Generating-paths"]], "Geometric": [[106, "geometric"]], "Getting atom information from AtomGroups": [[53, "Getting-atom-information-from-AtomGroups"]], "Getting started with Git": [[2, "getting-started-with-git"]], "Getting the develop branch ready for a release": [[102, "getting-the-develop-branch-ready-for-a-release"]], "GitHub Actions": [[108, "github-actions"]], "Group operators and set methods": [[1, "group-operators-and-set-methods"]], "Groupby and split": [[1, "groupby-and-split"]], "Groups of atoms": [[98, null]], "Guessing": [[60, null]], "Guessing topology attributes": [[114, "guessing-topology-attributes"]], "Guidelines for writing docstrings": [[3, "guidelines-for-writing-docstrings"]], "HISTORY (DL_Poly Config)": [[63, "history-dl-poly-config"]], "Hard cutoff with a single reference": [[19, "Hard-cutoff-with-a-single-reference"]], "Hausdorff method": [[46, "Hausdorff-method"]], "Helix analysis": [[39, null], [39, "id6"]], "Helper functions": [[26, "Helper-functions"]], "Hydrogen Bond Analysis": [[7, "hydrogen-bond-analysis"], [25, null]], "Hydrogen bond lifetime of individual hydrogen bonds": [[27, "Hydrogen-bond-lifetime-of-individual-hydrogen-bonds"]], "Hydrogen bonds": [[26, "Hydrogen-bonds"]], "Hydrogen bonds between specific groups": [[28, "Hydrogen-bonds-between-specific-groups"]], "IN, FHIAIMS (FHI-aims input files)": [[73, null]], "INPCRD, RESTRT (AMBER restart files)": [[74, null]], "ITP (GROMACS portable topology files)": [[75, null]], "Imports and dependencies": [[7, "imports-and-dependencies"]], "In-memory trajectories": [[103, "in-memory-trajectories"]], "In-memory trajectories of an atom selection": [[103, "in-memory-trajectories-of-an-atom-selection"]], "Increment develop branch files ready for the next version": [[102, "increment-develop-branch-files-ready-for-the-next-version"]], "Index": [[106, "index"]], "Indexing and slicing": [[1, "indexing-and-slicing"]], "Input": [[103, "input"]], "Installation": [[100, null]], "Intermittent lifetime": [[27, "Intermittent-lifetime"]], "Iterating over auxiliary data": [[57, "iterating-over-auxiliary-data"]], "Janin analysis": [[37, "Janin-analysis"]], "Jupyter notebook files": [[4, "jupyter-notebook-files"]], "Known issues:": [[105, "known-issues"]], "Known test failures:": [[105, "known-test-failures"], [105, "id35"]], "LAMMPSDUMP (LAMMPS ascii dump file)": [[76, null]], "Length": [[113, "length"]], "List of core module dependencies": [[101, "list-of-core-module-dependencies"]], "Loading a structure or trajectory": [[53, "Loading-a-structure-or-trajectory"]], "Loading data into a Universe": [[57, "loading-data-into-a-universe"]], "Loading files": [[9, "Loading-files"], [10, "Loading-files"], [11, "Loading-files"], [12, "Loading-files"], [13, "Loading-files"], [14, "Loading-files"], [15, "Loading-files"], [16, "Loading-files"], [18, "Loading-files"], [19, "Loading-files"], [20, "Loading-files"], [21, "Loading-files"], [22, "Loading-files"], [23, "Loading-files"], [24, "Loading-files"], [26, "Loading-files"], [27, "Loading-files"], [28, "Loading-files"], [31, "Loading-files"], [33, "Loading-files"], [34, "Loading-files"], [36, "Loading-files"], [37, "Loading-files"], [38, "Loading-files"], [39, "Loading-files"], [40, "Loading-files"], [42, "Loading-files"], [43, "Loading-files"], [44, "Loading-files"], [45, "Loading-files"], [46, "Loading-files"], [48, "Loading-files"], [49, "Loading-files"], [55, "Loading-files"]], "Loading files: the difference between ParmEd and MDAnalysis": [[52, "Loading-files:-the-difference-between-ParmEd-and-MDAnalysis"]], "Loading from files": [[114, "loading-from-files"]], "MDAnalysis Release Notes": [[105, null]], "MDAnalysisData": [[5, "mdanalysisdata"]], "MDAnalysisTests": [[5, "mdanalysistests"]], "MMTF (Macromolecular Transmission Format)": [[77, null]], "MOL2 (Tripos structure)": [[78, null]], "MOL2 specification": [[78, "mol2-specification"]], "Major changes:": [[105, "major-changes"], [105, "id2"], [105, "id8"], [105, "id14"], [105, "id20"], [105, "id25"], [105, "id30"], [105, "id36"]], "Manually upload Cirrus CI wheels (temporary)": [[102, "manually-upload-cirrus-ci-wheels-temporary"]], "Mass": [[13, "Mass"]], "Masses": [[60, "masses"]], "Measuring convergence with cosine content": [[34, "Measuring-convergence-with-cosine-content"]], "Memory Usage": [[57, "memory-usage"]], "Merging with a protein": [[50, "Merging-with-a-protein"]], "Methods": [[1, "methods"]], "Modifying TopologyAttrs": [[109, "modifying-topologyattrs"]], "Module dependencies in the code": [[101, "module-dependencies-in-the-code"]], "Module imports": [[108, "module-imports"]], "Module imports in MDAnalysis": [[101, null]], "Module imports in MDAnalysis.analysis": [[101, "module-imports-in-mdanalysis-analysis"]], "Module imports in the test suite": [[101, "module-imports-in-the-test-suite"]], "Modules and dependencies": [[3, "modules-and-dependencies"]], "Modules in the \u201ccore\u201d": [[101, "modules-in-the-core"]], "Molecules": [[0, "molecules"]], "More advanced selections": [[28, "More-advanced-selections"]], "Multiple references": [[19, "Multiple-references"]], "Multiple selections": [[96, "multiple-selections"]], "NCDF, NC (AMBER NetCDF trajectory)": [[79, null]], "New Contributors": [[105, "new-contributors"], [105, "id1"], [105, "id7"], [105, "id11"], [105, "id19"]], "Non-linear dimension reduction to diffusion maps": [[33, null]], "Note": [[95, "note"]], "Notes:": [[105, "notes"]], "Nucleic acids": [[107, "nucleic-acids"]], "Nucleic backbone": [[107, "nucleic-backbone"]], "Nucleic sugars": [[107, "nucleic-sugars"]], "Nucleobases": [[107, "nucleobases"]], "On a Mac": [[3, "on-a-mac"]], "On the hole2 notebook": [[4, "on-the-hole2-notebook"]], "On-the-fly transformations": [[112, null]], "Optional modules in MDAnalysis.analysis and MDAnalysis.visualization": [[101, "optional-modules-in-mdanalysis-analysis-and-mdanalysis-visualization"]], "Optional steps and tips": [[4, "optional-steps-and-tips"]], "Order and uniqueness": [[1, "order-and-uniqueness"]], "Ordered selections": [[106, "ordered-selections"]], "Ordering HOLE profiles with an order parameter": [[30, "Ordering-HOLE-profiles-with-an-order-parameter"]], "Other": [[51, null]], "Other possible parallelism approaches for multiple analyses": [[15, "Other-possible-parallelism-approaches-for-multiple-analyses"]], "Output": [[103, "output"]], "Overview": [[4, "overview"], [53, "Overview"]], "PDB format with AutoDOCK extensions for the PDBQT format.": [[82, "id1"]], "PDB specification": [[81, "pdb-specification"]], "PDB, ENT (Standard PDB file)": [[81, null]], "PDBQT (Autodock structure)": [[82, null]], "PDBQT specification": [[82, "pdbqt-specification"]], "PQR file (PDB2PQR / APBS)": [[83, null]], "PQR specification": [[83, "pqr-specification"]], "PSF (CHARMM, NAMD, or XPLOR protein structure file)": [[84, null]], "PSF specification": [[84, "psf-specification"]], "Packaging the release": [[102, "packaging-the-release"]], "Pairwise RMSD between two trajectories": [[12, "Pairwise-RMSD-between-two-trajectories"]], "Pairwise RMSD of a trajectory to itself": [[12, "Pairwise-RMSD-of-a-trajectory-to-itself"]], "Parallelization in a simple per-frame fashion": [[15, "Parallelization-in-a-simple-per-frame-fashion"]], "Parallelization in a split-apply-combine fashion": [[15, "Parallelization-in-a-split-apply-combine-fashion"]], "Parallelization with dask": [[15, "Parallelization-with-dask"]], "Parallelization with multiprocessing": [[15, "Parallelization-with-multiprocessing"]], "Parallelizing analysis": [[15, null]], "ParmEd (ParmEd Structure)": [[80, null]], "Participating": [[99, "participating"]], "Passing arguments to auxiliary data": [[57, "passing-arguments-to-auxiliary-data"]], "Pickling": [[103, "pickling"]], "Plotting": [[18, "Plotting"], [19, "Plotting"], [19, "id6"], [19, "id7"], [20, "Plotting"], [21, "Plotting"], [22, "Plotting"], [22, "id4"], [23, "Plotting"], [24, "Plotting"], [24, "id4"], [30, "Plotting"], [30, "id8"], [37, "Plotting"], [42, "Plotting"], [42, "id5"], [42, "id6"], [44, "Plotting"], [44, "id5"], [44, "id6"], [45, "Plotting"], [46, "Plotting"], [46, "id5"]], "Plotting RMSF": [[14, "Plotting-RMSF"]], "Plotting distance as a heatmap": [[23, "Plotting-distance-as-a-heatmap"]], "Plotting the data": [[13, "Plotting-the-data"]], "Polymers and membranes": [[7, "polymers-and-membranes"], [29, null]], "Preexisting selections and modifiers": [[106, "preexisting-selections-and-modifiers"]], "Preparing a release": [[102, null]], "Principal component analysis": [[34, "Principal-component-analysis"]], "Principal component analysis of a trajectory": [[34, null]], "Protein backbone": [[107, "protein-backbone"]], "Protein dihedral angle analysis": [[37, null]], "Proteins": [[107, "proteins"]], "Pushing your code to GitHub": [[3, "pushing-your-code-to-github"]], "Q1 vs Q2 contact analysis": [[20, null]], "Quick start guide": [[53, null]], "RMSD": [[53, "RMSD"]], "RMSD between two sets of coordinates": [[13, "RMSD-between-two-sets-of-coordinates"]], "RMSD of a Universe with multiple selections": [[13, "RMSD-of-a-Universe-with-multiple-selections"]], "RMSD of an AtomGroup with multiple selections": [[13, "RMSD-of-an-AtomGroup-with-multiple-selections"]], "Radius cutoff": [[19, "Radius-cutoff"]], "Radius of gyration": [[15, "Radius-of-gyration"], [16, "Radius-of-gyration"]], "Ramachandran analysis": [[37, "Ramachandran-analysis"]], "Reading and writing files": [[103, null]], "Reading data directly": [[57, "reading-data-directly"]], "Reading in": [[65, "reading-in"], [66, "reading-in"], [67, "reading-in"], [70, "reading-in"], [71, "reading-in"], [72, "reading-in"], [76, "reading-in"], [79, "reading-in"], [81, "reading-in"], [82, "reading-in"], [83, "reading-in"], [84, "reading-in"], [85, "reading-in"], [88, "reading-in"], [89, "reading-in"], [94, "reading-in"], [95, "reading-in"]], "Reading in selections": [[96, "reading-in-selections"]], "Reading multiple trajectories": [[103, "reading-multiple-trajectories"]], "Reading trajectories into memory": [[103, "reading-trajectories-into-memory"]], "Rebasing your code": [[3, "rebasing-your-code"]], "Recreating auxiliaries": [[57, "recreating-auxiliaries"]], "References": [[9, "References"], [10, "References"], [11, "References"], [12, "References"], [13, "References"], [14, "References"], [15, "References"], [16, "References"], [18, "References"], [19, "References"], [20, "References"], [21, "References"], [22, "References"], [23, "References"], [24, "References"], [26, "References"], [27, "References"], [28, "References"], [30, "References"], [31, "References"], [33, "References"], [34, "References"], [36, "References"], [37, "References"], [38, "References"], [39, "References"], [40, "References"], [42, "References"], [43, "References"], [44, "References"], [45, "References"], [45, "id5"], [46, "References"], [48, "References"], [49, "References"], [50, "References"], [52, "References"], [53, "References"], [55, "References"], [104, null]], "Release 2.0.0 of MDAnalysis": [[105, "release-2-0-0-of-mdanalysis"]], "Release 2.1.0 of MDAnalysis": [[105, "release-2-1-0-of-mdanalysis"]], "Release 2.2.0 of MDAnalysis": [[105, "release-2-2-0-of-mdanalysis"]], "Release 2.3.0 of MDAnalysis": [[105, "release-2-3-0-of-mdanalysis"]], "Release 2.4.0 of MDAnalysis": [[105, "release-2-4-0-of-mdanalysis"]], "Release 2.4.1 of MDAnalysis": [[105, "release-2-4-1-of-mdanalysis"]], "Release 2.4.2 of MDAnalysis": [[105, "release-2-4-2-of-mdanalysis"]], "Release 2.4.3 of MDAnalysis": [[105, "release-2-4-3-of-mdanalysis"]], "Release 2.5.0 of MDAnalysis": [[105, "release-2-5-0-of-mdanalysis"]], "Release 2.6.0 of MDAnalysis": [[105, "release-2-6-0-of-mdanalysis"]], "Release 2.6.1 of MDAnalysis": [[105, "release-2-6-1-of-mdanalysis"]], "Release 2.7.0 of MDAnalysis": [[105, "release-2-7-0-of-mdanalysis"]], "Release policy and release numbering": [[102, "release-policy-and-release-numbering"]], "Residues and Segments": [[98, "residues-and-segments"]], "Running the analysis": [[39, "Running-the-analysis"]], "Running the test suite": [[108, "running-the-test-suite"]], "Sanitization": [[4, "sanitization"]], "See Also": [[15, "See-Also"]], "Selecting Trajectory Frames Based on Auxiliary Data": [[57, "selecting-trajectory-frames-based-on-auxiliary-data"]], "Selecting atoms": [[53, "Selecting-atoms"]], "Selecting dihedral atom groups": [[37, "Selecting-dihedral-atom-groups"]], "Selection Keywords": [[106, "selection-keywords"]], "Selection exporters": [[96, null]], "Serial Analysis": [[15, "Serial-Analysis"]], "Similarity and connectivity": [[106, "similarity-and-connectivity"]], "Simple selections": [[106, "simple-selections"]], "Single AtomGroup": [[96, "single-atomgroup"]], "Single frame": [[53, "Single-frame"]], "Skipping tests": [[108, "skipping-tests"]], "Slicing trajectories": [[110, null]], "Soft cutoff": [[19, "Soft-cutoff"]], "Soft cutoff and multiple references": [[19, "Soft-cutoff-and-multiple-references"]], "Speed": [[113, "speed"]], "Split the trajectory": [[15, "Split-the-trajectory"]], "Standalone Usage": [[57, "standalone-usage"]], "Standard residues in MDAnalysis selections": [[107, null]], "Store data": [[26, "Store-data"]], "Structure": [[7, "structure"], [35, null]], "Summary of tasks": [[102, "summary-of-tasks"]], "Supported formats": [[57, "supported-formats"]], "Supported selection exporters": [[96, "id2"]], "Supported versions": [[87, "supported-versions"]], "TNG (Trajectory Next Generation)": [[85, null]], "TOP, PRMTOP, PARM7 (AMBER topology)": [[86, null]], "TPR (GROMACS run topology files)": [[87, null]], "TPR format versions and generations read by MDAnalysis.topology.TPRParser.parse().": [[87, "id1"]], "TPR specification": [[87, "tpr-specification"]], "TRJ, MDCRD, CRDBOX (AMBER ASCII trajectory)": [[88, null]], "TRR (GROMACS lossless trajectory file)": [[89, null]], "TRZ (IBIsCO and YASP trajectory)": [[90, null]], "TXYZ, ARC (Tinker)": [[91, null]], "Table of all supported formats in MDAnalysis": [[61, "id10"]], "Table of supported coordinate readers and the information read": [[58, "id2"], [61, "id12"]], "Table of supported topology parsers and the attributes read": [[61, "id11"], [97, "id1"]], "Temporary files and directories": [[108, "temporary-files-and-directories"]], "Test coverage": [[108, "test-coverage"]], "Test with pytest and nbval": [[4, "test-with-pytest-and-nbval"]], "Testing": [[100, "testing"]], "Testing exceptions and warnings": [[108, "testing-exceptions-and-warnings"]], "Testing in parallel": [[108, "testing-in-parallel"]], "Testing the same function with different inputs": [[108, "testing-the-same-function-with-different-inputs"]], "Testing your code": [[3, "testing-your-code"]], "Tests for analysis and visualization modules": [[108, "tests-for-analysis-and-visualization-modules"]], "Tests in MDAnalysis": [[108, null]], "The site-specific RDF without densities": [[40, "The-site-specific-RDF-without-densities"]], "The topology system": [[109, null]], "Tiling into a larger Universe": [[50, "Tiling-into-a-larger-Universe"]], "Time": [[113, "time"]], "Topology": [[61, "topology"], [97, null]], "Topology attributes": [[109, "topology-attributes"]], "Topology objects": [[109, "topology-objects"]], "Topology-specific methods": [[109, "topology-specific-methods"]], "Trajectories": [[53, "Trajectories"], [56, "trajectories"], [111, null]], "Trajectory formats": [[103, "trajectory-formats"]], "Trajectory similarity": [[7, "trajectory-similarity"], [41, null]], "Transferring trajectories into memory": [[103, "transferring-trajectories-into-memory"]], "Transformations": [[54, null]], "Transforming a function into a class": [[16, "Transforming-a-function-into-a-class"]], "Trying out different clustering parameters": [[42, "Trying-out-different-clustering-parameters"]], "Trying out different dimension reduction parameters": [[44, "Trying-out-different-dimension-reduction-parameters"]], "Types": [[60, "types"]], "Typical workflow for preparing a release": [[102, "typical-workflow-for-preparing-a-release"]], "Unit Handling": [[57, "unit-handling"]], "Unit conversion": [[113, "unit-conversion"]], "Units and constants": [[113, null]], "Universe": [[114, null]], "Universe properties and methods": [[114, "universe-properties-and-methods"]], "Unwrapping the protein": [[55, "Unwrapping-the-protein"]], "Update conda-forge packages": [[102, "update-conda-forge-packages"]], "Use case: Atoms list grouped by residues": [[98, "use-case-atoms-list-grouped-by-residues"]], "Use case: Sequence of residues by segment": [[98, "use-case-sequence-of-residues-by-segment"]], "Use guess_acceptors and guess_hydrogens to create atom selections": [[28, "Use-guess_acceptors-and-guess_hydrogens-to-create-atom-selections"]], "Use with Trajectories": [[57, "use-with-trajectories"]], "Using HOLE with a PDB file": [[30, "Using-HOLE-with-a-PDB-file"]], "Using HOLE with a trajectory": [[30, "Using-HOLE-with-a-trajectory"]], "Using MDAnalysis to select atoms": [[52, "Using-MDAnalysis-to-select-atoms"]], "Using ParmEd and OpenMM to create a simulation system": [[52, "Using-ParmEd-and-OpenMM-to-create-a-simulation-system"]], "Using ParmEd with MDAnalysis and OpenMM to simulate a selection of atoms": [[52, null]], "Using a Gaussian network model": [[38, "Using-a-Gaussian-network-model"]], "Using a Gaussian network model with only close contacts": [[38, "Using-a-Gaussian-network-model-with-only-close-contacts"]], "Using default arguments with clustering ensemble similarity": [[43, "Using-default-arguments-with-clustering-ensemble-similarity"]], "Using default arguments with dimension reduction ensemble similarity": [[43, "Using-default-arguments-with-dimension-reduction-ensemble-similarity"]], "Using pre-commit hooks": [[4, "using-pre-commit-hooks"]], "Using test data files": [[108, "using-test-data-files"]], "Version control, Git, and GitHub": [[2, "version-control-git-and-github"]], "Viewing the documentation interactively": [[3, "viewing-the-documentation-interactively"]], "Visualisation": [[48, "Visualisation"]], "Visualising RMSF as B-factors": [[14, "Visualising-RMSF-as-B-factors"]], "Visualising projections into a reduced dimensional space": [[34, "Visualising-projections-into-a-reduced-dimensional-space"]], "Visualising the VMD surface": [[30, "Visualising-the-VMD-surface"]], "Volumetric analyses": [[7, "volumetric-analyses"], [47, null]], "Weighted RMSD of a trajectory": [[13, "Weighted-RMSD-of-a-trajectory"]], "Welcome to MDAnalysis User Guide\u2019s documentation!": [[99, null]], "What file to edit": [[4, "what-file-to-edit"]], "Where to start?": [[2, "where-to-start"]], "Where to write docstrings": [[3, "where-to-write-docstrings"]], "Why MDAnalysis?": [[99, "why-mdanalysis"]], "Why do the atom positions change over trajectories?": [[56, "why-do-the-atom-positions-change-over-trajectories"]], "With conda-forge packages": [[3, "with-conda-forge-packages"]], "With mamba/conda": [[3, "with-mamba-conda"]], "With pip and virtualenv": [[3, "with-pip-and-virtualenv"], [3, "id1"]], "Working with groups of atoms": [[53, "Working-with-groups-of-atoms"]], "Working with the code": [[3, "working-with-the-code"]], "Working with the code documentation": [[3, "working-with-the-code-documentation"]], "Working with the data": [[30, "Working-with-the-data"]], "Working with trajectories": [[53, "Working-with-trajectories"]], "Wrapping the solvent back into the box": [[55, "Wrapping-the-solvent-back-into-the-box"]], "Write your own native contacts analysis method": [[18, null]], "Writing docs for abstract base classes": [[3, "writing-docs-for-abstract-base-classes"]], "Writing new code": [[3, "writing-new-code"]], "Writing new tests": [[108, "writing-new-tests"]], "Writing out": [[65, "writing-out"], [66, "writing-out"], [67, "writing-out"], [71, "writing-out"], [79, "writing-out"], [81, "writing-out"], [82, "writing-out"], [83, "writing-out"], [89, "writing-out"]], "Writing out coordinates": [[53, "Writing-out-coordinates"]], "Writing selections": [[96, "writing-selections"]], "Writing trajectories to a file": [[10, "Writing-trajectories-to-a-file"]], "Writing your own trajectory analysis": [[16, null]], "XML (HOOMD)": [[92, null]], "XPDB (Extended PDB file)": [[93, null]], "XTC (GROMACS compressed trajectory file)": [[94, null]], "XVG Files": [[57, "xvg-files"]], "XYZ specification": [[95, "xyz-specification"]], "XYZ trajectory": [[95, null]], "chemfiles (chemfiles Trajectory or file)": [[62, null]], "conda": [[100, "conda"]], "matplotlib (3D static plot)": [[48, "matplotlib-(3D-static-plot)"]], "nglview (interactive)": [[48, "nglview-(interactive)"]], "pip": [[100, "pip"]], "pyvista (3D surface)": [[48, "pyvista-(3D-surface)"]], "reStructuredText files": [[4, "restructuredtext-files"]], "scikit-image (triangulated surface)": [[48, "scikit-image-(triangulated-surface)"]], "segid and chainID": [[87, "segid-and-chainid"]]}, "docnames": ["advanced_topology", "atomgroup", "contributing", "contributing_code", "contributing_docs", "datasets", "examples/README", "examples/analysis/README", "examples/analysis/alignment_and_rms/README", "examples/analysis/alignment_and_rms/aligning_structure_to_another", "examples/analysis/alignment_and_rms/aligning_trajectory", "examples/analysis/alignment_and_rms/aligning_trajectory_to_frame", "examples/analysis/alignment_and_rms/pairwise_rmsd", "examples/analysis/alignment_and_rms/rmsd", "examples/analysis/alignment_and_rms/rmsf", "examples/analysis/custom_parallel_analysis", "examples/analysis/custom_trajectory_analysis", "examples/analysis/distances_and_contacts/README", "examples/analysis/distances_and_contacts/contacts_custom", "examples/analysis/distances_and_contacts/contacts_native_fraction", "examples/analysis/distances_and_contacts/contacts_q1q2", "examples/analysis/distances_and_contacts/contacts_within_cutoff", "examples/analysis/distances_and_contacts/distances_between_atomgroups", "examples/analysis/distances_and_contacts/distances_between_selections", "examples/analysis/distances_and_contacts/distances_within_selection", "examples/analysis/hydrogen_bonds/README", "examples/analysis/hydrogen_bonds/hbonds", "examples/analysis/hydrogen_bonds/hbonds-lifetimes", "examples/analysis/hydrogen_bonds/hbonds-selections", "examples/analysis/polymers_and_membranes/README", "examples/analysis/polymers_and_membranes/hole2", "examples/analysis/polymers_and_membranes/polymer", "examples/analysis/reduced_dimensions/README", "examples/analysis/reduced_dimensions/diffusion_map", "examples/analysis/reduced_dimensions/pca", "examples/analysis/structure/README", "examples/analysis/structure/average_rdf", "examples/analysis/structure/dihedrals", "examples/analysis/structure/elastic_network", "examples/analysis/structure/helanal", "examples/analysis/structure/site_specific_rdf", "examples/analysis/trajectory_similarity/README", "examples/analysis/trajectory_similarity/clustering_ensemble_similarity", "examples/analysis/trajectory_similarity/convergence", "examples/analysis/trajectory_similarity/dimension_reduction_ensemble_similarity", "examples/analysis/trajectory_similarity/harmonic_ensemble_similarity", "examples/analysis/trajectory_similarity/psa", "examples/analysis/volumetric/README", "examples/analysis/volumetric/density_analysis", "examples/analysis/volumetric/linear_density", "examples/constructing_universe", "examples/other/README", "examples/other/parmed_sim", "examples/quickstart", "examples/transformations/README", "examples/transformations/center_protein_in_box", "faq", "formats/auxiliary", "formats/coordinates", "formats/format_reference", "formats/guessing", "formats/index", "formats/reference/chemfiles", "formats/reference/config", "formats/reference/coor", "formats/reference/crd", "formats/reference/data", "formats/reference/dcd", "formats/reference/dcd_lammps", "formats/reference/dms", "formats/reference/gms", "formats/reference/gro", "formats/reference/gsd", "formats/reference/in", "formats/reference/inpcrd", "formats/reference/itp", "formats/reference/lammpsdump", "formats/reference/mmtf", "formats/reference/mol2", "formats/reference/ncdf", "formats/reference/parmed", "formats/reference/pdb", "formats/reference/pdbqt", "formats/reference/pqr", "formats/reference/psf", "formats/reference/tng", "formats/reference/top", "formats/reference/tpr", "formats/reference/trj", "formats/reference/trr", "formats/reference/trz", "formats/reference/txyz", "formats/reference/xml", "formats/reference/xpdb", "formats/reference/xtc", "formats/reference/xyz", "formats/selection_exporters", "formats/topology", "groups_of_atoms", "index", "installation", "module_imports", "preparing_releases_and_hotfixes", "reading_and_writing", "references", "releases", "selections", "standard_selections", "testing", "topology_system", "trajectories/slicing_trajectories", "trajectories/trajectories", "trajectories/transformations", "units", "universe"], "envversion": {"nbsphinx": 4, "sphinx": 64, "sphinx.domains.c": 3, "sphinx.domains.changeset": 1, "sphinx.domains.citation": 1, "sphinx.domains.cpp": 9, "sphinx.domains.index": 1, "sphinx.domains.javascript": 3, "sphinx.domains.math": 2, "sphinx.domains.python": 4, "sphinx.domains.rst": 2, "sphinx.domains.std": 2, "sphinx.ext.intersphinx": 1, "sphinx.ext.viewcode": 1, "sphinxcontrib.bibtex": 9}, "filenames": ["advanced_topology.rst", "atomgroup.rst", "contributing.rst", "contributing_code.rst", "contributing_docs.rst", "datasets.rst", "examples/README.rst", "examples/analysis/README.rst", "examples/analysis/alignment_and_rms/README.rst", "examples/analysis/alignment_and_rms/aligning_structure_to_another.ipynb", "examples/analysis/alignment_and_rms/aligning_trajectory.ipynb", "examples/analysis/alignment_and_rms/aligning_trajectory_to_frame.ipynb", "examples/analysis/alignment_and_rms/pairwise_rmsd.ipynb", "examples/analysis/alignment_and_rms/rmsd.ipynb", "examples/analysis/alignment_and_rms/rmsf.ipynb", "examples/analysis/custom_parallel_analysis.ipynb", "examples/analysis/custom_trajectory_analysis.ipynb", "examples/analysis/distances_and_contacts/README.rst", "examples/analysis/distances_and_contacts/contacts_custom.ipynb", "examples/analysis/distances_and_contacts/contacts_native_fraction.ipynb", "examples/analysis/distances_and_contacts/contacts_q1q2.ipynb", "examples/analysis/distances_and_contacts/contacts_within_cutoff.ipynb", "examples/analysis/distances_and_contacts/distances_between_atomgroups.ipynb", "examples/analysis/distances_and_contacts/distances_between_selections.ipynb", "examples/analysis/distances_and_contacts/distances_within_selection.ipynb", "examples/analysis/hydrogen_bonds/README.rst", "examples/analysis/hydrogen_bonds/hbonds.ipynb", "examples/analysis/hydrogen_bonds/hbonds-lifetimes.ipynb", "examples/analysis/hydrogen_bonds/hbonds-selections.ipynb", "examples/analysis/polymers_and_membranes/README.rst", "examples/analysis/polymers_and_membranes/hole2.ipynb", "examples/analysis/polymers_and_membranes/polymer.ipynb", "examples/analysis/reduced_dimensions/README.rst", "examples/analysis/reduced_dimensions/diffusion_map.ipynb", "examples/analysis/reduced_dimensions/pca.ipynb", "examples/analysis/structure/README.rst", "examples/analysis/structure/average_rdf.ipynb", "examples/analysis/structure/dihedrals.ipynb", "examples/analysis/structure/elastic_network.ipynb", "examples/analysis/structure/helanal.ipynb", "examples/analysis/structure/site_specific_rdf.ipynb", "examples/analysis/trajectory_similarity/README.rst", "examples/analysis/trajectory_similarity/clustering_ensemble_similarity.ipynb", "examples/analysis/trajectory_similarity/convergence.ipynb", "examples/analysis/trajectory_similarity/dimension_reduction_ensemble_similarity.ipynb", "examples/analysis/trajectory_similarity/harmonic_ensemble_similarity.ipynb", "examples/analysis/trajectory_similarity/psa.ipynb", "examples/analysis/volumetric/README.rst", "examples/analysis/volumetric/density_analysis.ipynb", "examples/analysis/volumetric/linear_density.ipynb", "examples/constructing_universe.ipynb", "examples/other/README.rst", "examples/other/parmed_sim.ipynb", "examples/quickstart.ipynb", "examples/transformations/README.rst", "examples/transformations/center_protein_in_box.ipynb", "faq.rst", "formats/auxiliary.rst", "formats/coordinates.rst", "formats/format_reference.rst", "formats/guessing.rst", "formats/index.rst", "formats/reference/chemfiles.rst", "formats/reference/config.rst", "formats/reference/coor.rst", "formats/reference/crd.rst", "formats/reference/data.rst", "formats/reference/dcd.rst", "formats/reference/dcd_lammps.rst", "formats/reference/dms.rst", "formats/reference/gms.rst", "formats/reference/gro.rst", "formats/reference/gsd.rst", "formats/reference/in.rst", "formats/reference/inpcrd.rst", "formats/reference/itp.rst", "formats/reference/lammpsdump.rst", "formats/reference/mmtf.rst", "formats/reference/mol2.rst", "formats/reference/ncdf.rst", "formats/reference/parmed.rst", "formats/reference/pdb.rst", "formats/reference/pdbqt.rst", "formats/reference/pqr.rst", "formats/reference/psf.rst", "formats/reference/tng.rst", "formats/reference/top.rst", "formats/reference/tpr.rst", "formats/reference/trj.rst", "formats/reference/trr.rst", "formats/reference/trz.rst", "formats/reference/txyz.rst", "formats/reference/xml.rst", "formats/reference/xpdb.rst", "formats/reference/xtc.rst", "formats/reference/xyz.rst", "formats/selection_exporters.rst", "formats/topology.rst", "groups_of_atoms.rst", "index.rst", "installation.rst", "module_imports.rst", "preparing_releases_and_hotfixes.rst", "reading_and_writing.rst", "references.rst", "releases.md", "selections.rst", "standard_selections.rst", "testing.rst", "topology_system.rst", "trajectories/slicing_trajectories.rst", "trajectories/trajectories.rst", "trajectories/transformations.rst", "units.rst", "universe.rst"], "indexentries": {"atomname": [[83, "term-atomName", true]], "chainid": [[83, "term-chainID", true]], "charge": [[83, "term-charge", true]], "duecredit_enable": [[104, "index-0", false]], "environment variable": [[104, "index-0", false]], "radius": [[83, "term-radius", true]], "recordname": [[83, "term-recordName", true]], "residuename": [[83, "term-residueName", true]], "residuenumber": [[83, "term-residueNumber", true]], "serial": [[83, "term-serial", true]], "x y z": [[83, "term-X-Y-Z", true]]}, "objects": {}, "objnames": {}, "objtypes": {}, "terms": {"": [1, 2, 3, 4, 9, 10, 13, 16, 19, 26, 27, 30, 33, 34, 37, 39, 40, 42, 44, 45, 48, 50, 52, 53, 55, 56, 57, 60, 67, 81, 87, 96, 98, 101, 102, 103, 104, 105, 109, 111, 113, 114], "0": [0, 1, 2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 89, 90, 91, 92, 93, 94, 95, 96, 97, 98, 99, 100, 101, 102, 103, 104, 106, 107, 108, 109, 110, 111, 112, 113, 114], "00": [13, 30, 36, 42, 53, 78, 82, 98, 109], "000": [30, 52, 78], "0000": 43, "00000": [30, 104], "000000": [13, 16, 18, 19, 20], "0000000000000007": 52, "00000000e": 42, "00000762939453": 57, "00001525878906": 57, "00002": [14, 104], "0000305175781": 57, "0000610351562": 57, "00009": [30, 104], "00011079": 49, "00020": [38, 104], "00022158": 49, "00024": [9, 10, 55, 104], "00024669": 40, "00025464": 40, "00026781": 49, "00028": 40, "00031": [42, 43, 44, 45, 104], "0003116": 40, "00033237": 49, "00038": [33, 104], "00044316": 49, "00050771": 49, "00053562": 49, "00054276": 49, "00055068": 40, "00055396": 49, "00066475": 49, "00073491": 49, "0007466": 40, "00080344": 49, "00083": [19, 20, 104], "00085": [33, 104], "00088633": 49, "00094167": 40, "00099712": 49, "000e": [36, 109], "001": 113, "00106921": 40, "00107": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55, 104], "00107125": 49, "00108553": 49, "00111344": 49, "00112985": 49, "00114292": 40, "00115669": 49, "00122727": 49, "00127": [9, 10, 11, 12, 13, 14, 33, 104], "00129204": 49, "001312": 49, "00132949": 49, "00133906": 49, "00144029": 49, "00152": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "001589": 16, "00160687": 49, "00175": [39, 104], "00177266": 49, "00177646": 49, "0018406": 49, "002": 82, "00210503": 49, "0022": [37, 104], "00220": [33, 104], "0022283678904084": [37, 104], "0023665": 40, "00241031": 49, "00259": [19, 20, 104], "00279604": 49, "0033": 53, "003316543310998": 111, "00348": 104, "00348155": 49, "00401706": [14, 104], "00479816": 103, "00522": [30, 104], "006": [33, 82, 104], "0063": 113, "007": [1, 53, 82], "00778": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 55, 104], "008": [1, 53], "00874": [37, 104], "00876945": 49, "009": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 104], "00935": [30, 104], "00e": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "01": [13, 30, 36, 53, 104], "010": 52, "010261e": 13, "0103643": 113, "010e": 36, "011": [1, 39, 53], "011126": 53, "012": 82, "013": [15, 82, 104], "0135559": 49, "014111": [34, 104], "01418196": 109, "01688797": 49, "01691979": 49, "017": 103, "01700328": 49, "0175389": 49, "017e": 36, "018": [98, 104], "019": 82, "01957657": 49, "019587": 16, "0196": 53, "0196814": 49, "02": [27, 36, 104], "02096112": 49, "020e": 36, "021": 82, "02131476": 49, "02166694e": 42, "02179554": 49, "02271": [33, 104], "022757": 33, "02339659": 49, "024": [30, 82, 104], "024e": 36, "02689655": 49, "02691": 50, "02791523": 49, "028398": 33, "029266e": 13, "02954": 57, "029879e": 13, "03": [3, 36, 37, 42, 104, 107, 109], "03125632": 43, "031910": 104, "031958e": 13, "03231": 50, "03400656": 49, "03402765": 49, "034909350700361955": 52, "03504874": 109, "03507781": 49, "035526": 33, "036821e": 13, "037335": 16, "0374380078872": 52, "037768e": 13, "0378": 57, "038": 98, "038469": 33, "038667": 33, "038766": 34, "03881675": 44, "039": 103, "03997": [37, 104], "04": [33, 104], "041445": 33, "042": 83, "04223882": 109, "04277601": 49, "04737475": 46, "04737477": 46, "0485004790689": 52, "0488882": 113, "05": [30, 99, 104], "05076614": 44, "052": 82, "052780e": 53, "054": 82, "054708": 33, "0567": 43, "057143": 33, "059": 82, "06": [1, 38, 104, 113], "060914": 33, "061491": 16, "06153911": 44, "062": 82, "0625": 57, "06342056": 43, "064333": 16, "066": [33, 104], "067112": 33, "067632": 33, "06808195": 53, "07": [13, 38, 50, 53, 104], "070": 82, "072": 103, "073": 82, "07391102": [39, 104], "075950": 33, "075991": 53, "077": 82, "0784": 53, "07840037": 103, "07957562": 46, "07957565": 46, "08": [13, 26, 50, 53, 57], "081": 82, "088241": 34, "088865": 16, "089e": 36, "09": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 104, 113], "091": 78, "094409": 33, "094795": 33, "0962": 30, "0991": 43, "0f": 53, "0f99b0dc5f49": 109, "0x13a476d30": 14, "0x140451fd0": 53, "0x14115fdf0": 26, "0x1444979d0": 48, "0x7f0442bc0af0": 36, "0x7f0442f64370": 36, "0x7f0443041df0": 36, "0x7f044305ffa0": 36, "0x7f0554052c40": 38, "0x7f05540e1ac0": 38, "0x7f05569e96d0": 38, "0x7f0556a1f8e0": 38, "0x7f06d09bc700": 22, "0x7f06d2a3b7c0": 22, "0x7f1a146af610": 30, "0x7f2cca7d3a60": 27, "0x7f2cca7db1c0": 27, "0x7f2e804833d0": 13, "0x7f2e80483490": 13, "0x7f2e80561610": 13, "0x7f2e830164f0": 13, "0x7f3006abf310": 57, "0x7f3006abf340": 57, "0x7f300cf8d210": 57, "0x7f4b7ddfd160": 31, "0x7f5d682b3b20": 49, "0x7f75f0149520": 33, "0x7f75f1291520": 33, "0x7f75f1291970": 33, "0x7f8bf93611c0": 15, "0x7f9000474df0": 16, "0x7f9000500820": 16, "0x7f90006ca9d0": 16, "0x7f901a31bca0": 16, "0x7f9e98499ee0": 43, "0x7f9eb2146160": 43, "0x7faa885ab280": 40, "0x7fcd2b8cb430": 37, "0x7fcd2ba11580": 37, "0x7fce5096fd60": 28, "0x7fce50983790": 28, "0x7fce5098a250": 28, "0x7fce51309190": 28, "0x7fd0e5c7a850": 12, "0x7fd0e5ddcc40": 12, "0x7fd1d0c7ad00": 44, "0x7fd2165443a0": 44, "0x7fd216582df0": 44, "0x7fd21662ec10": 44, "1": [0, 1, 3, 4, 9, 10, 11, 12, 13, 14, 15, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 60, 61, 66, 69, 75, 78, 81, 82, 83, 84, 87, 88, 89, 91, 93, 94, 95, 96, 98, 102, 103, 104, 106, 108, 109, 110, 111, 112, 113, 114], "10": [1, 3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 71, 78, 82, 83, 87, 98, 103, 104, 105, 106, 108, 109, 110, 111, 112, 113, 114], "100": [0, 1, 14, 19, 26, 27, 30, 42, 44, 52, 53, 57, 87, 113, 114], "1000": [27, 44, 50, 105, 106, 113, 114], "100000": [105, 113], "1002": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 52, 53, 55, 104], "1003": 52, "1004415": [42, 43, 44, 45, 104], "1004568": [46, 104], "1007": [34, 104], "100th": 14, "101": [9, 82, 98], "10101525": 33, "1016": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 30, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 104], "102": [12, 42, 44, 45, 46, 98], "1021": [38, 104], "10286": [37, 104], "1029": 98, "103": 87, "1030": 98, "1031": 98, "1032": 98, "1033": 98, "1034": 98, "103407": 33, "1035": 98, "1036": 98, "1037": 98, "1038": 98, "1039": [26, 27, 28, 98], "104": [27, 50], "1040": [1, 98], "1041": [40, 98], "1042": 98, "1043": 98, "1044": 98, "1045": 98, "10490022": [14, 104], "105": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 103, 104], "10506570": [39, 104], "106": 53, "1063": [27, 33, 34, 104], "107": 34, "1073": [19, 20, 104], "107425": 33, "108": 27, "1080": [14, 39, 104], "1082": 57, "1084": 57, "1093": [9, 10, 19, 20, 52, 55, 104], "10th": [16, 106], "11": [1, 3, 9, 10, 13, 14, 15, 16, 19, 24, 26, 27, 28, 30, 33, 34, 36, 37, 38, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 78, 81, 82, 83, 87, 98, 103, 104, 105, 106, 109, 110, 112, 113, 114], "110": [19, 20, 34, 87, 104], "1103": 104, "1107": [9, 10, 11, 12, 13, 14, 33, 104], "11084": 1, "11086": 0, "11087": 0, "11088": 0, "111": [37, 44, 48], "111460": 33, "112": [34, 87, 103], "113": [82, 98], "11394": [38, 104], "114": 82, "11401": [38, 104], "11404": 1, "114195": 16, "115": 34, "1159": 101, "116": 87, "118": 34, "11th": 106, "12": [1, 3, 9, 10, 13, 14, 15, 16, 19, 26, 27, 30, 33, 34, 36, 37, 40, 42, 43, 44, 46, 48, 49, 50, 52, 53, 55, 57, 78, 82, 86, 98, 103, 104, 105, 106, 109, 110, 111, 112, 113, 114], "121": [13, 39, 46, 50, 52], "122": [13, 14, 22, 23, 50, 82, 98], "123": 98, "123456789": 82, "124": 27, "1241": [9, 10, 52, 55, 104], "124116": [33, 104], "1242": [9, 10, 52, 55, 104], "125": [37, 82, 104], "1264": 105, "1265": 53, "127": 15, "128": [57, 82], "129": [37, 38, 98, 104], "13": [1, 9, 10, 13, 14, 15, 16, 19, 26, 27, 30, 34, 36, 37, 40, 42, 43, 44, 48, 49, 50, 52, 53, 55, 57, 81, 82, 98, 103, 106, 109, 110, 112, 114], "130": [48, 106], "1300": 105, "130355": 53, "1311599110": [19, 20, 104], "132017": 33, "133": [27, 98], "134": [15, 33, 104], "135": 82, "1371": [42, 43, 44, 45, 46, 104], "137593e": 13, "137873": 16, "138474e": 13, "1386": 57, "139": 30, "13913721": 43, "139156e": 13, "14": [1, 9, 10, 13, 15, 16, 19, 26, 27, 30, 34, 36, 40, 42, 43, 44, 48, 49, 50, 52, 53, 55, 57, 82, 98, 100, 103, 104, 105, 106, 109, 110, 112, 114], "140": 96, "140631869613383": 52, "140e": 36, "141": [34, 96, 104], "141134e": 13, "142": [15, 27, 104], "143": 27, "143376e": 13, "144": 82, "145622": 45, "145e": 36, "146": [27, 57], "1464": 43, "149": [30, 34, 104], "14932597": 103, "15": [1, 7, 10, 13, 15, 16, 19, 26, 27, 30, 34, 36, 40, 41, 42, 43, 44, 45, 48, 49, 50, 52, 53, 57, 81, 82, 98, 103, 104, 106, 109, 110, 112, 114], "150": [26, 28, 82], "150901": [34, 104], "153": 52, "154": 52, "154475": 33, "154986e": 53, "155": [52, 98], "1552": 57, "1561": 53, "1563": 53, "159": [13, 14, 22, 23, 50, 98], "15th": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "16": [1, 3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 81, 82, 98, 103, 104, 105, 106, 109, 110, 111, 112], "160": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 104], "1600": 0, "160e": 36, "161": 39, "161102": 45, "161863": 16, "163276": 16, "164": 98, "165": [11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 33, 38, 39, 42, 43, 44, 45, 49], "1659867": 45, "1660": 113, "166068": 33, "168": 98, "168397e": 13, "168694": 33, "169": 37, "17": [1, 12, 15, 16, 19, 20, 21, 26, 27, 30, 33, 34, 36, 39, 42, 44, 48, 49, 50, 52, 53, 57, 69, 81, 82, 87, 98, 103, 104, 106, 109, 110, 111, 112], "171873": 33, "1738": 105, "175": 78, "176": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 82, 104], "1760": 105, "177": 82, "1785": 105, "17874": [19, 20, 104], "17879": [19, 20, 104], "179": 31, "18": [1, 9, 15, 16, 19, 26, 27, 30, 42, 44, 46, 48, 49, 50, 52, 53, 57, 78, 81, 82, 86, 98, 103, 105, 106, 109, 110, 112, 113], "180": [67, 113], "1801": 57, "18089604": 103, "182243": 16, "183": 52, "1849904397706": 52, "186e": 36, "187": [39, 67], "1879874": 45, "188": 103, "189": 101, "1893": [89, 94], "18980852": 43, "18th": [15, 104], "19": [1, 15, 16, 19, 22, 23, 24, 26, 27, 28, 30, 37, 40, 42, 44, 48, 49, 50, 52, 53, 57, 82, 98, 103, 104, 105, 106, 109, 112, 113], "190": 106, "1901": 105, "19053": 34, "190e": 36, "1929": 98, "193": 27, "193e": 36, "1959": 98, "196": [82, 98], "1960": 98, "1961": 98, "1962": [14, 104], "1967": 104, "197": 27, "197000e": 13, "1978": [37, 104], "197e": 36, "198": 30, "1983": 43, "1988": [78, 105], "199": 27, "1993": [30, 34, 104], "1996": [30, 104], "199960": 33, "19th": [33, 104], "19xx": 105, "1a": 106, "1ake": 13, "1c": 106, "1d": [12, 43], "1e": 113, "1f": 45, "1x": 84, "2": [0, 1, 2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 89, 90, 91, 92, 93, 94, 95, 96, 97, 98, 99, 100, 101, 102, 103, 104, 106, 107, 108, 109, 110, 111, 112, 113, 114], "20": [1, 15, 16, 19, 26, 30, 31, 42, 44, 48, 49, 50, 52, 53, 57, 82, 98, 103, 105, 106, 110, 111, 112, 113], "200": [27, 42, 49, 52, 57, 102, 114], "2000": [39, 50, 104], "20000000000000015": 52, "2002": [34, 104], "2003": [37, 104], "2005": [9, 10, 11, 12, 13, 14, 33, 53, 104], "2006": [33, 104], "2007": [19, 20, 38, 104], "2008": [33, 104], "2009": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 53, 55, 104], "200e": 36, "201": 48, "2010": 53, "2011": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 52, 53, 55, 104], "2013": [19, 20, 30, 67, 104], "2014": [30, 34, 104], "2015": [27, 42, 43, 44, 45, 46, 104], "2016": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 87, 104], "2017": [14, 52, 104], "2018": [9, 10, 26, 27, 28, 34, 52, 55, 87, 104], "2019": [15, 71, 87, 104], "2020": [3, 104, 105], "2021": [104, 105], "2022": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 105], "2023": [3, 105], "2024": 99, "204": [27, 98], "205": 30, "206": 27, "207": 78, "208": 27, "209": 82, "2093": 15, "21": [1, 9, 15, 16, 26, 27, 28, 30, 31, 33, 42, 44, 48, 49, 50, 52, 53, 57, 71, 81, 82, 98, 103, 104, 105, 106, 109, 112, 113, 114], "210": [27, 37, 53, 82], "211": 27, "21124": 57, "2118": 105, "212": [37, 53], "2124": 57, "213": 53, "214": [9, 13, 24, 27, 37, 46, 50, 53], "21439": [9, 10, 11, 14, 104], "21787": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 52, 53, 55, 104], "219e": 36, "22": [1, 15, 16, 26, 30, 44, 46, 48, 49, 50, 53, 57, 81, 82, 98, 103, 105, 106, 112], "220": [37, 82], "221": 30, "22168": 1, "222": 82, "2223": [86, 113], "222884": 16, "223": 98, "2245": 83, "224907": 27, "225": 98, "226": 82, "22634681": 50, "2278": 0, "22791": 24, "228815": 33, "229": 52, "23": [1, 3, 15, 16, 26, 30, 34, 44, 48, 49, 50, 53, 57, 81, 82, 87, 93, 98, 103, 106, 112], "230": 98, "2319": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 52, 53, 55, 104], "2327": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 52, 53, 55, 104], "2332": 57, "234": 98, "235205e": 53, "2364": 105, "237": [30, 82], "237e": 36, "238": 82, "23853": 1, "239": [98, 103], "239006": 113, "23912": 50, "2393": 63, "24": [1, 3, 15, 16, 26, 27, 30, 34, 39, 44, 49, 50, 53, 57, 81, 82, 87, 98, 103, 105, 112], "2422": 105, "24269804": 43, "243": 30, "2438": 105, "244e": 36, "2450": 3, "2452": 105, "24545978": 44, "2455": [30, 104], "24595657": 50, "246": 57, "2460": [30, 104], "2468": 105, "2484": 57, "249": 98, "24955": 45, "25": [1, 15, 26, 27, 30, 34, 46, 49, 50, 53, 57, 81, 82, 83, 98, 103, 105], "250384": 33, "2508": 105, "25080": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "251": 52, "2522": 43, "255": 48, "256": 3, "25614133": 53, "2565": [34, 45], "257429": 16, "26": [1, 15, 26, 30, 34, 49, 50, 53, 57, 81, 82, 83, 87, 93, 98, 103], "262": 82, "263638e": 53, "26432545e": 42, "265": 82, "26549552": 16, "2666": 105, "2668": 105, "267": 82, "2699": 57, "27": [1, 15, 26, 30, 49, 50, 53, 57, 81, 82, 93, 98, 103, 104, 107, 113], "270191e": 13, "2703": 105, "27156576e": 50, "2723": 105, "27269": 57, "2728": 105, "27372673": 103, "2739": 105, "2744": 50, "2746": 105, "275": 98, "276497e": 13, "276639": 16, "276e": 36, "279498e": 53, "28": [1, 3, 15, 30, 49, 50, 53, 57, 78, 98, 103], "28004": 50, "2811": 105, "2821": 105, "2827": 105, "2836": [37, 104], "2842": 105, "2849": 57, "285": 82, "2854886173518": 52, "2863": 105, "2866": 105, "287": 98, "2887": 103, "289": 1, "2898": 105, "29": [1, 13, 15, 30, 34, 46, 49, 50, 53, 57, 98, 103, 113], "290": 98, "290068": 53, "290153": 16, "290e": 36, "2913": 105, "2917": 105, "29185734": 16, "2927": 105, "293e": 36, "2956": 105, "296": 30, "2977": 105, "298": 82, "2984": 105, "298539": 16, "298e": 36, "2d": [12, 13, 14, 43], "2e": 57, "2f": [11, 26, 27, 30, 53], "2g14": 84, "2gb": 105, "2lyz": 98, "3": [1, 3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 60, 78, 81, 82, 83, 84, 87, 93, 94, 95, 96, 98, 103, 104, 106, 108, 109, 110, 111, 112, 113, 114], "30": [1, 13, 14, 15, 22, 23, 30, 33, 42, 49, 50, 53, 57, 78, 98, 103, 104, 110, 112, 113], "300": [44, 52, 57, 114], "3000": [50, 83], "3002": 105, "300e": 36, "301": 96, "3025": 52, "3026": 52, "3030": 105, "3044": 105, "3054": 105, "30580288e": 50, "306": 82, "306984": 34, "307": 83, "309": 98, "3092": 105, "31": [1, 15, 16, 19, 30, 48, 49, 50, 53, 57, 81, 82, 98, 103], "310e": 36, "3115": 105, "3118": 57, "3119": 105, "312": [1, 98, 104, 108], "3127": 105, "313": [98, 108], "314": 108, "31415": 30, "3144": 105, "3149": 105, "3152": 105, "316": 108, "317": 108, "3170": 43, "31770319": 43, "318": 53, "3180": 105, "3183": 105, "318859e": 13, "319": [53, 82], "32": [1, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 50, 52, 53, 55, 57, 98, 104, 105], "320": 53, "3200": 105, "320e": 36, "32166": 57, "324": 103, "32501": 57, "3257": 105, "3261": 105, "3271": 53, "3272": 53, "3273": 53, "328": 82, "329": 104, "33": [1, 15, 49, 50, 53, 57, 81, 82], "3305": 105, "3314": 105, "3317": 105, "33312648": 46, "33312649": 46, "33355791": 50, "3336": 105, "3337": 53, "3338": 53, "3339": 53, "3340": 53, "3341": [10, 15, 53, 96, 98, 103], "3352": 105, "3358": 105, "3364": 105, "3375": 105, "3385": 105, "3386": 105, "338e": 109, "339": 82, "339e": 109, "34": [1, 9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 30, 33, 37, 38, 39, 40, 42, 43, 44, 45, 49, 50, 52, 53, 55, 57, 81, 82, 98, 104], "340170408": [34, 104], "3403": 105, "34042415": 103, "340e": 109, "341467": 34, "3415": 105, "3416": 105, "3419": 105, "342": 103, "3423": 105, "3429": 105, "3437": 105, "3443": 105, "3445": 105, "3466": 105, "3469": 105, "3470": 105, "3472": 105, "349": 98, "349043": 16, "3495": [30, 104], "349e": 36, "35": [1, 19, 20, 30, 49, 50, 53, 57, 98, 103, 104], "3501": 105, "3511": 105, "35116178": 103, "3512": 105, "3514": 105, "353": 78, "3539": 105, "354": [30, 104], "3543": 105, "35433": 15, "3548": 105, "3556": 105, "3565": 105, "3569857": [33, 104], "357": [37, 104], "3571": 105, "3572": 105, "3596": 105, "3598": 105, "36": [1, 49, 50, 53, 57, 83], "360": [30, 104], "360050708": 104, "3611": 105, "3617": 105, "3621": 105, "36272588": 103, "364e": 36, "3654": 105, "3657": 105, "3664": 105, "3671": 105, "3678": 105, "3680": 105, "3683": 105, "3685": 105, "3687": 105, "37": [1, 38, 49, 50, 53, 57, 83, 98, 104], "3701": 105, "3703": 105, "3710": 105, "3711": 105, "371346e": 53, "3718": 113, "37205967": 46, "37206002": 46, "3721": 105, "3730": 105, "3735": 105, "37359575": 16, "374": 98, "3744": 105, "3749": 105, "3755": 105, "376": [30, 104], "3765": 105, "3767": 57, "378": 82, "3783": 105, "379": 30, "379e": 36, "38": [1, 16, 23, 49, 52, 53, 57, 81, 82], "3810": 105, "3825": 105, "382960": 16, "382e": 36, "3832": 105, "3844": 105, "3846": 105, "3848": 105, "385": [82, 98, 104], "386": [37, 98, 104], "387": [34, 104], "3876": 105, "388": 82, "3887": 105, "3889": [11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 33, 38, 39, 43, 44, 49], "389": 30, "3890": 105, "3894": 105, "39": [1, 13, 15, 16, 18, 20, 21, 23, 24, 26, 30, 31, 36, 37, 38, 39, 40, 42, 43, 44, 48, 49, 50, 52, 53, 57, 81, 82], "3904": 105, "3905": 105, "3906": 105, "391": 30, "3913": 105, "3914": 105, "393473": 53, "3935": 105, "394": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 78, 104], "395": 98, "3951": 105, "3953": 105, "3956": 105, "3958": 105, "3959": 105, "3967": 30, "3976": 105, "3977": 105, "3983": 105, "3988": 105, "399": [30, 98], "3991666": 46, "39916723": 46, "3996": 105, "3999": 105, "3d": [30, 43, 44, 53], "3f": [30, 31, 34, 39], "3n": [7, 32, 34, 41], "3rd": 12, "3x3": 3, "4": [1, 3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 60, 78, 82, 83, 87, 88, 93, 96, 98, 100, 102, 103, 104, 106, 108, 109, 110, 111, 112, 114], "40": [1, 19, 30, 49, 53, 57, 81, 82, 98, 103, 110], "400": [52, 57, 114], "4000": 15, "4000000000000003": 52, "4003": 105, "4007": 105, "4008": 105, "4009": 105, "4010": 105, "4015": 105, "402": 98, "40210": 87, "4022": 105, "4027": 105, "4028": 43, "4031": 105, "4032": 105, "4037": 105, "4039": 105, "4040": 105, "4043": 105, "4047": 105, "4049": 105, "405": 98, "4054": 105, "4059": 105, "4066": 105, "407": 37, "4070": 105, "4072": [57, 105], "4073": 105, "40737137186695": 52, "4074": 105, "4075": 105, "4076": 105, "408": 98, "408413": 34, "4085": 105, "4089": 105, "4091": 105, "4092": 105, "4096": 3, "41": [1, 30, 49, 57, 81, 82, 98], "410": 83, "4105": 105, "4108": 105, "4109": 105, "4115": 105, "41177493": 43, "411e": 36, "412": [34, 104], "414": [78, 98], "4140": 105, "414839": 53, "415": 98, "4153": 105, "416": 98, "4160": 105, "4161": 105, "4163": 105, "4167": 105, "4168": 105, "417": 98, "4170": 105, "4174": 105, "4176": 105, "418": 98, "4182": 105, "4184": 105, "4187": 15, "419": [14, 30, 98, 104], "4191": 105, "419340e": [13, 53], "4198": 105, "42": [30, 48, 49, 57, 103, 106], "420": [14, 98, 104], "4200": 105, "4203": 34, "4214": 105, "421683": 16, "4219": 105, "4220": 105, "42282569": 46, "42282661": 46, "4230": 105, "4237": 105, "4246": 105, "4247": 105, "4248": 105, "425": [30, 34, 104], "4253": 105, "4255": 105, "4258": 105, "426": [30, 82, 104], "4261": 105, "427098": 34, "4271": 105, "4273": 105, "4281": 105, "4283": 105, "4284": 105, "4289": 105, "4292": 105, "429350": 16, "4294": 105, "43": [3, 49, 57, 103], "430": 98, "4300": 105, "4301": 105, "4309": 105, "431": 82, "4319": 105, "4325": 105, "4327": 105, "4329": 105, "4331": 105, "4332": 105, "4333": 105, "4335": 105, "434": 52, "4340": 105, "4342": 105, "4343": 105, "4344215": 53, "4346": 105, "4359": 105, "4366": 105, "437": [37, 104], "4374": 40, "438": 30, "44": [19, 20, 30, 48, 49, 57, 103, 104], "442": 30, "442750": 16, "443": 30, "443243": 16, "443850e": 53, "444213": 16, "444711": 16, "445914": 16, "44733fc214dcfdcc2b7cb3e3705258781bb491bd": 105, "449": 82, "449275": 19, "45": [16, 49, 50, 57, 98], "450": [37, 104], "451285": 16, "451335": 16, "45325": 52, "4548": 113, "456": 82, "46": [49, 52, 57, 81, 82, 98, 106], "460": 98, "4600": 83, "463": 87, "463768": 19, "464154": 34, "46589388029852": 52, "47": [49, 57, 81, 82, 103, 109], "47003326": 103, "4721781": [9, 10, 55, 104], "47680": 1, "47681": [53, 103, 114], "478": [9, 10, 11, 12, 13, 14, 33, 53, 104], "48": [30, 49, 52, 57, 81, 82, 98], "480": [9, 10, 11, 12, 13, 14, 33, 53, 83, 104], "480681e": 13, "4819": 43, "482385": 16, "483e": 36, "484": 57, "485": 82, "487021": 16, "4885338": [34, 104], "489046": 16, "48955173": 26, "49": [42, 49, 57], "492": 98, "4922445": 27, "49225059e": 50, "492754": 19, "493": 57, "496493": 16, "498081e": 13, "499": 83, "4ake": [0, 13, 50, 53, 83, 106], "4f": [43, 53], "4th": [10, 34, 39, 48], "5": [1, 3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 67, 71, 78, 82, 87, 93, 98, 102, 103, 104, 106, 108, 109, 110, 111, 112, 114], "50": [3, 19, 37, 44, 49, 52, 53, 57, 104, 110, 113], "500": [37, 52, 57, 114], "500640": 16, "50182419815255": 52, "501e": 36, "504430e": 13, "5049637": [34, 104], "5056929": 103, "506": 79, "507119e": 13, "507246": 19, "507396": 16, "507e": 36, "508649": 16, "508946e": 13, "509": [33, 104], "51": [26, 30, 53, 57, 98, 103], "5108170": [14, 104], "511": 30, "51332265e": 50, "5134845": 53, "514341": 16, "52": [16, 57, 98, 103], "522": 82, "522147": 16, "523": 52, "524600": 57, "525164": 57, "529": 98, "52911": 57, "52934648642113": 52, "52983036": 43, "53": [57, 98], "530339": 16, "531": 40, "533": 30, "533023": 16, "533e": 36, "535": 82, "537": 98, "5373676523751": 52, "537926": 16, "539112": 16, "53a6": 107, "54": [30, 53, 57, 81, 82, 113], "540e": 36, "542": [52, 78], "542565": 16, "543": [30, 82], "544784": 16, "545": 83, "55": [57, 81, 82, 110], "550": 98, "550181e": 13, "55032598": 46, "55032613": 46, "550571": 16, "551": [98, 103], "551e": 36, "55204678": 46, "55204694": 46, "5526783580306": 52, "554": 98, "555": 103, "55559436896063": 52, "556": 108, "556e": 36, "557": [52, 82], "557e": 36, "56": [30, 53, 57, 103], "560575": 16, "560e": 36, "561879": 34, "562034": 16, "567": 30, "568": 40, "568381": 16, "57": [30, 52, 57, 103], "570": [40, 52], "571st": 40, "575": 52, "578": 98, "58": [30, 57, 87], "581": 82, "583": 98, "584163": 16, "584302": 34, "58767": 50, "588600e": [13, 53], "589": [37, 57], "59": [13, 14, 16, 22, 23, 50, 57], "591575": 16, "592": 98, "593": 98, "59556372": 44, "59975057e": 42, "5f": [34, 40], "5th": 106, "6": [1, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 66, 69, 78, 81, 82, 83, 84, 87, 91, 93, 98, 102, 103, 104, 106, 109, 110, 111, 112, 114], "60": [13, 36, 40, 46, 50, 57, 81, 82, 110], "600": [52, 57, 98, 114], "6000000000000004": 52, "60069985": 44, "601": 98, "602176565": 113, "60218e": 113, "603": 52, "603098": 16, "603704620787127": 9, "60502842": 50, "606": 52, "6084": [14, 104], "61": [9, 10, 11, 12, 13, 14, 30, 33, 40, 53, 57, 81, 82, 98, 104], "612": 98, "612104": 34, "612923": 53, "612989e": 13, "613": 98, "6132305": 53, "614": 52, "614469": 16, "616e": 36, "61919832973248": 52, "62": [30, 40, 57, 103], "621": 82, "623": 52, "6234": 57, "625": 49, "627": 82, "629e541a": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "63": [30, 40, 52, 57], "630e": 36, "635": 98, "636": 98, "636592e": [13, 53], "64": [30, 57], "640025": 16, "640x480": 46, "644": 82, "6454": 57, "646130": 16, "6468601": 103, "646981": 16, "65": [30, 57, 104], "650": 82, "652498": 34, "653968": 16, "656678": 16, "658": [57, 98], "659": 82, "66": [16, 30, 57, 81, 82], "66053892103219": 113, "66053906660": 113, "66054e": 113, "663": 30, "66369356": 44, "664622": 53, "66508082": 50, "666": 101, "667": 82, "667003": 16, "6682": 10, "6690": 53, "669018": [16, 53], "669018368649777": 111, "67": [57, 81, 82], "67052241": 46, "67052252": 46, "673": 104, "6732": 53, "673217": [16, 53], "675616": 34, "677194": 16, "6779995219885": 52, "679": 104, "679625": 16, "68": [57, 98], "68070702": 42, "681294": 16, "68134177": 44, "682": 82, "684": 103, "68452079": 44, "68682809": 42, "69": [19, 21, 57, 98], "69314718": 42, "696454": 16, "697": 78, "6th": [1, 106], "7": [1, 3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 21, 22, 23, 24, 26, 27, 28, 30, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 66, 78, 81, 82, 87, 98, 102, 103, 104, 106, 109, 110, 111, 112, 114], "70": [19, 53, 57, 82, 98, 108, 110], "700": [57, 114], "700e": 36, "704": 82, "704494": 16, "70556": 50, "707": 98, "708": 82, "71": [27, 30, 82, 98], "712154435976014": 9, "71288": 57, "713": 98, "713e": 36, "715": 39, "7185": 53, "719242": 19, "71996": 50, "72": [11, 53], "722": 103, "722283": [16, 53], "7223": 53, "723": [34, 83], "727": 98, "73": [11, 16, 21, 30, 50, 87], "731454": [16, 53], "7315": 53, "735": [30, 104], "739": 57, "739184e": 13, "74": [30, 98, 103], "740e": 36, "743": 98, "74314071570579": 52, "743960893217544": 111, "743961": [16, 53], "743983e": [13, 53], "7440": 53, "745": 98, "74534511": 46, "74534554": 46, "745572e": 13, "746624": 34, "747461": 16, "748416e": 53, "749": 82, "749343": 16, "75": [19, 36, 40, 49], "751": [28, 30, 104], "753": 103, "754418e": 13, "75524844": 53, "76": [27, 81, 82], "760545": 16, "762": 105, "7638984": 53, "764": 82, "767501": 19, "77": [21, 81], "770653826924175": 109, "771949": 16, "774": 82, "7741": 53, "7764": 53, "777": 82, "77760845": 103, "7776190679035": 52, "777e": 36, "78": [37, 81, 104], "780732": 16, "780e": 36, "781": 78, "78155009e": 50, "781e": 36, "78220560918737": 37, "783": 98, "783e": 36, "784": 82, "7855": [30, 104], "786797": 34, "788": 98, "788027": 19, "78938645874581": 111, "7894": 53, "79": [52, 81, 82], "795031e": 13, "79514029": 50, "79665166": 53, "7ddc1dd1": [15, 104], "8": [0, 1, 2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 17, 19, 20, 22, 23, 24, 25, 26, 27, 28, 29, 30, 32, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 89, 90, 91, 92, 93, 94, 95, 96, 97, 98, 99, 100, 101, 102, 103, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114], "80": [3, 16, 19, 81, 82, 105, 106, 110], "800": [57, 114], "8000": [4, 83], "8000000000000006": 52, "800e": 36, "801": 82, "801342": 16, "804": 103, "804211e": 13, "8064191062": 52, "807987e": 13, "80th": 16, "81": [11, 30, 98, 106], "811": [39, 104], "81293": [30, 104], "81360424": 103, "814": 98, "814553": 16, "817293751703919": 9, "817898e": 13, "817e": 36, "819": [39, 104], "8195947370533": 52, "820322e": 13, "821": 98, "821205e": 13, "823686867261616": 13, "824e": 36, "827": 82, "82744082": 26, "828": [82, 103], "8289": 53, "829219": 19, "829e": 36, "83": [26, 87], "831": 98, "833500": 19, "834": 82, "834344e": [13, 53], "835": 98, "839346": 16, "84": [11, 30], "845": 98, "85": [21, 108], "8500": 83, "8521": 53, "852127": 16, "852774844656239": 53, "85342131": 16, "854": 83, "8549": 53, "855": 34, "8566": 113, "86": 39, "8601466": 103, "86135435": 103, "868e": 36, "87": 30, "871241": 16, "871915e": 13, "8723": 53, "87231363208217": 111, "87503334950912": 52, "878262": 16, "8787": 15, "878e": 36, "879": 30, "88": 30, "882": 82, "884": 30, "8844": 57, "885": [82, 98], "8864": 113, "88686156": 103, "889": 98, "8th": 16, "9": [1, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 24, 26, 27, 28, 30, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 78, 81, 82, 84, 87, 98, 102, 103, 105, 106, 109, 110, 111, 112, 114], "90": [3, 22, 34, 37, 49, 50, 100, 106, 108, 110, 111, 112], "900": [57, 98, 114], "90016526": 103, "900327": 16, "900e": 36, "903": 34, "9033261": 103, "904": 98, "90408": [37, 104], "906": 34, "91": 30, "910": 82, "9108": 53, "910e": 36, "912": 82, "914": 98, "915": 82, "917": [31, 106], "918": 98, "919": 98, "92": 27, "920274": 34, "920e": 36, "921": [83, 106], "921486e": 13, "922e": 36, "923": 106, "93": [13, 16, 27, 30, 104], "933480028298": 52, "934167e": 53, "935": 98, "936": 78, "939": 78, "939111e": 53, "94": [13, 16, 98], "940994e": 13, "942533": 16, "943820": 18, "943e": 36, "946": 98, "946494": 20, "948339": 20, "949262": 20, "9494": 53, "95": [13, 16, 27], "950e": 36, "951": 34, "951107": 20, "952952": 20, "954": 98, "95442": [34, 104], "958": 98, "95908": 50, "959755": 53, "96": [13, 16, 27, 30, 34, 50, 104], "960": [34, 98], "961": 103, "964": 34, "967": 57, "968": 98, "969": 98, "97": [13, 16, 27, 30, 104], "970027": 20, "970184": 19, "972752": 20, "97364299e": 50, "973660": 20, "975": 82, "976": 98, "977444": 16, "978": [34, 104], "9780387954424": [34, 104], "98": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104, 111], "980425": 19, "980926": 20, "980e": 36, "981": 82, "9810": 53, "983": 98, "983231": 53, "9845": [26, 27, 28], "984544": 19, "984928": 19, "9857": [26, 27, 28], "986": 82, "988": [103, 105], "988764": 18, "988937528818184": 52, "98977": 1, "99": [37, 53, 65, 93, 105], "9900092": 45, "991465038265208": 9, "997": 30, "998": 98, "999": [1, 53, 65, 93], "999094": 19, "999991": [13, 16], "999992": [13, 16], "999993": 16, "999994": 16, "999995": 16, "999996": 16, "999997": 16, "999998": 16, "999999": 16, "9999996476800743": 111, "9999999119200186": 111, "99sb": 107, "A": [0, 1, 3, 4, 5, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 56, 57, 60, 61, 63, 67, 71, 72, 75, 81, 82, 83, 84, 87, 88, 95, 98, 101, 102, 103, 104, 105, 106, 107, 108, 109, 112, 113, 114], "And": [5, 55, 96, 100], "As": [2, 3, 4, 10, 12, 13, 14, 15, 16, 23, 24, 30, 33, 34, 39, 42, 43, 44, 48, 50, 53, 55, 57, 61, 84, 93, 95, 96, 98, 100, 102, 103, 105, 106, 108, 109, 113], "At": [3, 102, 106, 108, 112], "BY": 15, "Be": [2, 15, 100], "By": [9, 19, 26, 30, 42, 44, 49, 61, 66, 68, 99, 106], "For": [1, 2, 3, 4, 7, 9, 12, 13, 15, 16, 19, 26, 28, 30, 32, 33, 34, 37, 39, 40, 42, 43, 44, 46, 50, 52, 53, 55, 57, 60, 61, 66, 78, 83, 87, 89, 96, 98, 100, 101, 102, 103, 104, 105, 106, 108, 109, 110, 111, 112, 114], "IN": [58, 59, 61, 97, 109], "If": [2, 3, 4, 7, 9, 10, 11, 12, 13, 15, 16, 23, 26, 27, 30, 34, 36, 37, 38, 40, 42, 44, 46, 50, 52, 53, 55, 57, 61, 65, 66, 67, 68, 79, 81, 82, 83, 84, 88, 89, 92, 96, 99, 100, 101, 102, 103, 105, 106, 108, 109, 112, 114], "In": [0, 1, 3, 4, 5, 7, 9, 11, 12, 13, 14, 15, 16, 18, 19, 26, 27, 30, 33, 34, 36, 38, 42, 44, 45, 46, 48, 50, 52, 53, 57, 61, 66, 67, 79, 88, 89, 93, 96, 98, 99, 100, 101, 104, 105, 106, 108, 109, 110, 111, 112, 114], "It": [2, 3, 4, 7, 9, 12, 13, 14, 15, 16, 21, 22, 26, 27, 28, 30, 32, 33, 34, 36, 37, 40, 45, 48, 49, 50, 53, 57, 60, 61, 67, 76, 78, 82, 85, 87, 89, 99, 104, 106, 108, 110, 112, 114], "NOT": 95, "No": [19, 21, 28, 101, 108, 109], "Not": 53, "Of": 4, "On": [26, 27, 28, 48, 50, 55, 57, 87, 102, 108], "One": [3, 4, 13, 14, 18, 30, 48, 52, 57, 103, 109], "Or": [3, 30, 57], "THE": 3, "That": [3, 19], "The": [1, 2, 3, 4, 5, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 41, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 56, 57, 60, 61, 62, 66, 67, 68, 69, 70, 72, 73, 77, 78, 79, 80, 83, 84, 85, 86, 87, 88, 89, 92, 93, 94, 95, 96, 98, 99, 100, 101, 102, 103, 104, 105, 106, 107, 108, 110, 111, 112, 113, 114], "Then": [3, 4, 12, 13, 15, 18, 24, 53], "There": [3, 12, 19, 26, 30, 33, 34, 36, 37, 40, 50, 81, 82, 99, 112, 114], "These": [1, 3, 4, 5, 7, 8, 17, 24, 37, 43, 48, 53, 57, 72, 81, 82, 89, 94, 98, 106, 108, 109], "To": [0, 2, 3, 4, 10, 12, 16, 19, 22, 26, 27, 28, 30, 42, 43, 44, 46, 48, 50, 53, 57, 66, 86, 100, 102, 105, 108], "With": [13, 34, 50, 103, 109], "_": [2, 3, 13, 26, 31, 44, 48, 87, 99], "__class__": 0, "__future__": 101, "__getattr__": 0, "__init__": [101, 102], "__main__": 16, "__name__": 0, "__version__": [3, 50, 53, 102], "_conclud": [16, 105], "_conclude_fft": 105, "_conclude_simpl": 105, "_dcdmodul": 3, "_distanc": 3, "_eigenvector": 33, "_eprint": [34, 104], "_frame_index": 16, "_i": [13, 14, 16, 31, 34, 36], "_j": 36, "_offset": [89, 94], "_prepar": 16, "_privat": 108, "_t": 16, "_test_write_trajectori": 108, "_trajectori": 16, "_verbos": 16, "a1": 82, "a10": 82, "a11": 82, "a11_11": 82, "a12": 82, "a13": 82, "a14": 82, "a15": 82, "a16": 82, "a17": 82, "a17_17": 82, "a18": 82, "a19": 82, "a2": 82, "a20": 82, "a3": 82, "a4": [82, 84], "a5": 82, "a6": 82, "a7": 82, "a7_7": 82, "a8": [82, 84], "a9": 82, "a9_9": 82, "a_": 31, "a_1": 46, "a_2": 46, "a_i": [31, 46], "a_ix": 27, "a_l": 46, "aa": [12, 13, 14, 26, 30, 48, 107], "aarch64": [102, 105], "ab": [14, 34, 36, 40, 104, 106], "abhinav": [34, 104], "abid": 99, "abil": [4, 105], "abl": [3, 4, 30, 101, 102, 105, 108], "about": [3, 4, 7, 9, 14, 15, 26, 32, 33, 34, 37, 46, 53, 70, 84, 87, 99, 105, 108, 109], "abov": [1, 3, 10, 13, 16, 23, 24, 26, 27, 28, 39, 48, 53, 55, 57, 83, 102, 103, 105, 106, 108, 109, 111], "abs_dev": 39, "absent": 106, "absolut": [16, 26, 101, 106, 108, 109], "absolute_import": 101, "ac": 107, "ac_timeseri": 27, "academ": [9, 10, 19, 20, 55, 104], "academi": [19, 20, 104], "acceler": 15, "accept": [3, 13, 30, 43, 44, 53, 105, 106, 109, 112], "acceptor": [26, 27, 28, 84], "acceptor_index": 26, "acceptor_ix": 26, "acceptors_sel": [26, 27, 28], "access": [0, 1, 3, 5, 16, 42, 50, 53, 56, 89, 94, 98, 99, 105, 106, 107, 109, 114], "accetptor": 28, "accident": 105, "accompani": 57, "accomplish": [10, 30, 48], "accord": [1, 13, 14, 87, 91, 106, 109], "accordingli": [15, 102, 111], "account": [2, 3, 4, 7, 32, 34, 40, 49], "accur": [53, 105], "accuraci": 105, "acess": 57, "acha": [33, 104], "achar": [81, 82], "achiev": [1, 15], "acid": [13, 18, 19, 20, 21, 26, 27, 28, 37, 53, 104, 105], "acidic_2": 19, "across": [3, 12, 48, 50, 89, 94, 102, 106], "act": [93, 111], "acta": [9, 10, 11, 12, 13, 14, 33, 53, 104], "action": 102, "activ": [3, 4, 82, 100], "actual": [3, 4, 5, 16, 40, 52, 56, 108, 111, 112], "ad": [6, 34, 42, 44, 57, 60, 85, 98, 99, 105, 107, 108, 114], "adam": 104, "adapt": 3, "add": [0, 1, 3, 4, 5, 14, 15, 16, 22, 23, 24, 50, 60, 99, 100, 102, 105, 106, 108, 109, 114], "add_angl": 109, "add_auxiliari": 57, "add_bond": 109, "add_compon": 48, "add_dihedr": 109, "add_improp": 109, "add_mesh": 48, "add_nois": 42, "add_represent": [48, 50, 55], "add_residu": [0, 105, 114], "add_seg": [0, 50, 105, 114], "add_subplot": [37, 44, 48], "add_surfac": 48, "add_topologyattr": [14, 50, 109, 114], "add_trajectori": 39, "add_transform": [48, 55, 112], "addit": [2, 3, 7, 44, 57, 61, 82, 96, 98, 101, 102, 103, 105, 106, 108, 109], "addition": 105, "address": [3, 108], "adenyl": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 53, 55, 104], "adequ": [102, 108], "adher": [2, 102], "adjust": 44, "adk": [5, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55], "adk_clos": [9, 10, 12, 19], "adk_closed_view": [9, 19], "adk_coord": 10, "adk_equilibrium": 15, "adk_open": [9, 10, 12, 19], "adk_open_view": [9, 19], "adk_oplsaa": [103, 114], "adk_traj_coord": 10, "adopt": 83, "advanc": [7, 15, 25, 26, 27, 46, 100], "advantag": 4, "advertis": [2, 105], "advis": [30, 105], "affect": [3, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 27, 33, 38, 39, 43, 44, 49, 105], "affin": 42, "affinitypropagationn": 42, "aforement": 15, "africa": [33, 104], "after": [3, 4, 13, 26, 30, 36, 48, 53, 57, 95, 103, 105, 106, 108, 111], "afterward": 103, "ag": [1, 10, 13, 40, 96, 98, 103], "ag1": [1, 40], "ag2": [1, 40], "ag_upd": 106, "again": [3, 13, 19, 30, 34, 37, 43, 46, 89, 96, 105, 108], "against": [2, 4, 102, 105], "aggreg": 30, "agrafioti": [9, 10, 11, 14, 53, 104], "agraw": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 52, 53, 55, 104], "agre": [2, 99], "ahead": [3, 102, 108], "ahm": 105, "aim": [3, 15, 58, 59, 61, 97, 105, 108], "aip": [34, 104], "akeco": 0, "akma": [67, 68, 113], "al": [12, 26, 27, 28, 53], "ala": [37, 52, 53, 87, 96, 98, 106, 107], "ala2_shel": 52, "ala_select": 96, "alad": 107, "alanin": [37, 96, 106], "alb93": [34, 104], "alexand": [9, 10, 52, 55, 104], "algorithm": [7, 8, 9, 10, 11, 12, 13, 14, 16, 19, 33, 34, 39, 41, 42, 43, 44, 48, 52, 53, 60, 100, 104], "alia": 109, "alias": 105, "align": [6, 12, 13, 34, 42, 44, 45, 53, 57, 83, 105, 109, 112], "align_principal_axi": 109, "align_structur": [7, 8], "align_trajectori": [7, 8], "align_trajectory_first": [7, 8], "align_transform": 112, "aligned_coord": 10, "aligned_rmsd": 11, "aligned_rmsd_3": 11, "aligned_to_first_fram": 11, "aligned_traj": 14, "aligned_view": 9, "alignto": [10, 11], "aligntraj": [11, 12, 14, 34, 45], "all": [1, 2, 3, 4, 6, 7, 9, 11, 12, 13, 14, 15, 16, 17, 19, 20, 26, 30, 33, 34, 37, 38, 44, 46, 48, 50, 53, 57, 66, 81, 83, 92, 95, 98, 99, 100, 101, 102, 103, 105, 106, 108, 109, 112, 114], "all_atoms_in_residu": 98, "all_bend": 39, "all_coordin": 114, "all_data": 57, "all_residu": 98, "allevi": 4, "allow": [1, 2, 3, 4, 10, 13, 14, 19, 27, 28, 30, 36, 37, 40, 42, 43, 44, 52, 53, 56, 57, 60, 96, 99, 100, 103, 105, 106, 108, 110, 114], "allowai": 104, "almost": [19, 53, 109, 114], "alon": 57, "along": [12, 15, 19, 20, 22, 30, 42, 44, 46, 49], "alongsid": 85, "alpha": [9, 11, 13, 14, 19, 20, 22, 23, 24, 39, 40, 48, 50, 53, 55, 60, 67, 81, 82, 103, 106], "alpha_al": 103, "alpha_skip2": 103, "alpha_som": 103, "alreadi": [3, 7, 11, 14, 16, 33, 34, 46, 50, 53, 66, 99, 100, 106, 109], "also": [1, 2, 3, 4, 6, 7, 9, 10, 11, 12, 13, 14, 16, 18, 19, 20, 21, 26, 27, 28, 30, 32, 34, 37, 39, 40, 41, 42, 44, 48, 53, 55, 57, 61, 62, 81, 82, 87, 89, 98, 100, 101, 102, 103, 105, 106, 108, 109, 110, 111, 112, 113, 114], "alter": [34, 48], "altern": [1, 3, 13, 20, 30, 48, 57, 77, 81, 82, 96, 103, 106, 108, 109, 112], "although": [3, 7, 16, 30, 48, 63, 67, 79, 82, 83, 84, 105, 111, 112], "altloc": [1, 14, 61, 81, 82, 97, 106, 109], "alwai": [2, 3, 4, 10, 15, 16, 20, 26, 33, 34, 53, 57, 60, 61, 67, 79, 81, 83, 84, 87, 88, 96, 99, 101, 103, 106, 108, 109, 111, 113], "amadei": [34, 104], "amass": 84, "amber": [58, 59, 61, 97, 105, 107, 109, 113], "amber_atom_typ": 86, "amberparm": 52, "ambient": 48, "amend": [3, 105], "american": [34, 38, 104], "amid": 13, "amino": [13, 37, 104, 105], "amount": [15, 102, 108], "amp": [13, 14, 22, 23], "amstat": [14, 104], "amu": 63, "an": [2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 18, 19, 20, 21, 22, 23, 24, 26, 31, 33, 34, 37, 38, 39, 40, 42, 43, 44, 46, 48, 49, 50, 52, 53, 57, 60, 62, 66, 67, 69, 71, 72, 78, 80, 83, 84, 85, 87, 88, 89, 94, 96, 98, 99, 100, 101, 102, 104, 105, 106, 108, 110, 112, 114], "anaconda": 3, "analog": [30, 53], "analys": [3, 4, 6, 13, 16, 17, 25, 26, 28, 29, 52, 53, 99, 105], "analysi": [0, 1, 3, 4, 8, 9, 10, 11, 12, 13, 14, 17, 22, 23, 24, 27, 28, 30, 31, 32, 33, 35, 36, 40, 41, 43, 45, 46, 48, 49, 52, 55, 57, 85, 98, 99, 100, 103, 104, 105, 109, 110, 113, 114], "analysis_class": 16, "analysis_ensembl": 15, "analysisbas": [3, 15, 16, 105], "analysisfromfunct": [10, 15, 16], "analyt": 15, "analyz": [15, 66], "analyze_block": 15, "anchor_nam": 114, "andi": [38, 104], "andrea": [34, 104], "andrew": [33, 52, 104], "ang": 37, "angl": [1, 6, 7, 22, 26, 27, 28, 35, 39, 50, 53, 57, 61, 66, 67, 84, 86, 92, 97, 99, 104, 105, 106, 109, 113, 114], "angle_hnh": 53, "angle_nhh": 53, "angles_inc_hydrogen": 86, "angles_without_hydrogen": 86, "angstrom": [13, 20, 22, 23, 24, 30, 36, 40, 42, 48, 49, 50, 52, 63, 66, 79, 81, 82, 88, 106, 110, 112, 113], "ani": [1, 2, 3, 4, 11, 15, 16, 18, 27, 28, 30, 31, 37, 42, 43, 44, 46, 49, 50, 53, 56, 57, 61, 67, 89, 98, 99, 100, 101, 102, 103, 104, 105, 106, 108, 112], "anim": 30, "annot": [3, 46, 105], "announc": 102, "anoth": [0, 1, 4, 6, 7, 8, 10, 11, 12, 14, 19, 34, 50, 53, 96, 98, 106, 108], "answer": 34, "antoniu": [34, 104], "anybodi": 99, "anyth": [83, 100, 108], "anywai": 92, "anywher": 12, "ap": 104, "apach": 105, "apart": 39, "apb": 59, "apex": 53, "api": [3, 9, 10, 11, 13, 14, 15, 19, 22, 23, 24, 30, 31, 34, 36, 37, 38, 40, 42, 43, 44, 45, 46, 49, 85, 102, 103, 105], "app": 52, "appar": 43, "appear": [3, 34, 38, 48, 63, 68, 96, 102, 103], "append": [15, 21, 26, 27, 50, 52, 53, 96, 98, 102], "appl": 114, "appli": [3, 13, 16, 19, 30, 33, 36, 38, 42, 43, 44, 98, 104, 105, 106, 109, 111, 112], "applic": [4, 37, 58, 61, 66, 98, 114], "approach": [3, 4, 27, 33, 38, 104], "appropri": [15, 19, 36, 57, 68, 96, 103, 106, 108], "approv": [3, 102], "approx": [31, 108], "approxim": [7, 32, 33], "appveyor": [3, 108], "april": [9, 10, 39, 55, 104], "ar": [0, 1, 2, 3, 4, 5, 7, 8, 9, 10, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 60, 61, 65, 66, 67, 68, 69, 70, 72, 73, 75, 76, 77, 78, 79, 81, 82, 83, 84, 87, 88, 89, 92, 93, 94, 95, 96, 98, 99, 100, 101, 102, 103, 104, 105, 106, 107, 108, 109, 111, 112, 113, 114], "arallel": 104, "arang": [15, 23, 37, 42, 44, 45], "arbitrari": [57, 85], "arbitrarili": 114, "arc": [58, 59, 61, 97, 109], "architectur": [3, 100, 105], "area": [14, 26, 37, 42, 108], "aren": 106, "arendal": [37, 104], "arg": [1, 15, 18, 19, 21, 27, 28, 53, 83, 98, 106, 107, 109], "arg1": 3, "arg2": 3, "argmax": 40, "argn": 107, "argument": [13, 15, 16, 18, 19, 27, 30, 33, 37, 42, 44, 48, 50, 53, 61, 66, 67, 81, 88, 89, 94, 95, 96, 103, 105, 106, 108, 109, 112, 114], "aris": [1, 4], "arm": [100, 105], "arm64": [102, 105], "aromat": [105, 109], "around": [6, 7, 13, 14, 16, 19, 22, 26, 28, 30, 34, 36, 40, 42, 47, 50, 52, 53, 99, 100, 106, 114], "arr": 1, "arrai": [0, 1, 7, 12, 13, 15, 16, 17, 18, 19, 21, 24, 26, 27, 30, 33, 34, 36, 37, 39, 40, 42, 43, 44, 46, 48, 49, 50, 53, 57, 98, 103, 105, 108, 109, 112], "arrang": [31, 46], "array1": 108, "array2": 108, "articl": [9, 10, 14, 19, 20, 30, 37, 42, 43, 44, 45, 55, 104], "arxiv": 104, "as_cwd": 108, "asarrai": 15, "ascii": [58, 59, 61, 97], "asel": 105, "asf": 107, "ash": 107, "ask": [2, 3, 4, 16, 99, 100, 102, 108], "asn": [53, 107], "asn1": 107, "asp": [18, 19, 21, 27, 53, 107], "aspect": 2, "asph": 107, "aspher": [105, 109], "assert": 50, "assert_almost_equ": 108, "assert_array_almost_equ": 108, "assert_array_equ": 108, "assert_equ": 108, "assert_rais": 108, "assertionerror": 108, "assess": 53, "assign": [0, 19, 24, 50, 53, 57, 60, 61, 66, 95, 105, 109, 110, 114], "associ": [15, 33, 34, 38, 44, 50, 52, 53, 57, 98, 104, 105, 109, 111], "assum": [3, 50, 53, 57, 60, 61, 66, 67, 68, 79, 83, 88, 100, 114], "astyp": 26, "asu": [30, 104], "athanassio": [33, 104], "atom": [0, 3, 6, 7, 8, 9, 10, 11, 14, 15, 16, 17, 18, 19, 20, 26, 27, 30, 32, 33, 34, 35, 38, 39, 41, 42, 44, 46, 48, 49, 50, 51, 55, 60, 61, 65, 66, 69, 70, 71, 75, 76, 78, 82, 83, 84, 87, 88, 89, 91, 92, 95, 96, 99, 105, 107, 108, 109, 110, 111, 112, 114], "atom1": [1, 95], "atom2": [1, 95], "atom3": 1, "atom_nam": 86, "atom_resindex": [50, 114], "atom_styl": [66, 103], "atom_typ": [60, 66], "atom_type_index": 86, "atomgroup": [0, 6, 7, 9, 15, 16, 17, 19, 26, 31, 37, 39, 40, 50, 52, 55, 60, 71, 98, 103, 105, 106, 112], "atomic_numb": 86, "atomiccharg": [61, 97, 109], "atomicdist": 105, "atomist": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 104], "atomn": 95, "atomnam": [83, 106], "atomno": 65, "atomnum": [61, 97, 109], "atoms_in_residu": 98, "atomselect": 96, "atomtyp": 82, "atp": [13, 14, 22, 23], "attach": [50, 103], "attempt": [9, 81, 105], "attr": 0, "attribut": [0, 1, 3, 4, 14, 15, 26, 30, 39, 40, 53, 56, 60, 65, 66, 77, 81, 83, 87, 99, 103, 105, 106, 108], "attributeerror": 0, "atttempt": 105, "august": [14, 104], "austin": [45, 52, 53], "author": [3, 101, 102], "auto": [27, 42, 43, 44], "autobuild": [3, 4], "autocorrel": [27, 31], "autodetect": [68, 88], "autodock": 59, "autom": [3, 53, 102, 108], "automat": [3, 7, 10, 16, 18, 30, 55, 57, 65, 66, 76, 79, 89, 94, 99, 101, 102, 103, 104, 106, 114], "autovectoris": 100, "aux": 57, "aux_edr": 57, "aux_edr_tpr": 57, "aux_edr_xtc": 57, "aux_list": 57, "aux_n": 57, "auxdata": 57, "auxialliari": 105, "auxilliari": 105, "auxnam": 57, "auxread": [57, 105], "avail": [1, 2, 3, 4, 7, 15, 16, 19, 32, 33, 36, 40, 42, 43, 44, 53, 56, 57, 60, 66, 73, 77, 79, 82, 87, 96, 98, 99, 100, 102, 105, 106, 108, 109, 114], "averag": [6, 7, 8, 16, 26, 27, 31, 34, 35, 39, 40, 42, 44, 45, 49, 55], "averagestructur": 14, "avg": [42, 44, 48], "avid": 104, "avishek": [46, 104], "avoid": [3, 4, 14, 15, 16, 36, 42, 44, 48, 57, 98, 100, 101, 102, 105], "awai": [40, 50, 106], "awar": [15, 108], "ax": [13, 16, 23, 24, 33, 37, 38, 39, 42, 44, 45, 46, 48, 49, 53, 109], "ax0": [42, 44], "ax1": [42, 44], "ax2": [23, 24], "ax_10": 16, "ax_charg": 13, "ax_mass": 13, "ax_polar": 37, "axes3d": [44, 48], "axes3dsubplot": 30, "axessubplot": [18, 30, 31, 37], "axi": [6, 7, 10, 12, 15, 16, 22, 30, 34, 39, 44, 47, 48, 50, 55, 71, 109, 112], "axisgrid": 33, "axvspan": [14, 22], "aya9aladdin": 105, "b": [3, 4, 9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 61, 67, 81, 82, 87, 88, 98, 104, 106, 108, 109], "b98835": [34, 104], "b_1": 46, "b_2": 46, "b_i": 46, "b_l": 46, "back": [9, 48, 52, 53, 62, 79, 80, 86, 102, 103, 108, 110, 111, 112, 113], "backbon": [9, 11, 13, 14, 33, 34, 37, 45, 53, 98, 106], "backend": 105, "background": 99, "background_color": 48, "backslash": 3, "backward": [102, 105], "bakker": [37, 104], "balanc": 15, "ball": 50, "bandwidth": 44, "bansal": [39, 104], "bar": [4, 15, 31, 100, 103, 105], "barnoud": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "barrier": 15, "base": [2, 4, 5, 9, 10, 11, 12, 13, 14, 15, 16, 19, 28, 33, 39, 42, 44, 46, 50, 52, 53, 60, 61, 65, 79, 87, 89, 94, 102, 103, 104, 105, 106, 107, 108, 109], "bashrc": [3, 5], "basi": [40, 83], "basic": [7, 18, 19, 21, 25, 27, 28, 53, 65, 87], "basic_2": 19, "basisc": 28, "bat": 105, "bath": 52, "bb": [31, 53], "bbox": 109, "bdpw09": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55, 104], "bead": [1, 9, 53], "beauchamp": 52, "becaus": [3, 10, 13, 15, 16, 48, 50, 53, 56, 66, 68, 79, 101, 108, 111], "beckstein": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 104], "becom": [3, 4, 7, 9, 10, 31, 32, 33, 36, 40, 109], "been": [3, 15, 16, 18, 37, 48, 53, 60, 67, 70, 87, 102, 104, 105, 108, 109], "befor": [2, 3, 4, 13, 16, 30, 36, 45, 48, 60, 89, 100, 101, 102, 105, 106, 108, 111], "begin": [12, 16, 24, 30, 114], "behav": 106, "behavior": [11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 33, 38, 39, 43, 44, 49], "behaviour": [16, 28, 42, 45, 61, 71, 98, 105, 106, 114], "behind": 3, "being": [53, 56, 61, 93, 102, 105], "believ": 4, "bell": 57, "belleman": 87, "belong": [1, 28, 50, 53, 61, 98, 106, 107], "below": [1, 2, 3, 4, 5, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 21, 22, 26, 27, 28, 30, 33, 34, 36, 37, 38, 39, 40, 42, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 61, 98, 103, 106, 107, 108, 109, 112, 113, 114], "benchmark": [14, 104, 105], "bend": [39, 87], "benefit": [16, 99], "bengtsen": [42, 43, 44, 45, 104], "benjamin": [38, 104], "benthal": [45, 52, 53], "benzen": 78, "berendsen": [34, 104], "berk": 104, "bernard": [37, 52, 104], "besid": 15, "bespok": 105, "best": [3, 4, 12, 19, 20, 104, 108], "beta": [19, 22, 39, 50, 55, 67, 81, 82, 102], "better": [105, 108], "between": [2, 3, 4, 6, 7, 8, 9, 11, 14, 16, 17, 18, 19, 21, 24, 26, 27, 30, 32, 33, 34, 36, 38, 39, 40, 41, 46, 50, 53, 60, 80, 82, 83, 91, 99, 105, 108, 114], "bfactor": [14, 66, 87, 105, 106], "bfactor2rmsf": 105, "bfedder": 105, "bhe13": [19, 20, 104], "bibtex": [3, 53, 104], "bicub": 48, "biexponenti": 27, "big": 3, "bigg": 27, "bigger": 50, "biggin": [38, 104], "bilay": 26, "bin": [3, 9, 10, 11, 12, 13, 14, 26, 30, 33, 36, 40, 48, 49, 104, 105], "bin_cent": 26, "bin_edg": 26, "bin_radii": 30, "binari": [30, 57, 58, 59, 61, 79, 85, 87, 88, 90, 100], "bind": [13, 14, 22, 23, 105], "binder": 6, "binsiz": 49, "bio": 105, "bioinformat": [9, 10, 34, 37, 52, 55, 104], "biol": [45, 50, 52], "biolog": 60, "biologi": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 30, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55, 104], "biomolecular": [39, 68, 104], "biophys": [30, 104], "biopolym": 104, "biopython": [3, 101, 105], "bip": 104, "bisect": 39, "bit": [4, 12, 105], "bkv00": [39, 104], "bla": 3, "black": [3, 37], "blame": 99, "blank": [3, 82, 95, 105, 114], "block": [3, 12, 16, 30, 36, 53, 85, 99], "blockslic": 15, "blog": [55, 100, 105, 112], "blue": [30, 37, 48, 50, 72], "blurri": 114, "bold": [26, 27], "boldsymbol": 109, "boltzman_const": 105, "boltzmann_const": 105, "bond": [1, 13, 31, 49, 52, 53, 55, 57, 61, 66, 78, 80, 81, 82, 84, 86, 91, 92, 97, 98, 99, 104, 105, 106, 109, 114], "bonds_inc_hydrogen": 86, "bonds_without_hydrogen": 86, "bondtyp": [52, 80], "book": [34, 104], "bool": [1, 3, 18, 50, 109, 110], "boolean": [1, 53, 108, 110], "boomsma": [42, 43, 44, 45, 104], "boost": [26, 100], "bootstrap": [42, 44], "border": 55, "bot": [3, 102], "both": [1, 3, 4, 13, 15, 16, 22, 30, 38, 48, 50, 52, 53, 60, 63, 72, 81, 85, 87, 91, 98, 100, 102, 103, 105, 108, 109, 114], "bound": [3, 38, 42, 44, 45, 53, 103], "boundari": [48, 105, 106, 112], "box": [22, 23, 26, 40, 48, 49, 50, 52, 54, 57, 67, 71, 88, 105, 111, 112, 114], "box_cent": 55, "bradlei": 87, "branch": [4, 82, 105, 108], "brand": 2, "break": [3, 27, 66, 101, 105, 108], "breakdown": [3, 114], "brett": 2, "bridg": [19, 21], "bring": 3, "broader": 2, "broken": [48, 50, 105], "brook": 52, "browser": [4, 108], "bryan": [37, 104], "bsphere": [53, 109], "btx789": [9, 10, 52, 55, 104], "buchoux": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "bug": [2, 3, 16, 88, 102], "bugfix": 105, "build": [2, 15, 16, 50, 53, 65, 87, 99, 100, 105], "build_ext": 3, "built": [3, 4, 30, 87, 108], "bulk": 48, "bullet": 3, "bump": 102, "bumpi": 102, "bunch": 53, "bundl": 7, "button": [3, 4], "bynum": 106, "byre": 106, "byte": [57, 90], "bzip2": 105, "c": [1, 3, 13, 27, 30, 31, 34, 36, 37, 38, 39, 46, 48, 50, 52, 53, 62, 67, 78, 81, 82, 85, 87, 88, 98, 100, 102, 103, 104, 105, 106, 107, 113], "c1": [78, 106, 107], "c2": [78, 106, 107], "c21": 82, "c21_21": 82, "c22": 82, "c22_23": 82, "c3": [78, 106, 107], "c36b2": 67, "c4": [78, 106, 107], "c5": [78, 106, 107], "c5m": 107, "c6": [78, 107], "c8": 107, "c9cp01532a": [26, 27, 28], "c_": 53, "c_alpha": 14, "ca": [1, 9, 10, 11, 12, 13, 14, 16, 18, 20, 21, 23, 24, 36, 37, 38, 39, 40, 42, 43, 44, 46, 53, 60, 98, 103, 106, 107], "ca1": [19, 22], "ca1_df": 19, "ca2": [19, 22], "ca2_df": 19, "ca3": 19, "ca3_df": 19, "ca60": 40, "ca61": 40, "ca61_h2o_571": 40, "ca62": 40, "ca_df": [18, 21], "cach": [5, 15, 100], "cala": 107, "calc_bond": 105, "calcium": [53, 60], "calcrmsdrotationalmatrix": 105, "calcul": [6, 7, 8, 9, 10, 11, 16, 18, 19, 25, 33, 34, 35, 39, 41, 46, 47, 53, 55, 57, 61, 100, 104, 105, 109], "call": [0, 1, 3, 4, 7, 12, 15, 16, 19, 28, 30, 32, 34, 37, 50, 53, 68, 98, 99, 105, 106, 108, 109, 112], "callowai": 15, "calpha": 53, "came": [2, 108], "can": [1, 2, 3, 4, 5, 6, 7, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 60, 61, 62, 63, 64, 66, 67, 68, 69, 70, 71, 72, 74, 78, 79, 80, 81, 83, 84, 89, 91, 92, 94, 95, 96, 98, 99, 100, 101, 102, 103, 104, 105, 106, 108, 109, 110, 111, 112, 113, 114], "cannot": [7, 15, 32, 33, 37, 60, 68, 81, 82, 83, 103, 108, 109], "canon": 37, "capit": 3, "capitalclass": 3, "caption": 4, "carbon": [9, 11, 13, 14, 19, 20, 22, 23, 24, 31, 36, 40, 60, 106], "carbonn": 27, "card": [58, 59, 61, 97], "care": [30, 40, 83], "carefulli": [42, 67], "carg": 107, "carl": 114, "carpentri": 108, "carri": [14, 48], "carriag": 4, "cartesian": [34, 49, 104, 105], "case": [3, 4, 9, 10, 12, 13, 14, 15, 27, 28, 30, 36, 44, 48, 52, 53, 55, 57, 68, 82, 87, 89, 96, 99, 100, 104, 105, 106, 108, 111, 114], "casf": 107, "casn": 107, "casp": 107, "cast": 26, "catch": 4, "categori": [108, 109], "caught": 108, "caus": [84, 101, 102, 106], "caution": [98, 105], "cb": [1, 36, 53, 98], "cbar": [23, 24, 45, 48], "cbar0": [42, 44], "cbar1": [42, 44], "cbar2": [23, 24, 42, 44], "cc": [15, 34], "ccy": 107, "ccyx": 107, "cd": [3, 4, 100, 102, 104, 108], "cdf": 40, "cdot": [13, 31, 34, 60], "ce": [42, 53], "cecilia": [33, 104], "cell": [4, 9, 10, 11, 14, 19, 26, 34, 39, 48, 49, 50, 53, 55, 67, 81, 82, 105, 106, 108, 112], "cen_line_d": 30, "center": [13, 15, 16, 23, 24, 26, 30, 36, 40, 50, 53, 54, 105, 106, 109, 112], "center_in_box": [48, 55, 112], "center_of_charg": [105, 109], "center_of_geometri": [30, 50, 53, 55, 109], "center_of_mass": [15, 16, 23, 24, 53, 55, 60, 108, 109], "centr": 30, "central": 53, "centroid": [42, 43, 109], "certain": [5, 7, 13, 17, 19, 21, 30, 40, 42, 53, 57, 61, 66, 98, 106, 108, 109, 110, 114], "ces0": 42, "ces1": 42, "ces2": 42, "ces_ax": 43, "ces_ax2": 43, "ces_conv": 43, "ces_conv2": 43, "ces_converg": 43, "ces_fig": 43, "ces_fig2": 43, "cfg": [4, 100], "cg": [53, 84], "cg1": 105, "cg2": 36, "cgi": [9, 10, 11, 12, 13, 14, 19, 20, 33, 104], "cgln": 107, "cglu": 107, "cgly": 107, "ch": 31, "chain": [13, 14, 37, 50, 81, 82, 83, 96, 104, 105, 109, 112], "chained_ag_upd": 106, "chainid": [50, 61, 65, 81, 82, 83, 97, 105, 109], "chainread": [103, 105, 114], "chang": [1, 5, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 26, 27, 28, 30, 33, 34, 38, 39, 42, 43, 44, 45, 49, 53, 55, 57, 61, 71, 72, 81, 87, 89, 100, 102, 103, 106, 108, 111], "changelog": [3, 102, 105], "channel": [30, 48, 99, 104], "chapter": 69, "char": [96, 105], "charact": [3, 30, 71, 81, 82, 83, 93, 106], "character": [38, 39, 104], "characteris": [19, 20, 38, 39], "characterist": [9, 10, 11, 12, 13, 14, 33, 53, 104], "charg": [6, 7, 13, 28, 47, 48, 61, 66, 81, 82, 83, 86, 87, 92, 97, 105, 106, 109, 114], "charge_dens": [49, 105], "charge_density_stddev": 49, "chargegroup": 109, "charmm": [26, 58, 59, 61, 68, 81, 83, 88, 96, 97, 103, 106, 107], "chaya": 52, "chdir": 108, "check": [3, 4, 5, 11, 26, 27, 28, 50, 53, 57, 60, 66, 67, 72, 89, 102, 108], "checklist": 3, "checkout": [3, 4], "chem": [26, 27, 28, 45, 52, 53, 78], "chembl30": 105, "chemfil": [3, 58, 59, 61], "chemfilesread": 62, "chemfileswrit": 62, "chemic": [33, 34, 38, 53, 98, 104, 114], "chemistri": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 55, 104], "cheq": 84, "chi": 37, "chi1_select": [37, 105], "chi_1": 37, "chi_2": 37, "chi_n": 37, "chid": 107, "chie": 107, "chip": 107, "chiral": [105, 109], "chodera": 52, "choic": [3, 4, 38, 108], "choos": [3, 10, 13, 16, 19, 20, 26, 30, 34, 36, 42, 43, 48, 49, 53, 103], "chosen": [5, 27, 42, 44, 57, 112], "chri": 15, "chrispfa": 105, "christian": [26, 27, 28], "chunk": [30, 36], "ci": 34, "cienc": 104, "cile": 107, "circumv": 106, "citat": 7, "cite": [7, 8, 9, 10, 11, 12, 13, 14, 16, 26, 27, 28, 30, 33, 34, 38, 39, 42, 43, 44, 45, 46, 53, 104], "cl": [0, 30], "cl06": [33, 104], "claim": 105, "clang": 3, "clarif": 105, "clariti": [2, 26], "class": [4, 7, 12, 13, 14, 15, 17, 18, 19, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 49, 53, 57, 83, 96, 98, 100, 101, 103, 105, 108, 109, 113, 114], "classic": 105, "clean": 100, "clear": [3, 4, 5, 9], "clear_data_hom": 5, "clear_represent": 48, "clearli": [42, 83], "clementi": [33, 104], "cleu": 107, "click": [3, 108], "client": 15, "clm": [42, 43], "clone": [3, 100], "close": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 30, 33, 34, 37, 39, 40, 42, 43, 44, 45, 46, 48, 50, 53, 55, 104], "closecontactgnmanalysi": 38, "closer": [19, 44], "closest": 48, "clustalw": 3, "cluster": [6, 7, 15, 41, 44, 46], "cluster_collect": 42, "clustercollect": 42, "clustering_ensemble_similar": 43, "clustering_method": [42, 43], "clusteringmethod": [42, 43], "cly": 107, "cm": 113, "cmap": [12, 109], "cme": 107, "cmet": 107, "co": [31, 67], "coars": [1, 9, 19, 20, 53, 104], "cobrotoxin": 57, "code": [1, 2, 4, 5, 6, 7, 11, 13, 14, 15, 16, 30, 36, 48, 50, 57, 67, 78, 81, 82, 84, 93, 98, 99, 102, 103, 104, 105, 106, 108, 109, 112, 114], "codebas": [2, 16, 105], "codecov": 3, "coeff": 105, "coeffici": 52, "cog": [50, 106], "cog2": 50, "coifman": [33, 104], "col": [15, 16, 34], "collect": [5, 6, 7, 30, 32, 34, 53, 104, 105, 112], "colon": 106, "color": [14, 22, 30, 37, 48], "color_palett": [33, 34], "color_schem": [14, 50], "colorbar": [12, 23, 24, 42, 44, 45, 48], "colour": [10, 14, 30, 48, 108], "column": [12, 13, 16, 18, 19, 20, 21, 26, 33, 34, 50, 53, 81, 82, 83, 84, 91, 93, 103, 105, 108], "com": [3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 100, 104, 105, 108], "comar": 15, "combin": [3, 4, 7, 26, 32, 34, 42, 50, 53, 87, 106, 114], "combined_view": 50, "come": [3, 53, 84, 99, 102, 108, 114], "comfort": 2, "command": [3, 4, 5, 48, 53, 66, 68, 76, 96, 100, 104, 108], "comment": [3, 4, 9, 10, 14, 19, 34, 39, 48, 50, 55, 91, 95, 108], "commit": [102, 105], "common": [1, 3, 7, 12, 13, 14, 15, 22, 26, 31, 32, 34, 53, 55, 68, 70, 104, 106, 108], "commonli": [14, 50, 78, 98], "commun": [2, 3, 88], "commut": 46, "compact": 16, "compar": [1, 6, 7, 9, 10, 11, 12, 14, 15, 17, 19, 22, 32, 34, 40, 41, 42, 44, 45, 108], "comparison": [22, 42, 43, 44, 45, 104, 105, 106], "compat": [95, 100, 101, 102, 105, 108], "compet": 105, "compil": [3, 4, 79, 105], "complet": [2, 3, 5, 30, 53, 57, 112], "complex": [4, 15, 16, 28, 53, 99], "compli": 3, "complic": [61, 106], "compnd": [81, 82], "compon": [6, 7, 32, 33, 43, 44, 104, 108], "compos": [4, 98], "compound": [23, 24, 48, 55, 81, 87, 105, 108, 109, 112], "comprehens": [15, 98], "compress": [58, 59, 61, 105], "compris": 37, "comput": [3, 6, 7, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 47, 52, 53, 55, 56, 99, 100, 104, 108, 109, 113], "concat": 1, "concaten": [1, 15, 53, 103, 106, 114], "concept": [53, 56, 98], "concert": 38, "concis": 3, "conda": [4, 7, 53, 79], "conda_build_config": 102, "condit": [1, 15, 105, 106, 108, 110, 112], "conduct": [2, 99], "conect": [81, 105], "conf": 4, "confer": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "confid": 34, "confidenti": 108, "config": [15, 58, 59, 61, 97, 109], "configpars": 63, "configread": 63, "configur": [2, 3, 7, 19, 23, 32, 41, 67, 108], "confin": 93, "confirm": 102, "conflict": [3, 4, 88, 108], "conform": [3, 7, 9, 10, 11, 12, 13, 14, 18, 19, 20, 21, 22, 32, 33, 34, 37, 38, 41, 42, 43, 44, 45, 46, 53, 83, 104], "conjug": 105, "connect": [1, 3, 4, 33, 50, 52, 53, 60, 61, 82, 87, 91, 105, 114], "consecut": 27, "consensu": 108, "conserv": 57, "consid": [0, 2, 3, 7, 13, 15, 16, 27, 32, 34, 38, 41, 42, 98, 100, 101, 106, 108, 114], "consist": [4, 50, 53, 71, 87, 106], "consol": 30, "consolid": 15, "constant": [4, 26, 33, 49, 52, 66, 76, 105, 106], "constant_dt": 57, "constantli": [4, 33], "constr": 57, "constraint": [52, 87], "construct": [3, 6, 7, 15, 32, 34, 99], "constructing_univers": 114, "constructor": 114, "contact": [6, 99, 104], "contact_matrix": 21, "contactanalysi": 105, "contacts_within_cutoff": 21, "contain": [1, 3, 4, 7, 8, 12, 14, 15, 17, 26, 30, 34, 37, 39, 40, 41, 42, 44, 46, 48, 50, 53, 55, 57, 66, 72, 81, 84, 87, 88, 89, 91, 92, 93, 96, 98, 101, 102, 103, 104, 105, 106, 108, 109, 111, 112, 114], "contat": 19, "content": [3, 4, 95], "context": [1, 15, 30, 52, 53, 96, 108], "contigu": [39, 105], "continu": [2, 19, 27, 48, 89, 94, 102, 103, 105, 109, 114], "contour": 48, "contrast": 10, "contrib": [10, 14, 34, 39, 48, 55], "contribut": [7, 13, 36, 99, 102, 105, 108], "contributor": [3, 108], "contriv": 9, "control": [19, 39, 42, 44, 48, 110], "conveni": [15, 16, 30, 31, 37, 46, 53, 57], "convent": [13, 15, 22, 23, 60, 66, 67, 102, 105], "converg": [6, 7, 12, 13, 38, 41, 42, 104], "convergence_it": 42, "convers": [3, 13, 57, 99], "convert": [3, 4, 24, 37, 48, 52, 53, 57, 62, 63, 76, 78, 80, 81, 83, 86, 105, 113], "convert_dens": 48, "convert_length": 48, "convert_to": 52, "convert_unit": 57, "converterbas": 105, "coor": [58, 59, 61], "coord": 95, "coord_arrai": 50, "coordiant": 83, "coordin": [3, 7, 8, 11, 12, 14, 15, 16, 17, 18, 19, 20, 21, 24, 26, 28, 30, 32, 33, 34, 36, 38, 39, 42, 43, 44, 45, 49, 50, 52, 55, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 76, 77, 78, 79, 80, 81, 82, 83, 85, 87, 88, 89, 90, 91, 93, 94, 95, 103, 104, 105, 106, 108, 109, 111, 112, 114], "copi": [3, 4, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 33, 38, 39, 42, 43, 44, 45, 49, 50, 57, 102, 105, 108], "copy_coord": 10, "copyleft": 2, "core": [0, 2, 3, 13, 14, 15, 22, 23, 42, 44, 50, 53, 57, 83, 100, 102, 103, 105, 109, 112], "core_atom": 50, "core_seg": 50, "core_sel": 46, "corner": 106, "corr": 57, "correct": [4, 14, 26, 50, 53, 67, 102, 104, 105, 108], "correctli": [3, 4, 60, 67, 88, 104, 105, 108], "correspond": [1, 3, 12, 13, 14, 16, 24, 26, 27, 40, 55, 71, 98, 108, 109], "corrupt": 105, "cosin": 67, "cosine_cont": 34, "cosmo": 114, "coul": 57, "could": [9, 13, 16, 18, 23, 24, 34, 48, 88, 109], "coulomb": 57, "count": [19, 21, 26, 27, 36, 40, 96, 105], "count_by_id": [26, 27], "count_by_tim": 26, "count_by_typ": 26, "counter": 50, "coupl": 46, "cours": [4, 37, 55], "cov": [3, 108], "cov_estim": 45, "covari": [34, 45, 105], "covariance_matrix": 105, "cover": 108, "coverag": [3, 101], "cphe": 107, "cplett": [33, 104], "cpoint": 30, "cpro": 107, "cpu": 100, "cpu_count": 15, "crd": [9, 10, 12, 13, 45, 46, 52, 53, 58, 59, 61, 88, 97, 105, 109], "crdbox": [58, 59, 61], "crdparser": 65, "crdreader": 65, "crdwriter": 65, "creat": [0, 2, 9, 10, 12, 15, 19, 20, 24, 26, 30, 34, 36, 39, 49, 53, 57, 60, 71, 75, 78, 80, 81, 83, 84, 89, 94, 99, 100, 103, 105, 106, 108, 110, 112], "create_vmd_surfac": 30, "createsystem": 52, "creation": [3, 57, 78, 102, 105], "crick": 105, "criteria": 26, "cross": [48, 87], "crucial": [53, 106, 108], "cryst1": 82, "crystal": 106, "crystallographi": [9, 10, 11, 12, 13, 14, 33, 104], "crystallographica": [9, 10, 11, 12, 13, 14, 33, 53, 104], "cser": 107, "csv": 26, "cthr": 107, "ctrl": 4, "ctrp": 107, "ctyr": 107, "cube": [48, 49], "cubic": [50, 87, 111], "cumul": [34, 36, 40], "cumulated_vari": 34, "current": [3, 4, 9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 30, 33, 38, 39, 42, 43, 44, 45, 48, 49, 50, 53, 55, 57, 63, 67, 70, 72, 79, 81, 84, 87, 88, 89, 96, 100, 102, 103, 104, 106, 111, 112, 114], "curv": [27, 34], "curve_fit": 27, "custom": [18, 50, 66, 98, 99, 105, 109], "customis": 30, "cutoff": [6, 7, 17, 18, 20, 26, 38, 57, 106], "cval": 107, "cvect": 30, "cy": [37, 105, 107], "cyan": 48, "cycl": [3, 30, 44, 104, 108], "cylay": 106, "cylind": 106, "cylindr": 106, "cym": 107, "cys1": 107, "cys2": 107, "cysh": [105, 107], "cystein": 37, "cyt": 107, "cython": [100, 105], "cyx": 107, "cyzon": 106, "c\u03b1": [37, 104], "c\u03b2": [37, 104], "d": [26, 27, 28, 45, 46, 48, 52, 53, 60, 104], "d_a_cutoff": 26, "d_h_a_angle_cutoff": 26, "d_ix": 27, "da": [26, 27, 107], "da3": 107, "da5": 107, "da_dist": 26, "dab": 107, "daili": 100, "dalton": 63, "damag": 89, "damp": 42, "danieljamesevan": 105, "dark": 37, "dashboard": 15, "dask": 3, "data": [7, 15, 19, 20, 27, 32, 33, 34, 37, 39, 42, 43, 44, 46, 53, 55, 56, 58, 59, 61, 81, 82, 83, 84, 85, 89, 94, 95, 97, 98, 99, 103, 105, 109, 110, 111, 112, 113], "data_selector": 57, "databas": 69, "datadryad": 5, "datafil": [1, 5, 9, 10, 11, 12, 13, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 93, 96, 98, 101, 103, 106, 108, 109, 110, 111, 112, 114], "datafram": [13, 16, 18, 19, 20, 21, 26, 33, 34, 53], "datapars": 66, "dataread": 66, "dataset": [5, 14, 15, 114], "datawrit": [66, 105], "date": [3, 4, 102], "daunt": 2, "davi": [37, 104], "david": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 55, 104], "db1": 42, "db2": 42, "dbscan": 42, "dc": [57, 107], "dc3": 107, "dc5": 107, "dcd": [0, 3, 5, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 26, 27, 28, 33, 34, 38, 39, 42, 43, 44, 45, 46, 49, 53, 58, 59, 61, 103, 105, 106, 108, 110, 111], "dcd2": [9, 10, 12, 16, 38, 42, 44, 45, 46], "dcd_namd_gbi": [42, 44, 45, 46], "dcdplugin": 67, "dcdreader": [11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 33, 38, 39, 42, 43, 44, 45, 49, 67, 68], "dcdwriter": [67, 68, 108], "de": [33, 37, 104], "deactiv": 3, "deafult": 105, "deal": 105, "debenedetti": [33, 104], "dec": 78, "decai": [27, 31], "decemb": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 104], "decid": 3, "decim": [34, 94, 108], "decis": 103, "declar": [102, 108], "decomposit": [38, 43, 44], "decor": [15, 108], "decorrel": 31, "decreas": [19, 33, 44], "dedic": 3, "def": [3, 10, 15, 16, 18, 21, 27, 44, 50, 105, 108, 112], "default": [3, 5, 7, 9, 12, 13, 19, 22, 24, 27, 30, 33, 34, 36, 38, 39, 40, 46, 48, 49, 50, 53, 57, 61, 65, 66, 67, 68, 76, 79, 81, 82, 88, 94, 95, 96, 105, 106, 108, 111, 113, 114], "default_timestep": 114, "defin": [0, 3, 4, 15, 20, 22, 24, 26, 30, 31, 36, 37, 40, 42, 44, 46, 50, 53, 55, 57, 61, 67, 82, 86, 95, 96, 98, 105, 106, 108, 109], "definit": [18, 21, 31, 81, 82, 95], "definiton": 95, "degeneraci": 13, "degre": [37, 39, 53, 67, 81, 82, 113], "del": [57, 96], "delai": 15, "delaru": [19, 20, 104], "delet": [3, 102], "delete_angl": 109, "delete_bond": 109, "delete_dihedr": 109, "delete_improp": 109, "delete_temporary_fil": 30, "deliv": 3, "delta": [36, 48], "delta_": 46, "delta_h": 46, "demand": 2, "demonstr": [3, 7, 8, 13, 18, 19, 26, 30], "den": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 104], "dendrogram": 46, "dens": 42, "densiti": [6, 7, 36, 42, 44, 47, 52, 57, 105], "density_analysi": 48, "density_analysis_imag": 48, "density_from_pdb": 105, "density_from_univers": 105, "densityanalysi": [48, 105], "depend": [4, 10, 16, 26, 53, 60, 61, 68, 100, 102, 104, 105, 106, 108, 112], "depict": 103, "deploi": [102, 108], "deploy": 102, "deprec": [3, 4, 108], "deprecated_funct": 108, "deprecationwarn": [11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 33, 38, 39, 40, 42, 43, 44, 45, 49, 108], "depth": [3, 34], "der": [30, 33, 60, 104, 109, 114], "deriv": [2, 3, 84, 87, 98, 105, 109], "desc": 57, "descend": 26, "descr": 5, "describ": [3, 4, 7, 15, 32, 34, 36, 39, 40, 87, 103, 104, 106, 108, 114], "descript": [3, 5, 15, 30, 53, 57, 58, 61, 83, 87, 96, 97, 105, 108, 109], "design": [3, 18, 53, 85], "desir": [108, 109, 112], "desktop": 15, "desmond": 59, "desr": [58, 61, 69, 97], "detail": [3, 15, 30, 45, 53, 61, 80, 81, 98, 105, 108, 112], "details0": [42, 44], "details1": [42, 44], "details2": [42, 44], "detect": [79, 86, 103], "determin": [4, 6, 7, 9, 10, 11, 13, 14, 16, 17, 18, 19, 20, 21, 29, 33, 34, 37, 46, 53, 57, 98, 104], "determinist": 34, "dev": [3, 102], "dev0": [0, 1, 2, 3, 4, 5, 6, 7, 8, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 89, 90, 91, 92, 93, 94, 95, 96, 97, 98, 99, 100, 101, 102, 103, 104, 106, 107, 108, 109, 110, 111, 112, 113, 114], "develop": [2, 15, 52, 72, 101, 108], "deviat": [6, 7, 8, 9, 11, 30, 37, 39, 42, 44, 83, 104], "devic": [10, 103], "df": [13, 16, 26, 33, 34, 46], "df_charg": 13, "df_mass": 13, "dg": 107, "dg3": 107, "dg5": 107, "dha": [26, 27], "dha_angl": 26, "diagnost": 15, "diagon": 12, "diagonalis": 34, "dict_kei": [30, 39, 57], "dictionari": [1, 18, 30, 57, 60, 89, 105, 108, 114], "dicuss": 100, "did": [3, 14, 81, 105], "dielectr": 105, "diff": [3, 108], "differ": [1, 3, 4, 7, 9, 10, 12, 13, 15, 16, 19, 26, 28, 34, 36, 38, 40, 41, 45, 46, 48, 50, 53, 55, 60, 66, 67, 70, 71, 75, 82, 87, 91, 93, 95, 96, 98, 99, 100, 102, 103, 104, 105, 106, 112, 114], "differenti": 30, "difficult": [3, 4, 7, 19, 32, 40, 55], "difficulti": [2, 99], "diffus": [6, 7, 32, 34, 104], "diffusionmap": [12, 33], "digit": 93, "dih": [37, 57], "dihedr": [1, 6, 7, 35, 53, 61, 66, 84, 86, 97, 105, 106, 109, 114], "dihedrals_inc_hydrogen": 86, "dihedrals_without_hydrogen": 86, "dillon": 15, "dim": [44, 49, 55], "dim_red_method": 44, "dimens": [6, 22, 23, 26, 29, 37, 41, 49, 50, 55, 67, 81, 82, 104, 105, 106, 111, 112, 114], "dimension": [7, 12, 32, 33, 41, 44, 45, 104], "dimension_reduction_ensemble_similar": 43, "dimensionality_reduct": [43, 44], "dimensionality_reduction_method": [43, 44], "dimensionalityreductionmethod": [43, 44], "dimitri": [9, 10, 11, 14, 104], "din": 105, "dipol": 109, "dipole_mo": 109, "dipole_vector": 109, "direcli": 96, "direct": [3, 4, 30, 46, 57, 87, 98, 105], "directed_hausdorff": 46, "directli": [0, 1, 4, 16, 18, 19, 20, 23, 30, 37, 38, 44, 48, 52, 53, 99, 102, 103, 106, 109, 111, 112], "directori": [3, 4, 5, 30, 89, 101, 102, 104], "disabl": [57, 100, 105, 108], "disconnect": [7, 32, 33], "discord": 102, "discount": 36, "discrete_frechet": 46, "discuss": [2, 3, 15, 27, 60, 63, 79, 87, 99, 100, 101, 102, 108], "disk": [89, 94], "disper": 57, "displai": [13, 26, 46, 50, 53, 103, 104], "dissimilar": 13, "dist": [21, 22, 102], "dist_arr": 23, "dist_box": 22, "dist_matrix": 12, "distanc": [3, 6, 8, 13, 15, 16, 18, 19, 21, 26, 27, 30, 32, 33, 36, 38, 40, 42, 44, 50, 52, 53, 60, 105, 106, 109], "distance_arrai": [21, 23], "distance_typ": 105, "distancematrix": 12, "distant": 44, "distinguish": [3, 34], "distopia": [3, 105], "distribut": [2, 3, 6, 7, 15, 30, 35, 38, 41, 42, 44, 45, 70, 100, 102], "diverg": [14, 42, 43, 44, 45], "divers": 53, "divid": [15, 26, 33, 43, 50], "divis": 101, "dl": 63, "dl_poli": [58, 59, 61, 97, 105], "dlphhvdw08": [33, 104], "dlpoli": 63, "dlpolypars": 63, "dm": [58, 59, 61, 97, 109], "dmap": 33, "dmitri": 53, "dmonstrat": 34, "dmpc": 106, "dmsparser": 69, "dmsreader": 69, "do": [1, 3, 4, 6, 10, 11, 12, 13, 15, 16, 19, 22, 26, 27, 28, 30, 34, 37, 42, 44, 45, 46, 48, 50, 52, 53, 95, 99, 101, 102, 103, 105, 108, 114], "do_": 87, "doc": [4, 9, 10, 11, 13, 14, 22, 23, 24, 30, 31, 34, 36, 37, 38, 40, 42, 43, 44, 45, 46, 49, 102], "dock": 78, "docstr": 4, "document": [2, 5, 7, 15, 19, 22, 26, 30, 43, 48, 53, 66, 76, 89, 94, 105, 106, 108, 113], "documentation_pag": 3, "docutil": 3, "doe": [3, 4, 10, 13, 14, 15, 16, 19, 27, 30, 34, 40, 48, 52, 53, 55, 57, 63, 66, 71, 72, 80, 81, 82, 84, 87, 88, 92, 100, 101, 102, 105, 106, 108, 109, 110, 111, 112, 114], "does_not_exist": 1, "doesn": [13, 50, 92, 96, 98], "doi": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 104], "domain": [0, 7, 13, 14, 17, 19, 22, 23, 50], "domain_view": 50, "domanski": [45, 52, 53], "doma\u0144ski": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "domin": [33, 38], "don": [3, 10, 11, 18, 24, 26, 30, 40, 42, 53, 55, 100, 105, 111], "done": [3, 4, 14, 16, 30, 109, 114], "doniach": [19, 20, 104], "donor": [26, 27, 28, 84, 105], "donor_index": 26, "donor_ix": 26, "donor_resnam": 26, "donor_sel": 26, "donor_typ": 26, "donors_sel": 26, "dot": 33, "dotson": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "doubl": [64, 105], "dougla": [9, 10, 11, 12, 13, 14, 33, 53, 104], "down": [15, 100, 106], "download": [4, 5, 6, 14, 15, 100, 102, 108], "downsid": 15, "dozen": 57, "dr": 36, "drawn": [30, 44, 107, 111], "drdomenicomarson": 105, "dre": [42, 44], "dres0": 44, "dres1": 44, "dres2": 44, "dres_ax": 43, "dres_ax2": 43, "dres_conv": 43, "dres_conv2": 43, "dres_converg": [42, 43], "dres_fig": 43, "dres_fig2": 43, "driven": 108, "drm": [43, 44], "drop": [19, 43, 100, 105], "dropdown": 4, "dsiplac": 105, "dt": [27, 33, 34, 57, 61, 81, 88, 95, 105, 107, 114], "dt3": 107, "dt5": 107, "dtype": [0, 26, 30, 48, 49, 50, 98, 103, 109], "due": [26, 34, 44, 71, 83, 102, 105], "duecredit": 3, "duecredit_en": 104, "dump": [26, 58, 59, 61, 97, 103, 105], "dumpread": 76, "duplic": [1, 30, 53, 103, 106], "dure": [4, 10, 13, 15, 19, 57, 89, 103], "dx": [26, 27, 28, 46, 48, 104], "dylan": [26, 27, 28], "dynam": [4, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 48, 49, 52, 55, 99, 104, 105, 110, 111, 112, 114], "e": [0, 1, 3, 4, 5, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 60, 67, 80, 82, 99, 100, 101, 102, 103, 104, 105, 106, 108, 109, 112, 113, 114], "e1004415": [42, 43, 44, 45, 104], "e1004568": [46, 104], "e1005659": 52, "e59c36ab66f4": 109, "each": [0, 1, 3, 4, 6, 7, 9, 10, 12, 13, 14, 15, 16, 21, 22, 23, 26, 27, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 42, 44, 45, 46, 47, 48, 50, 53, 55, 57, 60, 61, 66, 96, 98, 99, 101, 102, 103, 105, 108, 109, 111, 112, 113, 114], "earli": 4, "earlier": [12, 16, 105, 108], "eas": 85, "easi": [3, 12, 18, 104, 112], "easier": [3, 4, 13, 26, 33, 34, 44, 55, 105], "easiest": [4, 33, 34, 53], "easili": [13, 15, 16, 24, 30, 34, 39, 43, 53, 55, 99, 101, 109], "eastman": 52, "eaton": [19, 20, 104], "ech": 84, "echo": 5, "edg": [30, 105], "edit": [3, 34, 102, 104], "editconf": 50, "editor": [3, 15, 45, 52, 53, 104], "edr": 105, "edrread": [57, 105], "effect": [3, 7, 10, 32, 43, 100], "effici": [10, 11, 13, 26, 27, 89, 94, 99, 111], "eha": 84, "eigenvalu": [33, 34, 38], "eigenvector": [7, 32, 33, 34, 38], "einsteinmsd": 105, "either": [3, 12, 13, 15, 19, 27, 30, 43, 45, 57, 62, 83, 103, 106, 109], "ej": [45, 50], "elast": [6, 7, 35], "electron": [83, 86, 105], "element": [1, 42, 50, 53, 60, 61, 65, 66, 70, 81, 82, 86, 97, 105, 109, 114], "elementwis": 13, "elena": [26, 27, 28, 42, 43, 44, 45, 104], "elimin": 106, "elizabeth": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "elpi": 3, "els": [3, 37, 83, 101], "elsevi": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 30, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55, 104], "elsewher": 100, "emac": 3, "emb": [4, 7, 32, 33, 55], "embed": [33, 44], "embrac": 108, "emerg": 108, "emphasi": 61, "emphasis": 42, "emploi": 67, "empti": [14, 50, 83, 105, 106, 109, 114], "en": [15, 30, 57, 104], "enabl": [4, 15, 85, 89, 94, 104, 105, 108], "enclos": 3, "encod": [84, 109], "encor": [7, 41, 42, 43, 44, 45, 104, 105], "encount": [61, 79, 100, 105], "encourag": [2, 108], "end": [3, 4, 15, 45, 81, 108, 111], "endbranch": 82, "endian": 90, "endmdl": 81, "endroot": 82, "ener": 57, "energi": [19, 20, 52, 57, 104], "engin": 108, "enhanc": [2, 3], "enough": [11, 12, 14, 37, 57], "ensembl": [6, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 41, 46, 48, 49, 50, 55, 104], "ensemble1_mean": 45, "ensur": [4, 36, 100, 102, 103, 106, 108], "ent": [58, 59, 61, 82, 93, 97, 109], "enter": 96, "enthalpi": 57, "entir": [10, 11, 13, 30, 36, 37, 40, 53, 103, 106, 108, 114], "entireti": 106, "entiti": 3, "entri": [3, 4, 30, 40, 66, 83, 102, 105], "enumer": [12, 30, 42, 44], "env": [3, 4, 11, 12, 13, 15, 16, 18, 20, 21, 28, 33, 37, 38, 40, 42, 43, 44, 45, 49, 108], "environ": [5, 79, 100, 104], "enzym": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 53, 55], "eoss4": 105, "ep": 42, "epot": 57, "epsilon": [33, 109], "epsilon14": 109, "equal": [3, 19, 24, 42, 43, 108], "equat": [3, 13, 14, 108], "equilibrium": [14, 52], "equiv": 46, "equival": [1, 27, 48, 87], "err_msg": 108, "error": [1, 3, 4, 9, 49, 53, 72, 79, 89, 94, 100, 101, 105, 108], "especi": [3, 4, 27, 67, 100, 102], "essenti": [7, 32, 33, 34, 104, 108], "estim": [7, 12, 41, 45], "estimate_error": [42, 44], "et": [12, 26, 27, 28, 53], "etc": [15, 50, 61, 87, 92, 102, 105, 114], "ev": 113, "evalu": [1, 6, 7, 34, 41, 49, 106], "even": [9, 15, 18, 22, 48, 53, 60, 61, 66, 68, 102, 104, 105, 106, 108, 109, 110, 111], "evenli": 15, "eventu": 3, "everi": [1, 3, 4, 10, 14, 15, 16, 24, 27, 30, 31, 34, 37, 39, 42, 44, 48, 50, 52, 53, 57, 60, 61, 98, 103, 105, 106, 108, 109, 111, 114], "everybodi": 99, "everyon": 108, "everyth": [1, 3, 4, 48, 53, 98, 101, 102], "evolv": 2, "ex": 30, "exact": [44, 108], "exactli": [4, 16, 88, 109], "examin": [15, 33, 50], "exampl": [0, 1, 3, 4, 7, 8, 9, 11, 13, 15, 16, 19, 26, 27, 28, 30, 34, 37, 39, 40, 42, 43, 48, 50, 52, 53, 57, 60, 66, 78, 83, 87, 96, 98, 100, 101, 102, 103, 104, 106, 108, 109, 110, 111, 113, 114], "exascal": 15, "except": [11, 15, 37, 43, 44, 81, 82, 101, 103, 109, 113], "exchang": [7, 32, 33], "exclud": [100, 105], "exclude_sam": 105, "exclus": [36, 87, 105], "exclusion_block": 36, "execut": [3, 15, 30, 48, 108, 112], "exemplar": 42, "exist": [3, 15, 19, 37, 53, 60, 103, 108, 109], "exit": [3, 30], "exp": [27, 31], "expand": [3, 4, 44, 84], "expect": [3, 9, 10, 14, 19, 34, 37, 39, 48, 50, 55, 76, 99, 105, 106, 108, 109], "experi": 3, "experienc": 100, "experiment": [3, 30], "explain": [3, 34], "explan": [3, 4, 9, 11, 30, 53], "explicit": [7, 32, 33, 109], "explicitli": [15, 30, 53, 61, 66, 88, 101, 114], "explor": [7, 15, 32], "expon": 33, "exponenti": 31, "export": [3, 5, 48, 53, 104, 106], "expos": 105, "express": [3, 4, 13, 106], "ext": [65, 84], "extend": [3, 23, 24, 50, 58, 59, 61, 65, 84, 97, 106], "extendedpdbpars": 93, "extendedpdbread": 93, "extens": [0, 3, 4, 18, 30, 53, 57, 61, 79, 81, 88, 96, 99, 102, 103, 105], "extern": [3, 5, 7, 48, 100, 101, 105, 106], "externalradiu": 106, "extra": [4, 15, 16, 30, 83, 100], "extra_cflag": 100, "extra_format": 105, "extra_requir": 105, "extract": [7, 26, 32, 53, 57, 98, 104], "extract_": 87, "ey": 102, "f": [3, 4, 11, 15, 26, 27, 28, 30, 34, 37, 39, 40, 46, 53, 57, 60, 98, 104, 105, 113], "fac": [34, 114], "face": 48, "facetgrid": 34, "facil": 57, "fact": 12, "factor": [10, 34, 39, 42, 48, 55, 61, 81, 82, 109, 113], "fail": [3, 71, 83, 88, 89, 94, 100, 102, 105], "failur": [3, 4, 102, 108], "fall": [79, 108, 109], "fals": [1, 4, 9, 11, 14, 19, 20, 26, 27, 30, 40, 44, 46, 48, 50, 53, 57, 78, 103, 105, 106, 108, 109, 110, 114], "fan": [15, 104], "fanci": [1, 53, 110], "faq": 4, "fast": [7, 8, 9, 10, 11, 12, 13, 14, 15, 33, 53, 79, 99, 103, 104], "fasten": [3, 105], "faster": [3, 26, 79, 100], "fault": 3, "favor": 105, "favour": 105, "feasibl": 10, "featur": [2, 3, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 83, 99, 100, 102, 114], "februari": [30, 104], "feedstock": 102, "feel": [2, 3], "femtomet": 113, "femtosecond": [52, 66, 68, 113], "fene": 87, "ferguson": [33, 104], "fetch": 3, "fetch_adk_equilibrium": [5, 14, 15], "few": [13, 15, 34, 48, 100, 108, 112], "fewer": [42, 88], "ff": 83, "ffast": 105, "fhi": [58, 59, 61, 97], "fhiaim": [58, 59, 61, 97, 109], "fhiaimspars": 73, "fhiaimsread": 73, "fhiaimswrit": 73, "field": [26, 30, 53, 60, 66, 82, 83, 87, 93, 106, 107, 109], "fig": [23, 24, 33, 45, 46, 48], "fig0": [42, 44], "fig1": [42, 44], "fig2": [23, 24, 42, 44], "fig_polar": 37, "figshar": [5, 14, 104], "figsiz": [42, 44], "figur": [4, 23, 24, 37, 44, 46, 48, 50, 61], "file": [0, 2, 3, 5, 50, 53, 56, 58, 59, 60, 61, 63, 66, 67, 68, 70, 77, 78, 79, 80, 82, 85, 86, 91, 92, 95, 96, 97, 98, 99, 100, 101, 104, 105, 106, 109, 111], "filenam": [10, 11, 14, 30, 57, 96, 103], "fill_alpha": 30, "fill_valu": 26, "filter": 105, "filterwarn": [9, 10, 14, 22, 23, 24, 27, 30, 34, 46, 50, 52, 53], "final": [3, 4, 10, 13, 15, 19, 39, 40, 48, 87, 102, 106], "finalis": [16, 102], "find": [3, 7, 16, 19, 25, 37, 40, 55, 67, 92], "fine": 105, "finicki": 12, "finish": [3, 16], "firefli": 70, "first": [1, 3, 4, 7, 9, 10, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 24, 26, 27, 30, 31, 32, 33, 34, 36, 37, 38, 40, 42, 44, 45, 46, 48, 49, 50, 53, 55, 57, 61, 69, 72, 81, 83, 89, 94, 98, 100, 101, 105, 106, 108, 110, 111, 114], "first_clust": 42, "first_hbond": 26, "firstli": 108, "fit": [6, 14, 27, 31, 39, 42, 46, 48, 53, 56, 112], "fit_ac": 27, "fit_biexponenti": 27, "fit_rot_tran": [48, 112], "fit_t": 27, "fiter": 110, "five": [33, 34, 53, 93], "fix": [2, 3, 4, 48, 49, 68, 72, 102], "fkdd07": [19, 20, 104], "flag": [3, 4, 84, 86, 103, 105, 108], "flake8": 3, "flaki": 102, "flat": [24, 30, 44, 48], "flatten": [24, 30, 34, 48], "flavour": 84, "flexibl": [14, 15, 16, 23, 30, 59, 63, 85, 99, 104, 105], "flip": 9, "float": [48, 83, 105, 108, 109, 112], "float32": [49, 103], "float64": [26, 109], "florian": [34, 104], "fluctuat": [6, 7, 8, 13, 19, 27, 34], "fluid": [26, 27, 28], "fly": [14, 111, 114], "fm": 113, "fnmatch": 106, "focu": 99, "focus": [15, 99], "fold": [7, 17, 19, 20, 104], "folder": [3, 30, 108], "follow": [3, 4, 13, 16, 18, 23, 26, 27, 30, 34, 38, 46, 48, 53, 57, 60, 61, 63, 65, 67, 79, 81, 83, 87, 88, 91, 95, 100, 101, 102, 103, 105, 106, 108, 109, 114], "follw": 26, "foo": 108, "footnot": 82, "footprint": 57, "forc": [3, 26, 50, 52, 53, 57, 58, 60, 61, 63, 89, 94, 103, 105, 106, 107, 109, 111, 114], "forcefield": 26, "foremost": 98, "forg": [4, 100], "form": [2, 13, 19, 26, 42, 53, 55, 60], "formal": 105, "formalcharg": [105, 109], "format": [10, 13, 14, 19, 21, 22, 23, 30, 31, 33, 34, 36, 37, 40, 42, 43, 44, 45, 48, 52, 53, 58, 60, 62, 64, 65, 66, 67, 69, 70, 71, 72, 73, 76, 78, 80, 83, 84, 85, 86, 88, 89, 91, 92, 93, 94, 95, 97, 98, 99, 102, 104, 105, 106, 111, 113, 114], "formatt": 3, "former": [13, 52, 108], "fortran": 3, "fortran77": 30, "found": [4, 5, 19, 26, 28, 30, 31, 37, 42, 53, 103], "foundat": [9, 10, 11, 12, 13, 14, 33, 104], "four": [4, 26, 39, 44, 45, 103, 109], "fourier": 87, "fourth": [30, 111], "fowler": [30, 104], "fpkd11": [33, 104], "frac": [13, 16, 19, 24, 27, 31, 36, 109, 113], "fraction": [6, 7, 17, 18, 20, 21, 76], "fraction_contacts_between": 18, "fragil": 60, "fragindic": 108, "fragment": [0, 31, 48, 49, 50, 55, 105, 106, 108], "frame": [1, 7, 9, 10, 12, 13, 14, 16, 17, 18, 19, 20, 21, 26, 27, 30, 32, 33, 34, 36, 37, 38, 39, 40, 43, 44, 46, 48, 49, 52, 55, 56, 61, 66, 71, 81, 82, 89, 94, 99, 105, 106, 108, 110, 111, 112, 114], "frame_index": 15, "frame_open": 12, "frame_valu": 15, "frameiter": 110, "framework": [15, 99, 108], "franklin": [19, 20, 104], "free": [2, 3, 101], "freez": 102, "frequenc": [38, 104], "frequent": [13, 14, 26, 57, 100], "friction": 52, "friend": 3, "from": [0, 2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 17, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 55, 56, 57, 58, 60, 61, 63, 64, 65, 66, 67, 68, 69, 72, 75, 76, 78, 79, 81, 82, 83, 84, 87, 91, 92, 93, 94, 95, 96, 98, 99, 100, 101, 102, 103, 104, 105, 106, 107, 108, 110, 111, 112, 113], "from_file_view": 9, "from_smil": 105, "fudge_factor": 60, "full": [3, 4, 26, 30, 44, 57, 66, 85, 89, 100, 102, 112], "fulli": [16, 30, 100, 108], "func": [3, 15], "funcion": 26, "function": [1, 2, 3, 4, 6, 7, 8, 13, 17, 19, 20, 21, 27, 30, 33, 34, 35, 37, 41, 42, 43, 44, 45, 46, 52, 53, 55, 56, 57, 85, 87, 98, 100, 101, 102, 104, 105, 106, 109, 111, 112, 114], "functool": [15, 112], "fundament": [53, 56, 114], "further": [3, 4, 13, 15, 27, 50, 52, 53, 60, 62, 87, 98, 100, 105, 106], "futher": 108, "futur": [3, 15, 101, 105, 108], "fver": 87, "fver_err": 87, "g": [1, 3, 4, 5, 7, 14, 15, 19, 20, 26, 30, 32, 33, 34, 37, 53, 57, 67, 80, 99, 100, 101, 102, 103, 104, 106, 107, 108, 109, 112, 113, 114], "g2707": 105, "g96": 87, "g_": [36, 40], "g_pickl": 103, "gain": 12, "galleri": 53, "gamess": [58, 59, 61, 97], "gamma": [22, 39, 50, 55, 67, 81, 82], "gamma_": 46, "gap": [33, 103], "gasteig": 82, "gate": [30, 104], "gather": [15, 30], "gaussian": [44, 45], "gave": 4, "gazzarrini": [26, 27, 28], "gb": [15, 57], "gbn2": 52, "gbscreen": 109, "gcc": [3, 100], "gecht": [15, 104], "gen_release_not": 102, "gener": [2, 3, 4, 7, 8, 9, 10, 14, 15, 18, 19, 20, 28, 30, 34, 37, 38, 39, 48, 50, 53, 55, 58, 59, 61, 67, 77, 80, 89, 94, 99, 102, 103, 104, 105, 113, 114], "generate_path": 46, "generate_t": 105, "geometr": [1, 6, 7, 26, 41, 52], "geometri": [7, 13, 23, 30, 32, 33, 37, 39, 48, 50, 53, 104, 106, 109, 112], "gerhard": [34, 104], "get": [3, 4, 13, 15, 16, 24, 34, 36, 40, 42, 43, 44, 45, 48, 61, 72, 79, 86, 87, 89, 98, 99, 100, 105, 108, 109], "get_aux_attribut": 57, "get_aux_descript": 57, "get_auxreader_for": 57, "get_cdf": 40, "get_conversion_factor": 113, "get_data": 57, "get_data_hom": 5, "get_descript": 57, "getmonomerinfor": 105, "getnam": 105, "gh": [3, 102], "gia": 104, "gif": [10, 14, 34, 39, 48, 55], "gist": 50, "git": [3, 4, 100, 102], "github": [4, 6, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 33, 38, 39, 43, 44, 49, 99, 100, 101, 102, 105], "give": [3, 4, 7, 16, 17, 19, 21, 23, 24, 31, 37, 40, 44, 49, 53, 67, 98, 100, 108, 110, 112, 114], "given": [3, 4, 12, 15, 19, 20, 22, 24, 28, 34, 37, 39, 40, 44, 48, 53, 57, 60, 102, 103, 105, 106, 109, 112, 113, 114], "gkm342": [19, 20, 104], "gl": 106, "glb": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "glh": 107, "gln": [53, 106, 107], "global": [3, 7, 32, 33, 34, 101, 106], "global_ax": 39, "global_axi": 39, "global_tilt": 39, "glu": [18, 19, 21, 27, 53, 106, 107], "gluh": 107, "glutam": 53, "glx29": 106, "gly": [27, 37, 53, 96, 98, 106, 107], "gm": [58, 59, 61, 97, 109], "gmsparser": 70, "gmsreader": 70, "gmx": [48, 89, 94, 96, 114], "gmxdump": 87, "gmxfio_rw": 87, "gmxfio_xdr": 87, "gmxfiofio": 87, "gmxlib": 87, "gnm": 38, "gnmanalysi": 38, "gnu": [2, 108], "go": [2, 3, 4, 15, 16, 96, 102, 106], "good": [3, 4, 102], "goodfellow": [30, 104], "gov": [30, 104], "gower": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "gp": [34, 104], "gplv2": 105, "gplv3": 105, "gradual": [19, 105], "grai": 50, "grain": [1, 9, 19, 20, 53, 104], "gram": 52, "gramicidin": [30, 104], "grant": 105, "graph": [13, 15], "graphic": [9, 10, 30, 52, 55, 96, 104], "great": [2, 4], "greater": [18, 26, 27, 33, 106], "greatest": 46, "green": [14, 15, 22, 102, 108], "grid": [24, 48, 50], "grid_siz": 50, "griddataformat": [3, 101], "gro": [37, 42, 44, 45, 46, 53, 58, 59, 61, 87, 97, 103, 105, 109, 114], "groamc": 105, "gromac": [0, 16, 48, 50, 57, 58, 59, 61, 85, 96, 97, 98, 103, 105], "gromacs_dir": 87, "gromacswrapp": 96, "gromo": 107, "gromos11": [58, 61, 105], "gropars": 71, "groread": 71, "grossfield": 12, "ground": 99, "group": [0, 13, 22, 30, 31, 34, 40, 42, 43, 49, 50, 83, 84, 96, 103, 105, 106, 108, 109, 112, 114], "group_a": 21, "group_b": 21, "groupbi": [53, 108], "groupselect": [13, 53], "grow": [2, 5, 108], "growrit": 71, "gsd": [3, 58, 59, 61, 97, 105, 109], "gsdparser": 72, "gsdreader": 72, "gsoc": 105, "gt": [9, 10, 12, 13, 14, 15, 16, 18, 22, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 40, 42, 43, 44, 46, 48, 49, 50, 52, 53], "gua": 107, "guarante": [26, 83], "guard": 101, "guess": [13, 28, 50, 53, 57, 61, 65, 67, 81, 92, 97, 103, 105, 109], "guess_bond": [60, 109, 114], "guesser": [60, 105], "gui": 96, "guid": [2, 3, 6, 7, 11, 12, 13, 15, 16, 18, 20, 21, 28, 33, 37, 38, 40, 42, 43, 44, 45, 49, 69, 100, 108], "guidelin": [2, 105], "gyrat": [53, 105, 109], "gyration_mo": 109, "gzip": 105, "h": [1, 3, 27, 31, 36, 39, 45, 50, 52, 53, 78, 87, 96, 98, 103, 106], "h1": [26, 28, 50, 52, 78], "h2": [1, 26, 28, 50, 78], "h2o": 50, "h3": 78, "h4": 78, "h5": 78, "h5md": [58, 61, 105], "h5mdreader": 105, "h5mdwriter": 105, "h5py": 3, "h6": 78, "h_": 27, "h_ix": 27, "h_pickl": 103, "ha": [0, 2, 3, 7, 9, 10, 11, 13, 14, 15, 16, 18, 19, 22, 23, 24, 28, 29, 30, 34, 36, 40, 42, 43, 44, 45, 46, 48, 50, 52, 53, 55, 70, 87, 96, 98, 100, 102, 103, 105, 106, 108, 109, 111, 114], "ha1": 53, "ha2": [30, 53, 98], "ha3": 98, "habit": 108, "had": [43, 102, 105], "hai": [9, 10, 52, 55, 104], "hakarishirenai": 105, "half": [19, 37], "hall": [38, 104], "hand": [87, 108], "handl": [3, 15, 79, 105, 112], "happen": [3, 89, 101, 106], "happi": [3, 22], "hard": [15, 79, 106], "hard_cut": 19, "hard_cut_q": 19, "harmon": [6, 7, 19, 20, 33, 41, 87, 104], "harold": 104, "harrigan": 52, "hasattr": [50, 53, 109], "have": [1, 2, 3, 4, 10, 11, 12, 13, 14, 15, 16, 18, 19, 22, 24, 26, 27, 30, 31, 33, 34, 36, 37, 40, 42, 44, 45, 46, 48, 50, 53, 55, 57, 60, 63, 66, 67, 69, 71, 75, 79, 81, 82, 84, 87, 89, 95, 98, 100, 101, 102, 103, 104, 105, 106, 107, 108, 109, 110, 114], "hb": [26, 36], "hb1": [53, 98], "hb2": [53, 98], "hb3": 98, "hbl": 27, "hbond": [26, 27, 28, 52, 105], "hbond_analysi": [26, 27, 28, 105], "hbond_lifetim": 27, "he": [27, 28, 45], "he1": 53, "he2": 53, "he3": 53, "head": [3, 18, 19, 20, 21, 33, 34, 53], "header": [66, 81, 87, 91, 105], "headgroup_atom": 26, "heat": [12, 46, 48, 52], "heatmap": [12, 24, 46], "heavi": [98, 105], "heetvekariya": 105, "height": 26, "hel": 39, "helan": [39, 104], "helanal_imag": 39, "held": [3, 109], "helic": [39, 104], "helix": [6, 7, 35, 104, 105], "helix_analysi": [39, 105], "help": [1, 2, 3, 4, 13, 16, 22, 96, 99, 100, 106, 108], "helper": [30, 44], "henc": [3, 4], "herbst": [33, 104], "here": [3, 4, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 60, 78, 100, 102, 105, 107, 109], "hereman": [33, 104], "herman": [34, 104], "hes02": [34, 104], "hess": 104, "hetatm": [82, 83, 98, 109], "hg1": [27, 36, 53], "hg2": 53, "hg21": 36, "hg22": 36, "hg23": 36, "hh": 27, "hh11": [27, 28, 83], "hh12": 28, "hh21": 28, "hh22": [27, 28], "hi": [28, 53, 105, 107], "hid": 107, "hidden": [4, 53, 89, 94, 104], "hie": 107, "hierarchi": [46, 98], "high": [3, 4, 7, 14, 15, 32, 34, 42, 45, 52, 85, 106], "higher": [10, 13, 33, 42, 105], "highest": [14, 34, 40, 48, 50], "highli": [3, 26, 61, 85, 100], "highlight": [22, 38, 57, 102, 108], "hip": 107, "hire": 57, "hiromu": 104, "his1": 107, "his2": 107, "hisa": 107, "hisb": 107, "hisd": 107, "hise": 107, "hish": 107, "hist": [26, 38], "hist_bin_edg": [49, 105], "histax": 38, "histfig": 38, "histidin": 53, "histogram": [26, 30, 48, 105], "histogram_radii": 30, "histogramdd": 105, "histor": [3, 4], "histori": [58, 59, 61, 97, 105, 109], "historypars": 63, "historyread": 63, "hit": [3, 4, 108], "hitchhik": 3, "hkp": [38, 104], "hmacdop": 105, "hn": [28, 53], "hnh": 53, "hoc": 60, "hoh": 30, "hold": [37, 53, 99, 111, 114], "hole": [7, 100, 104, 105], "hole000": 30, "hole001": 30, "hole002": 30, "hole003": 30, "hole004": 30, "hole005": 30, "hole006": 30, "hole007": 30, "hole008": 30, "hole009": 30, "hole010": 30, "hole1": 30, "hole2": [3, 6, 7, 29, 105], "holeanalysi": 30, "holoview": 12, "home": [3, 4, 11, 12, 13, 15, 16, 18, 20, 21, 28, 33, 37, 38, 40, 42, 43, 44, 45, 49], "homepag": 4, "homogen": [36, 40], "hoomd": [58, 59, 61, 97], "hoomdxmlpars": 92, "hope": 105, "host": [2, 3, 5], "how": [3, 4, 10, 12, 13, 14, 15, 16, 18, 21, 23, 24, 27, 28, 30, 34, 38, 39, 40, 42, 43, 44, 53, 55, 71, 78, 84, 100, 102, 106, 108, 112, 113, 114], "howev": [0, 1, 3, 4, 7, 9, 10, 13, 14, 15, 16, 19, 26, 27, 30, 31, 32, 34, 39, 44, 48, 50, 52, 53, 55, 57, 67, 69, 71, 72, 84, 87, 89, 96, 98, 100, 101, 102, 103, 105, 108, 109, 114], "hpc": 15, "hri": 104, "hsd": [53, 107], "hse": [53, 107], "hsp": 107, "hstack": 10, "ht": 26, "ht1": 53, "ht2": 53, "ht3": 53, "html": [3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104, 108], "htmlcov": 108, "http": [3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 100, 104, 105], "hue": [33, 34], "hummer": [19, 20, 104], "hupe": 104, "hw16365": 40, "hyaluron": [26, 27, 28], "hydrogen": [50, 84, 98, 105, 106], "hydrogen_bond": [7, 25], "hydrogen_index": 26, "hydrogen_ix": 26, "hydrogen_sel": 28, "hydrogenbond": [26, 27, 28, 105], "hydrogenbondanalysi": [26, 27, 28, 105], "hydrogenbondanaysi": [26, 27, 28], "hydrogenbondlifetim": 105, "hydrogenbondsanalysi": 26, "hydrogens_sel": [26, 27, 28], "hydrogon": 26, "hyp": 107, "hypothesi": 3, "hz1": 28, "hz2": [27, 28], "hz3": [27, 28], "i": [0, 1, 2, 3, 4, 5, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 56, 57, 60, 61, 65, 66, 67, 68, 69, 70, 71, 73, 75, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 89, 91, 93, 94, 95, 96, 98, 99, 100, 101, 102, 103, 104, 105, 106, 108, 109, 110, 111, 112, 114], "i10": 84, "i4": 84, "i8": 84, "iac": 84, "ian": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "ibisco": [58, 59, 61], "icod": [14, 61, 81, 82, 97, 106, 109], "id": [3, 13, 23, 24, 26, 42, 43, 44, 45, 50, 61, 65, 66, 69, 75, 83, 84, 87, 98, 104, 106, 109], "id_var": 34, "idea": [2, 3, 53, 102], "ideal": 108, "ident": [3, 4, 12, 16, 42, 44, 72, 87, 114], "identif": [26, 34, 104], "identifi": [14, 26, 28, 42, 81, 82, 92], "iederhut": 104, "ignor": [4, 9, 10, 14, 22, 23, 24, 27, 30, 33, 34, 37, 46, 50, 52, 53, 81, 82, 84, 95, 105, 106, 114], "ignore_residu": 30, "ii": 84, "ij": [27, 48], "il": [37, 53, 105, 106, 107, 109], "ildn": 107, "illon": 104, "illustr": [15, 28, 33, 48], "im": [23, 24, 45, 48], "im0": [42, 44], "im1": [42, 44], "im2": [23, 24], "imag": [4, 9, 10, 12, 14, 15, 19, 22, 23, 34, 39, 50, 55, 105, 108], "imi": [42, 44], "immedi": [7, 15, 19, 32, 33, 102, 108], "imov": 84, "impact": [105, 114], "implement": [1, 3, 7, 9, 10, 11, 12, 13, 14, 15, 16, 32, 33, 34, 39, 53, 57, 62, 66, 76, 82, 87, 95, 106, 112], "implicitli": 15, "implicitsolv": 52, "import": [1, 3, 5, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 56, 57, 60, 78, 83, 87, 93, 96, 98, 102, 103, 105, 106, 109, 110, 111, 112, 114], "importantli": 108, "importerror": [3, 101, 108], "importorskip": 108, "improp": [53, 61, 66, 84, 86, 97, 109, 114], "improperdihedr": [1, 109], "improv": [2, 27, 99, 108], "imshow": [12, 23, 42, 44, 45, 48], "in1d": 105, "in_memori": [10, 11, 12, 14, 34, 55, 103, 114], "in_memory_step": 114, "inaccur": 53, "inact": 82, "includ": [2, 3, 4, 7, 9, 10, 13, 14, 15, 16, 19, 34, 36, 37, 39, 43, 48, 50, 52, 53, 55, 57, 84, 85, 87, 95, 96, 98, 99, 100, 102, 104, 105, 106, 108, 109, 111, 112, 114], "inclus": [53, 93, 105, 106], "incompat": [102, 105], "inconsist": [4, 105], "incorpor": 13, "incorrect": [105, 114], "incorrectli": [53, 83, 84, 105], "increas": [3, 27, 33, 42, 43, 44, 85, 102, 105, 108], "increasingli": 15, "increment": 83, "inde": [14, 19, 44], "indent": 3, "independ": [11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 33, 38, 39, 42, 43, 44, 45, 49, 57, 101], "index": [3, 4, 11, 13, 15, 16, 19, 26, 27, 30, 31, 33, 34, 40, 48, 53, 56, 75, 83, 84, 87, 96, 103, 105, 108, 109, 110, 111], "indexerror": 108, "indic": [1, 3, 12, 13, 14, 19, 24, 26, 27, 30, 33, 34, 38, 40, 43, 50, 53, 81, 82, 84, 87, 91, 96, 101, 105, 106, 108, 109, 110], "individu": [3, 4, 7, 13, 30, 38, 49, 53, 57, 77, 96], "inertia": [42, 43, 109], "infer": [13, 19, 105], "info": [3, 27], "inform": [1, 3, 4, 7, 10, 12, 14, 15, 16, 19, 22, 26, 28, 30, 32, 33, 34, 37, 40, 42, 43, 44, 46, 50, 52, 56, 57, 60, 62, 63, 66, 69, 70, 71, 72, 80, 81, 82, 84, 87, 88, 94, 95, 98, 101, 103, 105, 106, 108, 111, 112, 114], "informatin": 92, "inh": 82, "inherit": [3, 108], "ini": 4, "init": [42, 43], "initi": [13, 14, 16, 19, 48, 108, 113], "initial_contact": 19, "initial_tim": 57, "initialis": [16, 42, 44, 49, 53, 57], "inlin": [3, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 53], "inner": 106, "innerradiu": 106, "inpcrd": [58, 59, 61], "inplac": [3, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 33, 38, 39, 42, 43, 44, 45, 49], "inpread": 74, "input": [15, 23, 48, 58, 59, 61, 63, 68, 87, 97, 105, 109, 112, 114], "insensit": 106, "insert": [81, 82, 84, 93, 106, 109], "insid": [15, 53, 96, 101, 108], "insight": [7, 9, 10, 11, 12, 13, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 104], "instal": [2, 3, 4, 5, 7, 10, 30, 33, 34, 42, 43, 44, 46, 48, 53, 55, 79, 101, 104, 105, 108], "instanc": [1, 36, 50, 53, 57, 78, 106, 114], "instead": [1, 3, 4, 9, 10, 12, 14, 15, 16, 19, 23, 24, 30, 34, 37, 39, 43, 44, 48, 50, 55, 61, 81, 82, 88, 92, 93, 100, 105, 106, 108, 111, 114], "institut": [34, 104], "instruct": [2, 3, 4, 53, 100], "int": [3, 26, 30, 50, 109, 114], "int64": 109, "int_0": 36, "integ": [26, 66, 72, 81, 82, 83, 102, 105, 108], "integr": [3, 7, 15, 32, 33, 52, 85, 105], "intel": 105, "intend": [98, 100], "intent": [3, 105], "interact": [4, 6, 9, 10, 12, 14, 19, 26, 27, 28, 34, 36, 39, 50, 52, 55, 87, 104, 109], "interest": [1, 19, 30, 48, 53, 100], "interfac": [5, 26, 53], "interface_zpo": 26, "interfer": [3, 100], "intermedi": [30, 104], "intern": [4, 34, 53, 104, 110], "interpol": 48, "interpret": [3, 7, 24, 32, 33, 34, 42, 53, 67, 105], "interrdf": [36, 40, 105], "interrdf_": [40, 105], "intersect": [1, 106], "interv": 34, "intra_angl": 105, "intra_bond": 105, "intra_dihedr": 105, "intramolcular": 28, "intramolecular": 27, "intrins": [7, 32, 33], "introduc": [102, 105], "introduct": [18, 20, 21, 33, 34, 43, 53, 99, 104, 105, 112], "intuit": 34, "invent": 114, "invers": 105, "investig": [13, 34], "invok": 106, "involv": [16, 26, 28, 37, 52, 53, 105, 111], "involve": 26, "io": [4, 15, 79, 98], "ioanni": [15, 33, 104], "ion": [30, 42, 44, 104, 105], "ippa": 104, "ipygani": 48, "ipynb": [4, 43, 114], "ipython": [3, 4, 50, 109], "iqmol": 50, "irdf": 36, "irdf2": 36, "irdf3": 36, "irdf4": 36, "is_anchor": 114, "is_guess": 109, "is_in_contact": 18, "is_strict_subset": 1, "is_strict_superset": 1, "isbn": [34, 104], "isdesnat": 108, "isdisjoint": 1, "isin": 105, "isn": [13, 50], "isnat": 108, "iso": 48, "iso_v": 48, "isol": [3, 4], "isolay": 105, "isolevel": 48, "isolevel_typ": 48, "isscalar": 108, "issu": [2, 3, 4, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 33, 38, 39, 43, 44, 49, 50, 57, 61, 63, 67, 79, 84, 87, 89, 94, 99, 100, 101, 102, 106, 108], "issubset": 1, "issuperset": 1, "isus": 105, "item": [30, 39, 52, 108], "iter": [1, 12, 14, 15, 16, 30, 44, 49, 53, 103, 105, 108, 109, 110, 111], "iter_as_aux": 57, "iter_auxiliari": 57, "itp": [59, 61, 87], "itppars": [75, 105], "its": [1, 2, 3, 4, 7, 9, 13, 15, 18, 19, 20, 22, 30, 32, 33, 44, 46, 49, 52, 53, 98, 99, 100, 101, 103, 106, 108, 109, 111, 112], "itself": [3, 4, 5, 6, 7, 8, 9, 10, 16, 19, 30, 34, 39, 68, 79, 96, 106], "iucr": [9, 10, 11, 12, 13, 14, 33, 104], "j": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 104, 113], "ja071797i": [38, 104], "jaclark5": 105, "jain": [34, 104], "jan": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "jandom": 105, "jane": [37, 104], "janin": [104, 105], "januari": [37, 104], "jason": 52, "jcc": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 52, 53, 55, 104], "jennaswa": 105, "jensen": [42, 43, 44], "jfennick": 105, "jmb": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 30, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 104], "jmol": 96, "job": [15, 42, 44], "job_list": 15, "joblib": [3, 15, 26], "joel": [19, 20, 104], "john": 52, "join": [3, 10, 36, 99, 108], "jol02": [34, 104], "jolliff": [34, 104], "jonathan": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "jone": [66, 68, 76], "josto": 105, "journal": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "jo\u00ebl": [37, 104], "jr": [45, 50], "json": 102, "juan": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55, 104], "juli": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 55, 104], "jump": [103, 105], "june": [14, 27, 33, 104], "jupyt": [6, 9, 10, 13, 26, 52, 55, 100, 104], "jupyter_backend": 48, "jupyterlab": 100, "just": [3, 4, 23, 30, 48, 55, 57, 82, 98, 102, 106, 108, 112], "justifi": 81, "jvermaa": 105, "jwlm78": [37, 104], "k": [9, 10, 11, 14, 24, 30, 33, 40, 42, 43, 48, 52, 53, 57, 104], "k_count": 40, "k_max": 40, "k_valu": 40, "kay": [38, 104], "kcal": 113, "keep": [1, 2, 3, 10, 14, 30, 34, 39, 43, 44, 48, 55, 72, 96, 99, 101, 102, 108], "keep_fil": 30, "kei": [1, 2, 30, 38, 39, 49, 53, 57, 98, 99, 114], "kelvin": 52, "kennei": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "kept": [3, 34, 79], "kernel": [44, 87], "kevrekidi": [33, 104], "keysview": 49, "keyword": [13, 16, 18, 19, 22, 23, 28, 30, 36, 37, 42, 43, 44, 53, 61, 62, 68, 81, 89, 93, 94, 96, 103, 105, 107, 114], "kg": 113, "kilocalori": 52, "kinas": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 53, 55, 104], "kind": [3, 4, 13, 99, 114], "kinet": [33, 52, 57], "kineticenergi": 52, "kirchhoff": 38, "kj": [63, 113], "km1": [42, 43], "km2": [42, 43], "km3": 43, "kmean": [42, 43], "know": [4, 15, 16, 50, 53, 102, 108], "knowledg": [98, 105], "known": [14, 102], "koehl": [19, 20, 104], "kresten": [42, 43, 44, 45, 104], "kullback": 45, "kumar": [39, 46, 104], "kwarg": [15, 18, 19, 57, 105], "kyle": 52, "l": [3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 96, 104], "l_b": 31, "l_p": 31, "la": [33, 104], "label": [12, 13, 14, 15, 16, 22, 23, 24, 27, 37, 38, 42, 43, 44, 45, 46, 50, 99, 102], "labextens": 100, "laci": [30, 104], "lack": [105, 108], "lafon": [33, 104], "lamb": 57, "lambda": [19, 89], "lambda_const": 19, "lammp": [58, 59, 61, 97, 103, 105, 108], "lammpsdata": 66, "lammpsdump": [58, 59, 61, 97, 109], "lammpsdumppars": 76, "lammpsdumpread": 105, "lammpspars": [66, 76, 105], "landscap": [19, 20, 104], "langevin": 52, "langevinintegr": 52, "langl": [14, 27, 31, 36], "languag": [4, 53, 107], "laptop": 15, "larg": [3, 4, 7, 10, 13, 15, 17, 19, 20, 33, 36, 40, 50, 53, 55, 56, 83, 101, 102, 104, 105, 107, 108], "largest": [7, 32, 34, 46, 108], "larsen": [42, 43, 44, 45, 104], "last": [0, 3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 89, 99, 108, 109], "last_fiv": 53, "lat09": [7, 8, 9, 10, 11, 14, 104], "later": [2, 4, 13, 15, 102, 105, 106], "latest": [2, 3, 15, 100, 108], "latex": 3, "latter": [13, 45, 108], "layer": [58, 61, 106], "layout": 105, "lazili": 106, "lb": 31, "lda": [37, 104], "lead": [3, 4, 105, 114], "leaf_siz": 42, "leaflet": 26, "learn": [2, 3, 7, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 33, 38, 39, 42, 43, 44, 49, 99], "least": [3, 16, 31, 39, 42, 46, 67, 83, 98, 108], "leav": [3, 4, 55, 108], "led": 105, "lee": 52, "left": [13, 14, 31, 44, 106, 108], "legaci": [105, 108], "legend": [14, 15, 16, 19, 20, 22, 27, 30, 37, 38, 43, 44], "leibler": 45, "len": [1, 12, 23, 24, 30, 33, 34, 36, 37, 38, 40, 42, 44, 45, 46, 48, 50, 53, 57, 98, 103, 108, 109, 111], "length": [1, 6, 7, 12, 13, 22, 24, 27, 29, 39, 40, 42, 44, 45, 46, 48, 50, 52, 53, 63, 66, 67, 68, 71, 79, 88, 99, 104, 105, 110, 111], "lengthunit": [66, 68, 103], "lennard": [66, 68, 76], "less": [7, 18, 19, 26, 32, 34, 57, 68, 100], "let": [3, 4, 16, 26, 27, 40, 102], "letter": [3, 33, 83, 104], "leu": [37, 53, 107], "level": [1, 3, 4, 15, 48, 85, 98, 101, 108, 114], "leverag": [3, 15], "levitt": [37, 104], "lewin": 48, "lgplv2": 105, "li": 44, "lib": [3, 11, 12, 13, 15, 16, 18, 20, 21, 28, 33, 37, 38, 40, 42, 43, 44, 45, 49, 105, 108], "libmdanalysi": 105, "librari": [3, 9, 10, 14, 15, 19, 33, 34, 39, 46, 48, 50, 55, 58, 61, 62, 79, 80, 85, 99, 101, 102, 104, 105, 108], "licenc": 108, "licens": [2, 15, 105, 108], "licoric": 48, "lid": [13, 14, 22, 23, 50], "lid_atom": 50, "lid_ca": 23, "lid_com": 23, "lid_seg": 50, "lifetim": [7, 25, 26, 28, 89], "ligand": 114, "light": 108, "lighter": [37, 108], "lightweight": [3, 15, 101], "like": [1, 3, 4, 5, 13, 16, 19, 26, 30, 34, 39, 40, 43, 48, 53, 55, 57, 60, 83, 100, 106, 108], "likelihood": [19, 20, 45, 104], "likewis": [60, 87, 106], "lili": [19, 26, 39], "limit": [3, 15, 16, 30, 34, 36, 40, 55, 57, 88], "lin": 49, "lindorff": [42, 43, 44, 45, 104], "line": [0, 3, 4, 12, 13, 26, 27, 30, 33, 43, 48, 49, 57, 81, 83, 91, 95, 96, 98, 100, 105, 108, 114], "line2d": [33, 49, 57], "linear": [6, 7, 31, 32, 34], "lineardens": [48, 49, 105], "lineax": 38, "linefig": 38, "lineplot": 34, "linewidth": 26, "link": [3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 102, 104], "linkag": 46, "linkinghub": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55, 104], "linspac": [26, 27, 49], "linssen": [34, 104], "lint": 3, "linux": [3, 4, 102, 105], "lipid": [26, 27, 28, 106], "lippa": 15, "list": [1, 3, 4, 5, 13, 15, 16, 19, 26, 30, 38, 39, 40, 42, 43, 44, 46, 48, 50, 53, 57, 61, 65, 67, 82, 87, 96, 99, 100, 102, 104, 105, 106, 107, 108, 109, 111, 112, 113, 114], "listen": 99, "literatur": 48, "littl": [44, 90], "liu": [9, 10, 11, 14, 53, 104], "live": 12, "liwo": 104, "lj": 57, "ljwoods2": 105, "ll": [3, 4, 27], "ln": [42, 44], "load": [3, 4, 30, 50, 61, 78, 89, 99, 103, 105, 109, 111, 112], "load_fil": 52, "load_new": [10, 19, 34, 103, 114], "loc": 27, "local": [2, 3, 4, 7, 15, 16, 19, 20, 32, 33, 39, 48, 101, 102, 104, 108], "local_ax": 39, "local_bend": 39, "local_height": 39, "local_helix_direct": 39, "local_nres_per_turn": 39, "local_origin": 39, "local_rotation_vector": 39, "local_screw": 39, "local_screw_angl": 39, "local_twist": 39, "localhost": 4, "locat": [4, 5, 9, 81, 82, 102, 106, 109], "log": [30, 42, 44, 101, 105], "logic": 1, "login": 100, "long": [3, 12, 30, 33, 37, 42, 44, 85, 102, 114], "longer": [3, 12, 27, 57, 71, 105, 106, 108], "look": [2, 3, 4, 10, 12, 13, 15, 19, 23, 24, 26, 28, 36, 37, 39, 48, 55, 61, 83, 86, 92, 96, 98, 108, 111], "lookup": [19, 20, 104], "loop": [15, 16, 55, 108, 111], "loos": 95, "lorenz": [26, 27, 28], "lossless": [59, 85, 94], "lot": [3, 66, 108], "lovel": [37, 104], "low": [3, 7, 12, 14, 32, 42], "lower": [3, 7, 19, 24, 30, 32, 33, 34, 38, 40, 42, 43, 44, 57], "lowest": [38, 46, 50, 105], "lp": 31, "lre": 84, "lresid": 84, "lsegid": 84, "lstring": [81, 82], "lt": [9, 10, 12, 13, 14, 15, 16, 18, 22, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 40, 42, 43, 44, 46, 48, 49, 50, 52, 53], "luckili": 55, "luka": [30, 104], "lw": [26, 27, 48], "lx": [22, 55], "ly": [18, 19, 21, 22, 27, 28, 37, 53, 55, 106, 107], "lyn": 107, "lysh": [98, 107], "lysin": 106, "lysozym": 98, "lz": [22, 55], "m": [3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 102, 104, 113], "m2_view": 10, "m9": [14, 104], "m_i": [16, 109], "machin": [3, 4, 15, 48, 100, 105, 108], "maco": [3, 105], "macosx": 105, "macro": [4, 53, 96], "macromolecular": [9, 10, 11, 14, 46, 53, 59, 104], "made": [2, 3, 4, 26, 48, 71, 103, 105, 106, 109], "madwb11": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "maggioni": [33, 104], "magnitud": 44, "mai": [1, 3, 4, 7, 9, 12, 14, 15, 16, 18, 19, 26, 27, 28, 30, 32, 33, 34, 36, 38, 42, 43, 44, 48, 50, 53, 57, 93, 100, 101, 102, 103, 105, 111], "maigret": [37, 104], "mail": 99, "main": [2, 4, 100], "mainli": 44, "maintain": [3, 4, 6, 99, 108], "maisuradz": 104, "major": [3, 53, 102], "majora": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "make": [2, 3, 4, 7, 8, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 24, 26, 28, 33, 34, 38, 39, 40, 42, 43, 44, 45, 49, 53, 55, 56, 98, 100, 102, 103, 106, 108, 109, 111, 112, 114], "make_ndx": 96, "mamba": [4, 100], "mambaforg": [11, 12, 13, 15, 16, 18, 20, 21, 28, 33, 37, 38, 40, 42, 43, 44, 45, 49], "manag": [3, 15, 30, 53, 96, 100, 104, 108], "mani": [1, 2, 3, 4, 13, 15, 16, 21, 26, 30, 34, 39, 40, 42, 43, 44, 53, 99, 100, 108, 109, 111, 114], "manifold": [7, 32, 33], "manipul": [1, 53, 80, 99], "manner": [3, 102], "manual": [3, 4, 12, 50, 53, 87, 108], "manuel": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "map": [3, 4, 6, 7, 12, 15, 30, 32, 34, 44, 46, 48, 57, 104, 108], "marc": [19, 20, 104], "march": [33, 48, 100, 104], "marching_cub": 48, "margin": 37, "mari": [33, 104], "marinegor": 105, "mark": [3, 30, 103, 104, 108], "marker": [33, 34, 37], "markup": [3, 4], "mask": 36, "mass": [1, 6, 7, 9, 10, 15, 16, 23, 24, 28, 30, 36, 40, 45, 46, 47, 48, 53, 55, 61, 63, 65, 66, 86, 87, 92, 97, 106, 109, 112, 113, 114], "mass_dens": [49, 105], "mass_density_stddev": 49, "master": [1, 3, 109, 114], "match": [4, 6, 7, 9, 10, 13, 17, 37, 44, 100, 102, 105, 106, 108], "match_atom": [9, 10], "math": [3, 105, 109], "mathbf": [3, 13, 14, 16, 31, 34, 36], "mathjax": 3, "mathsf": [3, 13], "matplotlib": [3, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 53, 57, 101], "matric": [19, 24, 45], "matrix": [3, 7, 8, 9, 10, 11, 12, 13, 14, 24, 34, 38, 39, 42, 44, 45, 46, 53, 104], "matteo": [42, 43, 44, 45, 104], "matter": [53, 84, 87, 106, 109], "matthew": [2, 52], "mauro": [33, 104], "max": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 55, 66, 104, 105], "max_": 46, "max_it": 42, "max_lam": 44, "maxdepth": 4, "maximum": [19, 20, 27, 30, 45, 66, 104], "maxiter": 52, "maxium": 27, "mb": [57, 100], "mcgibbon": 52, "mcpu": 100, "md": [15, 53, 102, 105, 110, 113], "mda": [0, 1, 3, 4, 5, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 66, 93, 96, 98, 102, 103, 105, 106, 108, 109, 110, 111, 112, 114], "mda_xdrlib": 105, "mdahole2": [3, 30], "mdakit": [2, 105], "mdanalysi": [0, 1, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 48, 49, 50, 51, 53, 55, 56, 57, 60, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 88, 89, 90, 91, 92, 93, 94, 95, 96, 98, 100, 102, 103, 104, 106, 109, 110, 111, 112, 114], "mdanalysis001": 96, "mdanalysis002": 96, "mdanalysis_data": 5, "mdanalysisdata": [14, 15, 100], "mdanalysistest": [2, 3, 9, 10, 11, 12, 13, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 55, 57, 100, 101, 102, 103, 105, 108], "mdcrd": [58, 59, 61], "mdcrdreport": 52, "mdnalysi": 99, "me": 98, "mean": [4, 6, 7, 8, 9, 11, 16, 19, 24, 26, 27, 30, 32, 33, 34, 39, 42, 43, 45, 48, 69, 75, 80, 84, 87, 98, 99, 100, 103, 105, 106, 108, 114], "mean_count": 26, "mean_xy_area": 26, "meanin": 48, "meaning": [7, 32, 33, 53, 98, 114], "meaningfulli": 103, "meaningless": 34, "meant": [3, 4], "meanwhil": 42, "measur": [7, 12, 13, 16, 30, 31, 41, 48, 66, 108], "mechan": [19, 20, 104], "meet": 110, "meetb7": 105, "melo": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "melt": [31, 34], "member": 2, "membran": [6, 26, 27, 28, 30], "memori": [4, 10, 11, 12, 14, 15, 26, 45, 53, 55, 56, 98, 99, 105, 108, 111, 112, 114], "memory_limit": 57, "memoryread": [10, 50, 103, 105, 114], "mention": 3, "merg": [3, 4, 9, 10, 19, 34, 102, 103, 105, 108, 114], "merged1": 10, "merged1_view": 10, "merged2": 10, "merged2_view": 10, "merged3": 10, "merged_coord": 10, "merged_view": [9, 10], "mesh": 48, "meshgrid": 48, "mess": [3, 15], "messag": [3, 42, 53, 89, 100, 101, 102], "met": [1, 53, 83, 107, 109], "meta": 102, "metadata": 102, "metast": [34, 104], "meter": 16, "method": [0, 3, 6, 7, 14, 15, 17, 19, 20, 21, 25, 26, 27, 28, 30, 31, 32, 33, 34, 37, 39, 45, 48, 50, 57, 60, 96, 98, 99, 101, 103, 104, 105, 106, 108], "metric": [12, 13, 18, 19, 33, 42, 43, 44, 45, 46], "mglagolev": 105, "michael": [15, 37, 104], "michaud": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 52, 53, 55, 104], "micromamba": [4, 108], "microsecond": 113, "microsoft": 100, "middl": 39, "midpoint": [30, 48], "might": [4, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 26, 33, 38, 39, 43, 44, 49, 52, 67, 79, 100, 106], "millilit": 52, "millisecond": 113, "mimic": 15, "min": [30, 50], "min_": [13, 46], "min_lam": 44, "min_radii": 30, "min_radiu": [18, 30], "min_sampl": 42, "minactionpath": [19, 20, 104], "mind": [3, 30], "miniconda": [3, 4], "miniforg": 3, "minim": [3, 7, 8, 108], "minimis": [9, 10, 11, 12, 13, 14, 42, 43, 52], "minimize_vector": 105, "minimizeenergi": 52, "minimum": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 55, 61, 102, 105, 108], "minor": [3, 102, 105], "minorli": 11, "mislead": 12, "miss": [4, 27, 50, 57, 81, 82, 84, 101, 103, 105, 108], "misspelt": 105, "mistak": [99, 114], "mix": [46, 103], "miyazawa": [39, 104], "mkdir": 3, "mkvirtualenv": 3, "ml": 45, "mls09": [34, 104], "mm": 52, "mmtf": [3, 58, 59, 61, 97, 101, 106, 109], "mmtfparser": 77, "mmtfreader": 77, "mobil": [9, 11, 13, 14], "mobile_ca": 11, "mode": [3, 33, 34, 38, 96, 104], "mode2": 33, "mode3": 33, "mode4": 33, "mode5": 33, "mode6": 33, "model": [26, 27, 30, 31, 53, 61, 77, 80, 81, 82, 97, 104, 109], "modern": 105, "modernis": 2, "modif": [3, 78, 89], "modifi": [3, 4, 6, 11, 28, 37, 78, 102, 105, 112, 114], "modul": [0, 1, 7, 8, 9, 10, 11, 12, 13, 14, 15, 17, 25, 30, 38, 39, 41, 42, 43, 44, 45, 46, 53, 55, 79, 100, 105, 109, 112], "module_nam": 108, "mohitkumar020291": 105, "mol": [45, 50, 63, 78, 87, 105, 113], "mol2": [58, 59, 61, 97, 105, 109], "mol2pars": 78, "mol2read": 78, "mol2writ": 78, "molar": 113, "molblock": [87, 105], "mole": 52, "molecul": [1, 4, 10, 13, 26, 31, 38, 50, 55, 58, 61, 66, 78, 87, 92, 95, 98, 105, 106, 108, 109, 112], "molecular": [1, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 58, 59, 61, 66, 80, 85, 97, 99, 104, 114], "molecular_dynamics_trajectory_for_benchmarking_mdanalysi": [14, 104], "molecule_tag": 105, "moleculetyp": [0, 109], "molfrompdbfil": 78, "molnum": [0, 61, 87, 97, 108, 109], "moltomolfil": 78, "moltyp": [0, 61, 87, 97, 106, 109], "moment": [95, 105, 106, 109], "moment_of_inertia": 109, "monatom": 105, "monatomic_cation_charg": 105, "monitor": 57, "monoton": 102, "month": 105, "more": [1, 2, 3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 24, 26, 27, 30, 33, 34, 38, 39, 40, 42, 43, 44, 46, 48, 49, 50, 53, 56, 57, 60, 61, 65, 69, 87, 98, 101, 103, 105, 106, 108, 109, 112, 114], "moreov": 19, "mors": 87, "moschaeffl": 105, "most": [0, 1, 3, 7, 10, 14, 15, 16, 26, 27, 32, 34, 39, 40, 41, 53, 60, 68, 69, 83, 87, 99, 100, 103, 105, 106, 108, 109, 114], "most_common": 26, "mostli": [2, 15], "motion": [7, 32, 34, 38], "move": [13, 14, 22, 40, 48, 53, 55, 101, 105, 108, 111, 112], "move_bi": 50, "movement": [7, 13, 17, 19, 34, 57], "movi": [10, 14, 34, 39, 48, 55], "moviemak": [10, 14, 34, 39, 48, 55], "moviepi": 10, "mpl_toolkit": [44, 48], "mplot3d": [44, 48], "mprm": 52, "mprm_convert": 52, "mprm_from_parm": 52, "mse": 107, "msg": 108, "mtune": 100, "mu": 45, "much": [2, 3, 10, 11, 12, 13, 14, 16, 19, 30, 34, 42, 43, 48, 50, 60, 105, 108], "multi": [53, 71, 81, 82], "multicor": 15, "multifram": 16, "multimachin": 15, "multipdb_hol": 30, "multipl": [1, 3, 27, 39, 48, 53, 57, 62, 89, 94, 98, 100, 105, 106, 112, 114], "multipli": [19, 26, 86, 113], "multiprocss": 15, "multiscal": 27, "must": [1, 2, 3, 4, 11, 12, 13, 16, 18, 22, 23, 26, 27, 30, 31, 34, 42, 43, 46, 48, 50, 53, 60, 66, 79, 83, 84, 100, 101, 108, 109, 112, 114], "mvc": 105, "mw6365": 40, "mx": 48, "my": [3, 4, 5, 18, 48], "my_branch": 4, "my_pdb_fil": 53, "my_script": 53, "my_user_nam": 4, "myproject": 3, "mz": 48, "n": [1, 3, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 83, 95, 96, 98, 104, 105, 106, 107, 113], "n0a": 105, "n1": [98, 107], "n2": 107, "n3": [52, 107], "n4": 107, "n6": 107, "n7": 107, "n9": 107, "n_": [26, 34, 36], "n_a": 36, "n_atom": [3, 10, 15, 26, 50, 53, 103, 105, 108, 109, 111, 114], "n_atomgroup": 37, "n_b": 36, "n_bb": 34, "n_block": 15, "n_ca": 24, "n_color": [33, 34], "n_compon": [34, 43, 44], "n_contact": [19, 21], "n_db": 42, "n_donor": 26, "n_frame": [12, 15, 16, 26, 30, 34, 37, 39, 53, 105], "n_frames_per_block": 15, "n_job": 15, "n_lid": 23, "n_nmp": 23, "n_re": 24, "n_ref": 19, "n_residu": [3, 37, 39, 50, 53, 109], "n_segment": 50, "n_select": 53, "n_std": 30, "n_worker": 15, "n_x": 50, "n_y": 50, "n_z": 50, "na": [0, 1, 30, 105], "nala": 107, "nalysi": 104, "nambdin": 59, "namd": [42, 44, 45, 46, 58, 59, 61, 97, 103], "namdbin": [58, 61, 64], "namdbinread": 64, "namdbinwrit": 64, "name": [0, 3, 4, 9, 10, 11, 12, 13, 14, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 36, 37, 38, 39, 40, 42, 43, 44, 46, 48, 50, 53, 57, 60, 61, 65, 67, 70, 78, 81, 82, 83, 86, 87, 92, 95, 96, 97, 98, 100, 102, 103, 105, 106, 107, 108, 109, 114], "nan": [57, 108], "nanomet": [66, 113], "nanosecond": 113, "napoleon": 3, "nar": [19, 20, 104], "narg": 107, "nasn": 107, "nasp": 107, "nation": [19, 20, 104], "nativ": [6, 7, 15, 17, 20, 21, 63, 100, 104], "natom": 50, "natur": 44, "naveen": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 55, 104], "navig": [3, 4], "nbextens": 4, "nbin": [36, 40, 49], "nbindex": 109, "nbindic": 109, "nbsphinx": 4, "nc": [52, 58, 59, 61], "ncbi": [30, 104], "ncdf": [58, 59, 61], "ncdfreader": 79, "ncdfwriter": 79, "ncol": 27, "ncore": [42, 44], "ncr18": [9, 10, 55, 104], "ncy": 107, "ncycl": 44, "ncyx": 107, "ndarrai": [1, 53, 110], "ndx": 96, "ne": [27, 28], "near_met": 53, "nearest": [46, 57], "neat": [1, 4], "necessari": [13, 14, 16, 21, 26, 30, 50, 57, 102, 105, 106], "necessarili": [12, 18, 44, 69], "neduvelil": [30, 104], "need": [2, 3, 7, 8, 9, 14, 15, 16, 19, 24, 30, 33, 34, 42, 43, 44, 46, 48, 50, 52, 53, 55, 67, 98, 99, 100, 101, 102, 103, 105, 108, 111, 112], "neg": 106, "neighbor": 105, "neighbour": [36, 42, 46], "neighour": [7, 32, 33], "nep29": 105, "netcdf": [58, 59, 61, 88, 105], "netcdf4": [3, 79, 108], "network": [6, 7, 35], "networkx": [3, 105], "never": [19, 101, 108, 109], "nevertheless": 89, "new": [0, 1, 2, 9, 15, 16, 18, 19, 30, 34, 48, 53, 57, 66, 67, 87, 100, 101, 102, 103, 104, 109, 110, 111, 112, 114], "new_box": 50, "new_nam": 109, "new_rmsd": 9, "new_univers": 50, "newer": [3, 86], "newli": [3, 102, 105], "newseg": 0, "newton": 113, "next": [3, 13, 19, 26, 44, 46, 53, 55, 58, 59, 61, 89, 105, 106, 111], "next_as_aux": 57, "ngln": 107, "nglu": 107, "nglview": [4, 9, 10, 14, 19, 34, 39, 50, 52, 55, 104], "nglviewer": 48, "ngly": 107, "nguyen": [9, 10, 52, 55, 104], "nh": [18, 19, 21], "nh1": [27, 28, 83], "nh2": [27, 28], "nhh": 53, "nhid": 107, "nhie": 107, "nhip": 107, "nice": 3, "nicer": 55, "niederhut": 15, "nih": [30, 104], "nile": 107, "nitrogen": [31, 98, 105, 106], "nleu": 107, "nlm": [30, 104], "nly": 107, "nm": [48, 57, 66, 113], "nma1": 38, "nma2": 38, "nma_clos": 38, "nme": 107, "nmet": 107, "nmp": [13, 14, 22, 23, 50], "nmp_atom": 50, "nmp_ca": 23, "nmp_com": 23, "nmp_segment": 50, "no_charg": 78, "no_overlap": 50, "no_overlap_view": 50, "nocutoff": 52, "node": [92, 100], "nodej": 100, "noimplicit": 105, "nois": 42, "nojump": 105, "non": [6, 7, 13, 19, 32, 36, 57, 60, 88, 105, 106], "nonbondedmethod": 52, "none": [13, 15, 16, 26, 28, 30, 34, 37, 46, 50, 52, 57, 92, 98, 105, 109, 114], "nonlinear": [33, 104], "nonstandard": 101, "nonzero": 40, "norm": [40, 105], "normal": [1, 3, 15, 30, 38, 39, 43, 44, 84, 91, 96, 102, 104, 105, 108], "normalis": [36, 40, 48], "nose": 108, "not_protein": 55, "not_protein2": 55, "notat": 82, "note": [3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 19, 20, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 53, 55, 83, 84, 98, 102, 104, 106, 108, 111, 113], "notebook": [6, 9, 10, 11, 26, 27, 34, 48, 52, 53, 55, 104, 114], "notic": [3, 4, 16], "notifi": 101, "notimplementederror": [79, 109], "notimplementederrortraceback": 109, "notwithin_coordinates_factori": 105, "noun": 3, "nov": 99, "novemb": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55, 104], "now": [3, 4, 11, 14, 16, 19, 27, 40, 43, 46, 48, 50, 52, 55, 81, 102, 105], "np": [10, 12, 15, 16, 18, 19, 20, 21, 23, 24, 26, 27, 28, 30, 33, 34, 37, 40, 42, 43, 44, 45, 46, 48, 49, 50, 55, 57, 101, 103, 105, 108, 112, 114], "nphe": 107, "npro": 107, "npt": 105, "npy": 26, "npz": [89, 94], "nr": 96, "nrow": 38, "nsampl": 44, "nsc7810": 82, "nser": 107, "nstep": 44, "nth": 114, "nthr": 107, "ntrp": 107, "ntyr": 107, "nucleic": [19, 20, 104, 105, 106], "nucleicacid": 105, "nucleicbackbon": 106, "nucleicbas": 106, "nucleicsugar": 106, "nucleobas": 106, "nucpairdist": 105, "null": 1, "num_cor": 15, "number": [1, 3, 4, 6, 7, 13, 14, 15, 16, 17, 18, 19, 20, 22, 24, 26, 27, 30, 33, 34, 36, 37, 38, 39, 40, 41, 42, 43, 44, 48, 50, 52, 53, 57, 60, 65, 69, 71, 72, 75, 81, 82, 83, 84, 85, 87, 89, 91, 92, 93, 96, 103, 105, 106, 108, 109, 114], "number_of_clustering_method": 43, "number_of_window": 43, "numer": [42, 44, 53, 66, 106], "numpi": [2, 3, 10, 12, 15, 16, 18, 19, 20, 21, 23, 24, 26, 27, 28, 30, 33, 34, 37, 40, 42, 43, 44, 45, 46, 48, 49, 50, 53, 55, 100, 101, 102, 103, 105, 108, 109, 112], "numprocess": [100, 108], "nv": [9, 10, 14, 19, 34, 39, 48, 50, 55], "nval": 107, "nvt": 49, "nz": [18, 19, 21, 27], "o": [28, 30, 31, 36, 45, 50, 52, 53, 98, 104, 106, 107, 108], "o1": 82, "o2": [82, 106, 107], "o3": [82, 106, 107], "o4": [82, 106, 107], "o5": [106, 107], "o6": 107, "oa": 82, "object": [0, 1, 3, 16, 20, 26, 37, 48, 50, 52, 53, 57, 58, 61, 62, 98, 105, 106, 108, 114], "observ": 26, "obtain": [27, 48, 50, 57, 83, 104, 105, 113], "obviou": [9, 10], "occasion": [1, 89, 94], "occlud": [30, 104], "occup": [12, 14, 61, 66, 81, 82, 97, 105, 109], "occur": [4, 19, 105], "octob": [19, 20, 34, 42, 43, 44, 45, 46, 104], "od": [18, 19, 21], "od1": 27, "od2": 27, "odd": 48, "oe": [18, 19, 21], "oe1": 27, "oe2": 53, "off": [3, 4, 12, 16, 46, 50, 89, 106, 108], "offer": [5, 48, 105], "offici": 105, "offset": [22, 89, 94, 105], "often": [3, 4, 7, 12, 13, 19, 32, 48, 50, 52, 53, 61, 68, 80, 88, 100, 103, 106, 108, 112], "og": 105, "og1": [27, 36, 105], "oh": 27, "oh2": [26, 28], "ok": [3, 100, 101, 102, 108], "okai": 3, "old": [3, 15, 53, 67, 96, 103, 108], "old_rmsd": 9, "oldest": 105, "olecular": 104, "oliv": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "oliver_beckstein": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "omega": 37, "omega_select": 37, "omit": [37, 57, 83], "onc": [3, 16, 39, 53, 55, 102, 104, 105, 108, 111, 112], "one": [1, 2, 3, 4, 10, 11, 12, 13, 15, 19, 27, 28, 30, 31, 39, 46, 50, 53, 56, 57, 83, 87, 88, 91, 92, 96, 98, 99, 100, 103, 104, 105, 106, 108, 109, 114], "ones": [3, 33, 87, 106], "onfer": 104, "ongo": [3, 105], "onli": [0, 2, 3, 4, 10, 12, 13, 15, 16, 26, 27, 28, 30, 31, 34, 36, 37, 48, 49, 50, 53, 55, 56, 57, 66, 70, 72, 78, 79, 83, 84, 87, 88, 91, 94, 95, 98, 99, 100, 101, 102, 103, 105, 106, 108, 109, 110, 111, 112, 114], "onlin": [3, 6, 10], "onlinelibrari": [34, 104], "onto": [3, 7, 30, 32, 33, 34, 37, 43, 44, 48, 111], "onward": [55, 105], "ooprathamm": 105, "op_profil": 30, "opac": [30, 48], "opaqu": 48, "open": [2, 3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 53, 55, 87, 89, 94, 104, 108], "openmm": [3, 51, 58, 61, 105], "openmmapp": [58, 61], "openmmsimul": [58, 61], "openmmtopologi": 61, "openmmtopologypars": 105, "openmp": 100, "oper": [3, 9, 15, 16, 30, 39, 53, 103, 105, 106], "opl": 107, "oppos": 19, "optim": [9, 10, 11, 13, 14, 27, 53, 104], "optimis": 16, "option": [2, 9, 10, 14, 16, 19, 22, 23, 24, 30, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 53, 55, 57, 61, 66, 67, 82, 83, 95, 100, 103, 104, 105, 108, 109, 114], "orang": [14, 22], "oranges_d": [33, 34], "order": [0, 3, 4, 7, 12, 13, 15, 16, 19, 26, 31, 32, 33, 34, 37, 42, 43, 44, 48, 52, 53, 57, 61, 66, 67, 82, 90, 98, 100, 101, 102, 103, 105, 109, 110, 111, 112, 114], "order_paramet": 30, "org": [3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 99, 104], "organ": 105, "organis": [3, 108], "origin": [1, 3, 4, 7, 9, 13, 14, 23, 27, 32, 33, 34, 39, 50, 53, 55, 57, 67, 98, 102, 106, 108, 110, 113], "original_and_copi": 108, "orn": 107, "orthogon": [3, 7, 32, 34, 52, 81, 82], "orthorhomb": 88, "oscil": [42, 44], "osx": [102, 105], "ot": 26, "ot1": 53, "ot2": [27, 53], "otf": 55, "other": [3, 4, 6, 7, 9, 10, 11, 12, 13, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 37, 38, 39, 42, 43, 44, 45, 46, 49, 53, 60, 61, 66, 67, 68, 69, 71, 72, 76, 78, 79, 80, 81, 86, 87, 95, 96, 98, 99, 100, 105, 106, 108, 109, 112, 113], "otherwis": [3, 4, 11, 34, 44, 55, 83, 89, 108], "otim": 34, "oup": [9, 10, 19, 20, 55, 104], "our": [3, 4, 10, 11, 12, 14, 16, 18, 22, 24, 27, 31, 44, 46, 48, 50, 52, 53, 55, 105, 108], "ourselv": [10, 16, 50], "out": [1, 3, 4, 9, 10, 11, 12, 14, 19, 30, 34, 39, 48, 50, 52, 55, 57, 61, 70, 78, 93, 98, 102, 103, 105, 106, 109, 110, 111, 113, 114], "outcom": [1, 105], "outdat": 3, "outer": 34, "outfil": [30, 108], "outlier": 42, "outlin": [48, 53], "output": [4, 10, 14, 16, 30, 34, 38, 39, 40, 42, 43, 44, 48, 53, 55, 63, 70, 72, 83, 105, 108, 112], "outreachi": 105, "outsid": [3, 31, 49, 55, 57, 98, 101, 105], "over": [1, 6, 7, 8, 12, 15, 16, 17, 18, 20, 21, 22, 26, 27, 30, 32, 34, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 48, 53, 55, 72, 102, 103, 105, 108, 110, 111, 112], "over_order_paramet": 30, "overal": [4, 13, 16, 19, 27, 108], "overflow": [14, 105], "overhead": 15, "overlap": [30, 36, 50, 103], "overli": 21, "overlin": 34, "overrid": 105, "overview": 3, "overwhelm": 99, "overwrit": [3, 30, 96], "overwritten": 3, "ow": [48, 106], "owen": [26, 27, 28], "own": [2, 3, 4, 6, 7, 13, 15, 17, 19, 20, 21, 30, 42, 52, 53, 66, 99, 101, 108, 112], "oxygen": [26, 48, 50, 106], "p": [3, 14, 16, 26, 27, 30, 33, 34, 38, 46, 48, 52, 53, 57, 61, 63, 67, 79, 81, 88, 95, 104, 105, 106, 107, 113, 114], "p_": 46, "p_compon": 34, "p_re": 98, "p_seg": 98, "pablo": [33, 104], "pack_into_box": 109, "packag": [2, 4, 5, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 61, 79, 86, 96, 100, 101, 104, 105, 106, 108], "package_data": 108, "pad": 48, "page": [2, 3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 61, 102, 104, 106, 108], "pair": [7, 26, 28, 30, 36, 40, 41, 44, 46, 105], "pair_dist": 105, "pairgrid": [33, 34], "pairij": 105, "pairwis": [6, 7, 8, 13, 14, 19, 39, 40], "pairwise2": 105, "pairwisealign": 105, "palett": [33, 34], "panagiotopoulo": [33, 104], "pand": 52, "panda": [2, 13, 15, 16, 18, 19, 20, 21, 26, 33, 34, 49, 53, 108], "pang": [38, 104], "paola": 27, "papaleo": [42, 43, 44, 45, 104], "paper": [9, 10, 11, 12, 13, 14, 33, 34, 53, 104], "paragraph": 3, "parallel": [7, 100, 105], "parallelis": 15, "paralleliz": 7, "param": 27, "paramet": [3, 16, 43, 52, 53, 86, 104, 105, 108, 109], "parameter": 52, "parametr": [52, 108], "params_covari": 27, "paraskevako": [15, 104], "parenthes": 106, "parm": [3, 51, 58, 59, 61, 86, 105], "parm7": [59, 61, 97, 109], "parmar": 105, "parmedconvert": 80, "parmedpars": 80, "parmedread": 80, "pars": [71, 81, 83, 84, 105, 106, 114], "parser": [3, 4, 63, 65, 66, 69, 70, 71, 72, 73, 75, 76, 77, 78, 80, 81, 82, 83, 84, 86, 87, 91, 92, 93, 95, 99, 105, 106, 114], "part": [1, 2, 3, 4, 15, 30, 48, 57, 101, 103, 105, 106, 108, 111], "part01": 103, "part02": 103, "part03": 103, "part04": 103, "partial": [3, 15, 28, 61, 82, 108, 109, 112], "partialchrg": 82, "particl": [1, 9, 13, 14, 34, 36, 40, 50, 52, 53, 72, 105], "particular": [3, 4, 22, 30, 40, 46, 48, 67, 91, 98, 100, 108, 110, 111], "particularli": [57, 83, 85], "partit": [42, 43, 44, 49], "pass": [1, 3, 4, 13, 16, 18, 19, 22, 23, 24, 26, 28, 30, 31, 34, 36, 37, 39, 42, 43, 44, 45, 49, 50, 53, 55, 60, 61, 62, 66, 80, 81, 93, 95, 96, 100, 102, 103, 105, 106, 108, 110, 112, 114], "patch": 102, "path": [3, 5, 7, 19, 30, 32, 41, 53, 57, 104, 105, 108], "path_select": 46, "pathlib": 105, "pathsimanalysi": 3, "pathwai": [33, 46, 104], "patric": [19, 20, 104], "pattern": [33, 104, 106, 108], "paul": [26, 27, 28, 37, 104], "pave": 105, "pbarletta": [11, 12, 13, 15, 16, 18, 20, 21, 28, 33, 37, 38, 40, 42, 43, 44, 45, 49], "pbc": [48, 52, 105, 108], "pc": [15, 34, 44, 70], "pc1": [34, 43, 44], "pc2": [34, 43, 44], "pc3": [34, 43, 44], "pc4": 44, "pca": [7, 32, 34, 43, 44, 105], "pcbi": [42, 43, 44, 45, 46, 104], "pcolor": 24, "pd": [13, 15, 16, 18, 19, 20, 21, 26, 33, 34, 49, 53], "pdb": [1, 9, 10, 13, 14, 22, 23, 24, 34, 37, 46, 50, 52, 53, 57, 58, 59, 61, 77, 78, 83, 96, 97, 98, 103, 105, 108, 109, 114], "pdb2pqr": 59, "pdb_close": 22, "pdb_hole": 30, "pdb_name": 30, "pdb_small": [22, 23, 24, 45, 46, 50, 108], "pdb_xvf": 57, "pdbfile": 114, "pdbparser": [81, 105], "pdbqt": [58, 59, 61, 97, 105, 109], "pdbqtparser": 82, "pdbqtreader": 82, "pdbqtwriter": 82, "pdbreader": [81, 105], "pdbwriter": [81, 105], "pdf": [34, 57, 104], "peak": 38, "peoe": 82, "peopl": [2, 3, 102], "per": [19, 26, 66, 83, 105, 108], "percentag": 34, "perera": [38, 104], "perfect": 34, "perfectli": 57, "perform": [4, 13, 15, 26, 43, 44, 48, 52, 85, 100, 108, 111, 112], "perilla": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 104], "period": [27, 48, 87, 88, 105, 106, 112], "perm": 78, "perman": [5, 111], "permiss": 105, "persist": [6, 7, 10, 15, 26, 29, 53, 55, 111], "persistencelength": 31, "person": 4, "perspect": [34, 104], "peter": 52, "pgbarletta": 105, "pglu": 107, "phe": 107, "phi": 37, "phi_select": 37, "philip": [30, 38, 104], "phosopho": 15, "phosophotransferas": [9, 10, 11, 12, 13, 14, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55], "phosphor": 26, "phosphoru": 105, "phosphotransferas": 50, "phrase": 106, "phy": [26, 27, 28], "physic": [7, 32, 33, 34, 104], "physrev": 104, "pi": [3, 36, 113], "pick": [99, 102, 108], "pickl": [15, 26, 105], "picomet": 113, "picosecond": [38, 52, 53, 79, 113], "pictur": 50, "pie": [15, 114], "pii": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55, 104], "pile": 3, "pillos": 105, "pin": 102, "ping": 52, "pip": [4, 7, 53, 101, 104, 105, 108], "pipelin": [15, 105, 108], "pipx": 102, "pivot": 15, "pkl": 26, "place": [3, 4, 10, 34, 94, 99, 102], "placehold": [16, 50, 92], "placement": 48, "plai": 15, "plain": [4, 108], "plan": [100, 105], "plane": [30, 39, 48, 60], "platform": [4, 100], "pleas": [2, 3, 4, 7, 8, 9, 10, 11, 12, 13, 14, 16, 18, 19, 20, 21, 26, 27, 28, 30, 33, 34, 38, 39, 42, 43, 44, 45, 46, 53, 61, 87, 99, 100, 102, 104, 105, 112], "plen": 31, "plo": [42, 43, 44, 45, 46, 52, 104], "plor": 67, "ploscompbiol": [42, 43, 44, 45, 104], "plot": [12, 15, 16, 26, 27, 31, 33, 34, 36, 38, 39, 40, 43, 49, 53, 57, 105], "plot3d": 30, "plot3d_order_paramet": 30, "plot_annotated_heatmap": 46, "plot_mean_profil": 30, "plot_order_paramet": 30, "plot_trisurf": 48, "plotli": 12, "plotter": 48, "plt": [12, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 30, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 53, 57], "plugin": [4, 95, 100, 101, 108], "plural": 109, "pm": 113, "pmc": [30, 104], "pmc1225986": [30, 104], "pmc2652707": 104, "pmc3144279": [45, 52], "pmcid": [45, 52], "pmd": 52, "pmda": [15, 104], "pml": 96, "pna": [19, 20, 104], "png": [48, 57], "po": 105, "point": [3, 4, 7, 13, 15, 30, 31, 32, 33, 37, 42, 44, 46, 48, 53, 55, 57, 102, 105, 106, 108, 110, 111], "polar": 37, "poli": 63, "polici": 3, "polyamid": [27, 31], "polym": [6, 104], "polymers_and_membran": 4, "polynomi": [9, 10, 11, 12, 13, 14, 33, 53, 104], "pool": 15, "poor": [27, 34], "pope": 3, "popul": [12, 16, 42, 105], "popular": [3, 61, 93, 99], "pore": [6, 7, 29, 104], "pore_length": 30, "port": [33, 104], "portabl": [59, 61, 87], "portion": 101, "posit": [9, 10, 11, 13, 14, 15, 16, 19, 20, 21, 23, 24, 26, 34, 38, 45, 48, 52, 66, 67, 76, 103, 105, 106, 108, 109, 110, 111, 112], "possibl": [4, 28, 30, 46, 57, 60, 82, 99, 103, 104, 105, 106, 108], "possibli": 61, "post": [18, 26, 48, 55, 100, 105, 112], "potenti": [13, 19, 52, 57, 79, 87, 102, 105], "potentialenergi": 52, "power": [15, 53, 98], "powerpc": 100, "ppc64le": 105, "pprm": 52, "pqr": [58, 59, 61, 97, 105, 109], "pqrparser": 83, "pqrreader": 83, "pqrwriter": 83, "pr": [3, 4, 102, 103, 105], "practic": [3, 12, 48, 105], "pre": [3, 18, 48, 57, 102], "preced": 106, "precis": [64, 85, 94, 105, 108], "precomput": [48, 113], "predict": 108, "prefer": [30, 42, 100, 108], "prefix": [3, 4, 106], "preliminari": 105, "prepar": [3, 16], "prepart": 105, "presenc": 27, "presens": 102, "present": [1, 3, 19, 21, 26, 27, 40, 52, 65, 68, 81, 92, 95, 98, 105], "preserv": [1, 19, 66, 105], "pressur": 57, "presum": 14, "pretti": [24, 98], "preval": 27, "prevent": [4, 105], "preview": 3, "previou": [4, 13, 19, 30, 105], "previous": [78, 81, 105], "primari": [3, 53, 98, 109], "primarili": 5, "primer": 4, "princip": [6, 7, 32, 33, 43, 44, 104, 109], "principal_ax": 109, "principalcomponentanalysi": [43, 44], "principl": 101, "print": [1, 5, 9, 10, 11, 13, 14, 15, 19, 23, 26, 27, 28, 30, 31, 34, 36, 37, 39, 40, 42, 43, 44, 45, 46, 49, 50, 53, 57, 101, 103, 108, 109, 110, 111, 114], "print_funct": 101, "prior": [3, 28, 71, 87, 105, 109], "prisant": [37, 104], "privat": 99, "prm": 114, "prm7_ala2": 52, "prm_protein_shel": 52, "prmsd": 12, "prmtop": [26, 59, 61, 88, 97, 105, 109], "pro": [37, 96, 107], "probabl": [1, 4, 7, 15, 38, 41, 42, 44, 53, 88], "problem": [2, 3, 4, 13, 61, 68, 87, 99], "proce": 30, "procedur": [11, 39, 102], "proceed": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 100, 104], "process": [2, 3, 7, 15, 17, 18, 19, 23, 24, 26, 27, 48, 67, 102, 105, 108, 114], "prod": 26, "produc": [1, 23, 27, 34, 53, 57, 67, 105, 108], "product": [3, 14, 34, 104], "profil": 3, "profiles1": 30, "prograg": 42, "program": [3, 4, 7, 14, 30, 34, 39, 50, 53, 93, 96, 99, 100, 104], "progress": [3, 15, 16, 100, 103, 105], "progressbar": 105, "progressbar_kwarg": 105, "proj1": 34, "project": [2, 3, 4, 7, 32, 37, 39, 43, 44, 48, 99, 105], "promot": 3, "prop": 106, "proper": [57, 60, 87, 108], "properli": [3, 4, 102, 105], "properti": [1, 16, 30, 39, 53, 60, 98, 105, 106, 109, 111, 112], "proportion": 40, "prot": [34, 37, 104], "protect": [3, 102], "protein": [0, 6, 7, 9, 10, 13, 14, 15, 16, 17, 19, 20, 21, 22, 24, 26, 27, 28, 29, 30, 34, 35, 38, 39, 42, 44, 45, 47, 52, 53, 57, 59, 98, 104, 106, 110, 111, 112, 114], "protein2": 55, "protein_a": 106, "protein_acceptors_sel": 28, "protein_cent": 55, "protein_chain_a": 87, "protein_chain_b": 87, "protein_chain_xxx": 87, "protein_forc": 57, "protein_hydrogens_sel": 28, "protein_shel": 52, "protein_view": 50, "proton": 53, "protoread": 57, "provid": [1, 3, 4, 7, 12, 13, 15, 16, 17, 25, 26, 30, 31, 34, 37, 38, 43, 44, 46, 52, 53, 55, 57, 60, 61, 62, 65, 71, 81, 82, 83, 88, 94, 96, 99, 100, 103, 105, 106, 108, 109, 114], "proxim": 44, "psa": 46, "psanalysi": 46, "pseudo": 19, "psf": [0, 5, 9, 10, 11, 12, 13, 14, 16, 18, 19, 20, 21, 26, 27, 28, 33, 34, 38, 39, 42, 43, 44, 45, 46, 53, 59, 61, 82, 97, 103, 105, 106, 108, 109, 110, 111], "psf_namd_gbi": [42, 44, 45, 46], "psffre": 84, "psfparser": 84, "psfplugin": 84, "psi": 37, "psi_select": 37, "pu": [9, 10, 11, 14, 53, 104], "public": [2, 3, 16, 30, 99, 102, 104, 108], "publicli": [3, 73], "publish": [4, 9, 10, 11, 12, 13, 14, 16, 21, 26, 27, 28, 30, 33, 34, 38, 39, 42, 43, 44, 45, 46, 53, 61, 102, 104], "pull": [4, 10, 45, 70, 82, 101, 102, 105, 108, 111], "pure": [30, 31, 87, 104], "purpl": 14, "purpos": [3, 19, 28], "push": [2, 4, 15, 102, 108], "put": [3, 4, 16, 50], "pv": [48, 57], "pxd": 105, "py": [0, 3, 4, 5, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 33, 37, 38, 39, 40, 42, 43, 44, 45, 49, 53, 101, 102, 104, 105, 108], "pyarg": 100, "pycharm": 3, "pydagogu": 2, "pydev": [19, 26, 39], "pyedr": 3, "pymol": [53, 96], "pypi": [3, 102, 105], "pyplot": [12, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 30, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 53, 57], "pyproject": 3, "pytest": [3, 100, 102, 105, 108], "python": [4, 5, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 87, 98, 99, 100, 101, 102, 104, 105], "python3": [11, 12, 13, 15, 16, 18, 20, 21, 28, 33, 37, 38, 40, 42, 43, 44, 45, 49, 108], "pytng": [3, 105], "pyx": 3, "q": [19, 46, 82, 83, 96], "q1": [6, 7, 17, 18, 19, 21], "q1q2": 20, "q1q2_df": 20, "q2": [6, 7, 17, 18, 19, 21], "q_": 46, "q_i": 109, "qcp": [7, 8, 9, 10, 11, 12, 13, 14, 33], "qcprot": 105, "qln": 107, "quadrupol": 109, "quadrupole_mo": 109, "quadrupole_tensor": 109, "qualiti": [10, 12, 14, 34, 39, 48, 55, 85], "quantif": 12, "quantifi": [13, 14, 21, 23, 46, 104], "quantit": [42, 43, 44, 45, 104], "quantiti": [7, 8, 19, 53, 98, 105, 113], "quartic": 87, "quaternion": [9, 10, 11, 12, 13, 14, 33, 53, 104], "queri": [53, 111], "question": [2, 3, 99], "queue": 15, "quick": [6, 12, 16], "quicker": 77, "quickest": [33, 34], "quickli": [3, 26, 83, 99], "quickstart": 4, "quiet": 4, "quit": [3, 15, 34, 44, 96, 100, 114], "r": [3, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 52, 53, 55, 96, 102, 104, 105, 109], "r0": [18, 19], "r_": [16, 26], "r_0": 19, "r_1": 60, "r_2": 60, "r_charg": 13, "r_g": 16, "r_i": 109, "r_mass": 13, "r_max": 30, "r_valu": 14, "ra": 107, "ra3": 107, "ra5": 107, "rad": [30, 111, 113], "radgyr": [15, 16, 111], "radgyr_per_fram": 15, "radial": [6, 7, 35], "radii": [16, 30, 60, 61, 83, 97, 109, 114], "radiu": [18, 20, 21, 30, 36, 40, 53, 83, 87, 106, 109, 114], "radius_cut": 19, "radius_cut_q": [19, 20], "radius_of_gyr": [53, 109, 111], "radiusofgyr": 16, "radiusofgyration2": 16, "rafael": [38, 104], "rafal": 52, "rainbow": 14, "rais": [1, 3, 33, 49, 53, 65, 79, 81, 82, 83, 99, 100, 101, 105, 108], "rama": 37, "rand": 103, "random": [34, 89, 94, 103], "random_se": 30, "rang": [7, 15, 16, 30, 33, 34, 36, 40, 44, 50, 53, 57, 101, 106, 109], "rangl": [14, 27, 31, 36], "rapid": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "rapidli": [7, 17, 37], "rate": [43, 44], "rather": [3, 16, 19, 26, 36, 40, 53, 83, 99, 105, 108], "ratio": 108, "rational": 3, "ravel": [42, 44, 48], "raw": [3, 103], "rb": 26, "rc": 107, "rc3": 107, "rc5": 107, "rd": 98, "rd_dcd": 44, "rd_dcd2": 44, "rd_namd": 44, "rd_p1": 44, "rd_p1_ax": 44, "rd_p1_fig": 44, "rd_p2": 44, "rd_p2_ax": 44, "rd_p2_fig": 44, "rd_p3": 44, "rd_p3_ax": 44, "rd_p3_fig": 44, "rdax0": 44, "rdax1": 44, "rdf": [6, 7, 35, 36, 105], "rdfig0": 44, "rdfig1": 44, "rdkit": [3, 58, 61, 78, 105], "rdkitconvert": 105, "re": [3, 4, 10, 14, 16, 19, 24, 37, 53, 55, 78, 96, 102, 106, 108], "reachabl": 98, "reaction": [33, 104, 105], "read": [2, 3, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 30, 33, 38, 39, 43, 44, 49, 50, 52, 60, 62, 63, 64, 74, 80, 90, 91, 92, 99, 105, 106, 109, 110, 111, 113, 114], "read_": 87, "read_tpxhead": 87, "readabl": [30, 87], "reader": [4, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 33, 38, 39, 42, 43, 44, 45, 49, 53, 56, 57, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 76, 77, 78, 79, 80, 81, 82, 83, 85, 86, 87, 88, 89, 90, 91, 93, 94, 95, 99, 105, 108, 114], "readerbas": 105, "readm": 4, "readthedoc": [4, 15], "real": [18, 21, 66, 68, 76, 81, 82, 83], "realist": 15, "realli": [1, 13, 15, 108], "reappli": 3, "rearrang": [19, 21], "reason": [3, 38, 52, 88, 108], "rebas": 108, "rebuild": [3, 4], "rebuilt": [89, 102], "recalcul": [53, 89], "recarrai": 30, "receiv": 108, "recent": [0, 3, 67, 87, 102, 108, 109], "recip": 57, "recogn": [66, 76], "recognis": [79, 105, 107], "recognit": [33, 104], "recommend": [2, 3, 21, 26, 45, 61, 100, 101, 102, 108], "recomput": 16, "record": [67, 68, 81, 82, 98, 102, 105, 106, 109], "record_typ": [61, 97, 98, 109], "recordnam": 83, "rectangular": 24, "red": [14, 108], "reddi": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "reduc": [7, 11, 30, 33, 41, 42, 43, 44, 85, 94, 100], "reduced1": 44, "reduced_coordin": 44, "reduct": [6, 34, 41, 104], "redund": 106, "ref": [11, 13, 14, 19, 30, 37, 46, 108], "ref_axi": 39, "ref_ca": 11, "ref_filenam": 108, "ref_fram": [12, 13, 14], "refactor": 105, "refer": [3, 6, 7, 8, 17, 82, 89, 98, 103, 105, 112], "refgroup": [18, 19], "reflect": [3, 4, 105, 106], "reformat": 3, "refresh": 4, "refresh_offset": [89, 94], "regardless": [1, 3, 53, 113], "regener": [89, 94], "regex": 4, "region": [7, 14, 32, 33, 37, 43], "regist": [2, 44], "registri": 2, "regress": 108, "regular": [4, 57, 87], "rel": [3, 4, 9, 10, 15, 16, 27, 48, 60, 101, 108, 109], "relat": [21, 30, 100, 105], "relationship": 99, "releas": [3, 84, 87, 100, 108], "relev": [0, 4, 7, 26, 32, 50, 102], "reli": [3, 53, 60, 83, 100, 108], "reload": [11, 57], "remain": [7, 13, 16, 19, 24, 27, 32, 49, 53, 57, 104, 105, 108, 111], "remaind": 53, "remark": [57, 81, 82], "remot": [3, 4], "remov": [3, 4, 28, 30, 37, 40, 53, 102, 105, 108], "removeh": 78, "renam": [10, 57], "rename_aux": 57, "render": [3, 4, 10, 48, 55, 102], "render_param": [10, 14, 34, 39, 48, 55], "renumb": 83, "repeat": [30, 50], "repetit": 108, "replac": [4, 53, 100, 103, 105, 109], "replai": 3, "replic": 57, "replica": [7, 32, 33], "repo": 3, "report": [2, 52, 99, 108], "repositori": [2, 3, 4, 5, 99, 102], "repres": [7, 12, 13, 15, 20, 27, 32, 33, 34, 38, 39, 40, 42, 43, 44, 48, 50, 53, 57, 60, 67, 103, 109], "represent": [7, 32, 48, 67, 76, 96, 105, 112, 114], "represent_ts_a": 57, "reproduc": 30, "req": 52, "request": [2, 4, 101, 102, 108], "requir": [1, 3, 4, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 65, 66, 79, 81, 82, 83, 95, 96, 98, 100, 103, 105, 106, 108, 109], "res1": 109, "res2": 109, "res3": 109, "res60": 36, "res_com": 24, "res_dist": [23, 24], "resampl": 43, "research": [7, 15, 19, 20, 104], "resembl": 34, "reserv": 93, "reset": [53, 105], "reset_view": 9, "reshap": [34, 44], "resid": [1, 13, 14, 23, 24, 26, 27, 36, 40, 46, 50, 53, 61, 65, 66, 69, 72, 75, 81, 82, 87, 89, 98, 105, 106, 109], "resids1": 22, "resids1_box": 22, "resids2": 22, "resids2_box": 22, "residu": [1, 3, 7, 13, 14, 17, 19, 21, 22, 26, 28, 30, 36, 37, 38, 39, 40, 48, 49, 50, 52, 53, 55, 61, 65, 69, 70, 71, 72, 75, 81, 82, 83, 86, 87, 92, 93, 95, 96, 99, 105, 106, 109, 112, 114], "residue_label": 86, "residue_point": 86, "residue_segindex": 50, "residuegroup": [1, 53, 98, 105, 109], "residuenam": 83, "residuenumb": 83, "residues_by_seg": 98, "residues_per_turn": 39, "resindex": [50, 109], "resindic": [50, 87, 109], "resnam": [1, 18, 19, 21, 26, 27, 28, 36, 37, 40, 48, 50, 53, 55, 61, 65, 72, 81, 82, 86, 87, 96, 97, 98, 105, 106, 109, 112], "resno": 65, "resnum": [39, 61, 72, 87, 106, 109], "resolut": [30, 106], "resolv": [3, 48, 99], "resourc": [2, 3, 15, 42, 44, 55, 99, 108], "respect": [18, 26, 30, 37, 46, 53, 109], "responsibl": 103, "resseq": [81, 82], "rest": [3, 4, 14, 19, 26], "restart": [3, 53, 58, 59, 61, 102], "restraint": 87, "restrict": [1, 13, 14, 87], "restrt": [52, 58, 59, 61], "restructur": 3, "result": [1, 10, 11, 12, 13, 14, 16, 18, 19, 20, 21, 24, 30, 31, 36, 37, 38, 39, 40, 42, 43, 44, 48, 49, 52, 53, 61, 89, 94, 105, 106, 108, 110], "result_1": 15, "results_ensembl": 15, "retain": [7, 17, 19, 21, 85], "retri": 3, "retriev": [3, 9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55, 104], "return": [1, 3, 4, 9, 10, 13, 15, 16, 18, 19, 20, 21, 22, 24, 27, 30, 33, 34, 37, 40, 42, 44, 50, 53, 57, 98, 102, 105, 106, 108, 110, 111, 112], "return_count": 40, "reus": [16, 108], "reveal": 14, "revert": 105, "review": [3, 4, 104], "reviewnb": 4, "revis": 3, "revisit": 12, "rewind": [105, 110], "rg": [98, 107], "rg3": 107, "rg5": 107, "rgba": 48, "rgyr": 53, "rgyr_df": 53, "rho": 36, "rho_i": 14, "ri": 96, "ri_sq": [15, 16], "richard": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "richardjgow": 50, "richardson": [37, 104], "right": [4, 13, 14, 31, 40, 81, 106], "rightarrow": 3, "rise": [19, 39], "rm": [6, 11, 12, 13, 14, 26, 27, 30, 53, 110], "rmin": 109, "rmin14": 109, "rmsd": [6, 7, 8, 9, 10, 11, 14, 30, 33, 41, 46, 57, 104, 105, 110], "rmsd_analysi": 53, "rmsd_df": 53, "rmsd_valu": 30, "rmsf": [7, 8, 12, 13], "rmsf_tempfactor": 14, "robert": [26, 27, 28, 52], "robust": [38, 105], "roceed": 104, "rog": 16, "rog_1": 15, "rog_10": 16, "rog_2": 15, "rog_3": 15, "rog_4": 15, "rog_bas": 16, "rog_base_10": 16, "rog_sq": [15, 16], "rog_u1": 16, "rog_u2": 16, "rohrdanz": [33, 104], "role": 15, "ronald": [33, 104], "root": [3, 6, 7, 8, 9, 11, 15, 16, 38, 78, 82], "rose": [9, 10, 52, 55, 104], "rostrup": [45, 52, 53], "rot": 48, "rotat": [3, 7, 8, 9, 10, 11, 13, 14, 38, 48, 53, 104, 109, 112], "rotate_bi": 109, "roughli": 50, "round": [102, 108], "row": [13, 16, 26, 43, 45, 53], "rsmf": 14, "rst": 4, "rst7_ala2": 52, "ru": 107, "ru3": 107, "ru5": 107, "rule": [3, 4, 44, 99, 102, 106, 108], "run": [3, 4, 5, 6, 7, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 40, 42, 44, 46, 48, 49, 52, 53, 55, 59, 61, 97, 100, 101, 102, 105, 110], "run_analysi": 15, "run_anlaysi": 15, "run_per_fram": 15, "rundown": 53, "runreactantinplac": 105, "runtim": 105, "rxn_coord": 30, "rxncoord": 30, "ryckaert": [57, 87], "rzmc11": [33, 104], "s0006": [30, 104], "s0022283609011164": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55, 104], "s0108767305015266": [9, 10, 11, 12, 13, 14, 33, 104], "s0263": [30, 104], "sagan": 114, "sai": 3, "salah00": 105, "salt": [19, 21], "samantha": [38, 104], "same": [1, 3, 4, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 24, 26, 28, 30, 31, 33, 34, 36, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 53, 55, 60, 67, 93, 95, 96, 98, 102, 103, 105, 106, 109, 110, 114], "sampl": [7, 9, 10, 11, 12, 13, 18, 19, 20, 21, 30, 32, 33, 34, 39, 42, 43, 44, 53, 104], "sample_sd": 39, "sanitizationerror": 105, "sanitize_output": 4, "sansom": [30, 104], "save": [4, 9, 10, 13, 14, 15, 16, 19, 26, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 88, 96, 105, 108], "saw": 28, "sb17": [14, 104], "scalar": 108, "scale": [13, 15, 19, 20, 33, 76, 104], "scale_factor": 79, "scan": 4, "scatter": [3, 33, 34, 37, 44, 48], "scenario": [61, 79], "schedul": [15, 105], "schema": 72, "scheme": [14, 15, 42, 44, 102], "scheraga": 104, "schlaicha": 105, "scienc": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "sciencedirect": [37, 104], "scientif": [2, 3, 15, 85, 104, 105], "scikit": [3, 7, 42, 43, 44], "scipi": [3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 79, 101, 104, 105], "scipy2016": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "scitat": [34, 104], "scope": [3, 108], "scott": 44, "scratch": 50, "screenshot": 48, "script": [3, 4, 7, 9, 10, 11, 12, 13, 14, 15, 33, 53, 83, 102, 104], "scroll": 100, "sd": 53, "sdist": 102, "se": 19, "seaborn": [3, 12, 18, 19, 33, 34, 46], "seamlessli": [2, 67], "sean": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "search": [3, 4, 30, 106], "sebastian": [19, 20, 104], "sec": 113, "second": [1, 10, 12, 18, 19, 21, 40, 44, 53, 105, 113], "secondari": [19, 21], "section": [0, 3, 4, 9, 10, 11, 12, 13, 14, 19, 33, 53, 55, 57, 66, 81, 84, 100, 104, 105, 108], "see": [1, 2, 3, 4, 5, 7, 9, 10, 11, 12, 13, 14, 18, 19, 20, 21, 22, 26, 27, 28, 30, 32, 33, 34, 37, 38, 40, 42, 43, 44, 46, 48, 50, 52, 53, 55, 56, 57, 60, 61, 63, 66, 67, 69, 76, 81, 84, 87, 94, 96, 98, 99, 100, 101, 102, 103, 105, 106, 108, 109, 112, 114], "seem": [13, 44], "seen": [27, 34, 42, 44, 45, 46, 53, 105], "seg": [98, 106], "seg_": 87, "seg_0_protein_a": 98, "seg_0_protein_chain_a": 87, "seg_1_protein_chain_b": 87, "seg_2_sol": 87, "segid": [0, 1, 10, 26, 50, 53, 61, 65, 81, 82, 83, 105, 106, 109], "segindex": 109, "segindic": [50, 109], "segment": [1, 10, 49, 53, 61, 65, 70, 81, 87, 95, 99, 103, 105, 106, 109, 114], "segment_index": 87, "segmentgroup": [0, 1, 53, 98, 105, 109], "sel": 96, "sel_a": 40, "sel_acid": [18, 19, 21], "sel_bas": [18, 19, 21], "select": [3, 4, 6, 7, 9, 10, 11, 12, 14, 16, 17, 18, 19, 22, 25, 26, 27, 30, 31, 33, 34, 36, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 51, 66, 98, 99, 105, 110, 114], "select_atom": [1, 9, 11, 13, 14, 15, 16, 18, 19, 21, 22, 23, 24, 26, 31, 34, 36, 37, 40, 48, 50, 52, 53, 55, 96, 98, 103, 105, 106, 110, 111, 112, 114], "select_remov": 37, "selected_atom": 98, "selected_fram": 57, "selectionwrit": 96, "selector": 106, "self": [0, 3, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 33, 38, 39, 42, 43, 44, 45, 49, 108], "self_dist": 24, "self_distance_arrai": 24, "semant": 102, "send": 3, "sens": [7, 8, 84, 108, 109], "sensit": [96, 106], "sent": 3, "sentenc": 3, "separ": [1, 5, 7, 15, 16, 19, 30, 31, 36, 40, 42, 43, 81, 83, 84, 100, 102, 106, 108, 114], "septemb": [38, 104], "seq": 106, "sequenc": [46, 81, 82, 93, 103, 109], "sequence_alig": 105, "sequence_align": 105, "sequenti": [83, 106], "ser": [37, 105, 107], "seri": [30, 34, 57, 104, 105], "serial": [81, 82, 83, 100, 103, 105, 108, 109], "serious": 3, "serv": 105, "servic": 108, "session": [3, 5], "set": [2, 3, 4, 5, 7, 8, 9, 10, 11, 12, 14, 15, 16, 19, 23, 26, 27, 30, 31, 34, 37, 46, 48, 50, 52, 53, 57, 61, 66, 67, 68, 81, 83, 87, 88, 89, 92, 96, 101, 102, 103, 104, 105, 106, 108, 109, 111, 114], "set_aspect": 24, "set_aux_attribut": 57, "set_box": 112, "set_label": [42, 44, 48], "set_plot_them": 48, "set_printopt": 26, "set_titl": [42, 44], "set_xlabel": [38, 43, 44], "set_xtick": [23, 42, 44], "set_xticklabel": [23, 42, 44], "set_ylabel": [13, 16, 23, 24, 38, 43, 44], "set_ytick": 23, "set_yticklabel": 23, "set_zlabel": 44, "setposit": 52, "settabl": 57, "settl": 87, "setup": [3, 100, 101, 102, 105, 108], "sever": [1, 3, 7, 16, 29, 30, 33, 34, 53, 82, 101, 105, 108, 114], "seyler": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "sfpg": [15, 104], "sfsb14": [30, 104], "sg": 105, "sgw93": [30, 104], "sh": 3, "shannon": [42, 43, 44], "shape": [10, 12, 13, 16, 19, 21, 23, 24, 26, 27, 30, 31, 33, 34, 37, 39, 40, 43, 44, 45, 48, 50, 53, 109], "shape_paramet": [105, 109], "share": [1, 3, 105], "sharei": [38, 42, 44], "shares_memori": 108, "sharex": 38, "shell": [36, 40, 106], "shift": [110, 111], "shifted_aligned_view": 9, "shini": 3, "short": [3, 27, 30, 33, 34, 108], "shortcut": [1, 106], "shorten": 30, "shorter": 83, "shortli": 105, "shoshanna": [37, 104], "should": [3, 4, 5, 12, 13, 14, 15, 22, 26, 27, 30, 31, 34, 36, 42, 44, 53, 57, 68, 72, 77, 78, 83, 87, 92, 100, 101, 102, 105, 108, 109, 114], "show": [3, 9, 10, 13, 14, 15, 19, 23, 24, 26, 27, 34, 37, 39, 44, 48, 50, 52, 53, 55, 57, 98, 106, 108, 112], "show_mdanalysi": [9, 10, 14, 19, 34, 39, 48, 50, 55], "showextrema": 44, "shown": [13, 16, 30, 34, 37, 48, 50, 53, 89, 113], "shrinkag": 45, "shubx10": 105, "shuji": [15, 104], "shupe": 15, "si": 113, "side": [13, 14, 37, 104, 108], "sidechain": 98, "sigma": [45, 48], "sign": [2, 34], "signific": [15, 22, 83, 100, 105, 114], "significantli": [5, 13, 100, 105], "silent": 112, "sim": [43, 52], "similar": [1, 3, 4, 6, 12, 15, 19, 23, 24, 30, 32, 33, 34, 37, 38, 53, 73, 82, 83, 87, 92, 93, 98, 104], "similarli": [30, 36, 37, 48, 50, 98, 109], "similiar": 15, "simmonett": 52, "simon": [37, 104], "simpl": [53, 83, 95, 98, 104, 112], "simple2": 30, "simplest": [27, 28], "simpli": [1, 3, 12, 13, 15, 21, 24, 26, 34, 40, 50, 52, 53, 60, 79, 84, 88, 101, 104, 105, 106, 109, 113], "simplifi": 98, "simplist": 21, "simul": [7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 51, 53, 55, 57, 58, 61, 67, 68, 85, 104], "simultan": [3, 19, 85], "sinc": [3, 4, 15, 45, 57, 67, 87, 102, 106], "singl": [3, 13, 15, 26, 27, 38, 46, 57, 61, 81, 105, 106, 108, 114], "singlefram": 105, "singleword": 96, "singular": [30, 38, 43, 44, 109], "site": [4, 11, 12, 13, 15, 16, 18, 20, 21, 28, 33, 36, 37, 38, 42, 43, 44, 45, 49, 108], "site_url": 4, "sitemap": 3, "sittel": [34, 104], "situat": [96, 100], "six": 101, "size": [18, 26, 36, 38, 43, 46, 49, 50, 53, 55, 71, 89, 99, 102, 111], "sjs14": [34, 104], "skimag": 48, "skip": [1, 3, 16, 46, 57, 100], "skipif": 108, "sklearn": [43, 44], "sktb15": [46, 104], "slice": [16, 53, 57, 103, 106, 111], "slice_volum": 49, "slide": 39, "slightli": 28, "slow": [15, 79, 102], "sm67": [39, 104], "small": [3, 4, 5, 26, 27, 57, 78, 101, 108], "smaller": [33, 50, 98], "smart": [30, 104, 105], "smarts_kwarg": 105, "smith": [26, 27, 28], "smooth": 48, "smoother": 48, "smoothli": 27, "sn": [33, 34], "snapshot": [3, 102], "snippet": 48, "snw": [30, 104], "so": [3, 4, 5, 10, 11, 13, 14, 15, 16, 19, 22, 23, 24, 30, 34, 36, 37, 40, 42, 45, 48, 50, 55, 57, 60, 83, 87, 88, 92, 96, 102, 103, 105, 106, 108, 109, 114], "societi": [38, 104], "soft_cut": 19, "soft_cut_q": 19, "softwar": [4, 15, 42, 43, 44, 45, 100, 104, 106, 108], "sol": [1, 30, 36, 37, 40, 48, 50, 55, 87, 112], "sol_view": 50, "sole": 105, "solut": [15, 34, 79], "solv": [2, 87], "solvat": [36, 48], "solvent": [6, 7, 40, 47, 50, 114], "solventradii": 109, "solventradiu": 109, "some": [0, 2, 3, 9, 10, 14, 15, 22, 23, 24, 26, 27, 30, 34, 45, 46, 50, 52, 53, 55, 60, 66, 100, 102, 103, 105, 108], "someon": 3, "someth": [3, 52, 53, 112], "sometim": [3, 15, 50, 57, 60, 61, 71, 89, 105, 111, 114], "somewhat": [9, 34], "soon": [30, 102], "sophiaruan": 105, "sophist": 52, "sort": [1, 26, 27, 30, 34, 53, 105, 106], "sort_backbon": 31, "sorted_bb": 31, "sourc": [2, 3, 4, 16, 30, 53, 57, 84, 96, 100, 102, 105, 108], "south": [33, 104], "space": [3, 7, 32, 33, 41, 42, 43, 44, 48, 50, 83, 84, 100, 106, 108], "spatial": [31, 46], "spc": [106, 113], "spec": 82, "special": [3, 4, 53, 108], "specif": [2, 3, 4, 7, 14, 16, 26, 27, 29, 30, 36, 53, 56, 60, 66, 73, 98, 100, 101, 103, 104, 105, 108, 110, 114], "specifi": [3, 16, 19, 26, 27, 30, 42, 43, 44, 49, 53, 57, 60, 61, 66, 83, 93, 103, 106, 108, 114], "spectral": 33, "sped": 103, "speed": [2, 105, 108], "spelt": 105, "sph": 30, "sph_6": 106, "sph_process": 30, "sphere": [30, 53, 106], "spheric": [36, 40, 106], "sphinx": [3, 4], "sphinx_autobuild": 4, "sphinxcontrib": 3, "sphlayer": 106, "sphpdb": 30, "sphpdb_file": 30, "sphzone": [40, 106], "split": [3, 5, 26, 36, 89, 94, 98, 103, 105], "split_data": 44, "splitat": 96, "splitch": 96, "splitr": 96, "spring": 38, "springer": [34, 104], "spt": 96, "spuriou": 4, "sq": [15, 16], "sq_dist_arr": 24, "sq_dist_r": 24, "sq_r": [15, 16], "sq_x": [15, 16], "sq_y": [15, 16], "sq_z": [15, 16], "sqlite": 69, "sqrt": [13, 14, 15, 16], "squar": [6, 7, 8, 9, 11, 12, 15, 16, 24, 38, 104, 105], "sr": 57, "src": [3, 84, 87], "ss18": [34, 104], "ss_rdf": 40, "ss_rdf_nodens": 40, "ssh": 2, "stabil": [3, 102], "stabl": [3, 13, 14, 22, 100], "stack": [10, 108], "stackoverflow": [3, 48], "stage": 114, "stai": 38, "stand": 57, "standalon": [2, 16, 108], "standard": [3, 7, 30, 37, 39, 42, 44, 53, 58, 59, 61, 65, 82, 84, 93, 97, 101, 105, 106], "standardization_react": 105, "star": 108, "starlark": 108, "start": [3, 4, 6, 12, 13, 15, 16, 26, 30, 50, 57, 61, 69, 83, 87, 91, 101, 105, 106, 108], "stash": 3, "state": [4, 7, 12, 13, 14, 15, 19, 32, 33, 34, 38, 53, 102, 103, 104, 111], "statedatareport": 52, "statement": [53, 105, 108], "static": [1, 10, 15, 53, 106, 109, 111, 114], "static_ag": 106, "statist": [27, 34, 104, 108], "statu": [3, 15, 82], "std": [42, 44, 105], "stddev": 105, "stdin": 0, "stdout": 52, "stelzl": [30, 104], "step": [2, 3, 10, 13, 14, 15, 16, 26, 34, 37, 39, 44, 48, 52, 53, 55, 57, 68, 72, 88, 105, 112, 114], "stern": 52, "stick": [2, 50], "still": [4, 10, 15, 27, 60, 101, 102, 103, 105, 108], "stitch": 103, "stochast": 44, "stochasticproximityembeddingn": 44, "stock": [34, 104], "stop": [15, 16, 26, 33, 42, 53, 105, 111], "storag": 85, "store": [3, 5, 12, 30, 34, 39, 48, 53, 57, 69, 85, 88, 89, 94, 105, 113], "str": [3, 96, 108], "straightforward": [2, 53, 103, 106], "strategi": 105, "stream": 15, "streamlin": 105, "streamlines_3d": 105, "strength": 108, "string": [3, 4, 19, 28, 39, 81, 83, 96, 105, 106, 108, 109], "stringio": 98, "strive": [3, 101, 108], "strongli": [3, 100, 108], "structur": [6, 8, 10, 11, 12, 16, 17, 19, 20, 21, 30, 34, 37, 38, 39, 41, 46, 52, 56, 58, 59, 61, 96, 97, 103, 104, 106, 108, 111, 114], "structure_onli": 53, "structuredgrid": 48, "studi": 19, "studio": 100, "style": [3, 66, 67, 85, 89, 94, 105, 106], "st\u00e9phane": [33, 104], "sub": [53, 66], "subclass": [16, 42, 44, 108], "subject": 3, "subkeyword": 106, "submiss": 15, "submit": [3, 108], "subplot": [23, 24, 33, 38, 42, 43, 44, 45, 48], "subscrib": [2, 99], "subselect": 106, "subsequ": 103, "subset": [16, 28, 52, 82, 111], "subspac": [7, 32, 34, 43], "subst_id": 105, "subst_nam": 105, "substanti": [103, 108], "substitut": [82, 112], "substructur": 78, "subtract": [1, 13, 84], "succe": 108, "success": [7, 32, 34, 46], "successfulli": 102, "suffer": 13, "suffici": [103, 108], "suffix": [74, 88, 102], "sugar": 106, "sugeta": [39, 104], "suggest": [3, 12, 16, 19], "suit": [3, 53, 100, 114], "suitabl": [7, 16, 32, 33, 49], "sulfur": 105, "sum": [13, 14, 15, 16, 18, 19, 21, 27, 55, 104, 108, 109], "sum_": [13, 36], "sum_i": [16, 109], "sumit112192": 105, "summar": [3, 102], "summari": [3, 39, 53, 104, 108], "summaris": 39, "super": 16, "supercomput": 100, "superfl": 40, "superimpos": 13, "superpos": 10, "superposit": [9, 10, 11, 13, 14, 53, 104], "suppl_2": [19, 20, 104], "suppli": [15, 61, 68], "support": [1, 3, 13, 19, 30, 46, 53, 66, 71, 72, 82, 84, 85, 88, 100, 103, 105, 106, 109, 111, 114], "suppress": [9, 10, 14, 22, 23, 24, 27, 30, 34, 46, 50, 52, 53], "sure": [2, 3, 4, 18, 100, 102, 106, 108], "surf": 57, "surfac": 105, "surften": 57, "surpris": 61, "survivalprob": 105, "svd_solver": [43, 44], "swail": 52, "switch": [3, 9, 19, 79, 102], "sy": [4, 52], "symbol": [44, 81], "symlink": [30, 105], "symmetr": 48, "symmetric_differ": 1, "symmetris": 45, "symposium": [33, 104], "sync": 89, "synchron": 15, "synovi": [26, 27, 28], "syntax": [4, 15, 52, 98, 108], "syrupi": 102, "system": [1, 2, 3, 4, 14, 15, 22, 26, 30, 36, 40, 50, 53, 57, 61, 80, 81, 83, 105, 108, 114], "s\u00e9bastien": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "t": [1, 3, 4, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 24, 26, 27, 28, 30, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 48, 49, 50, 52, 53, 55, 56, 57, 66, 82, 92, 96, 98, 100, 103, 104, 105, 106, 107, 108, 110, 111, 112, 114], "t_0": 27, "tab": [3, 83], "tabl": [4, 48, 105, 109, 113], "tabul": 87, "tag": [3, 100, 102, 105], "take": [2, 3, 4, 7, 14, 15, 16, 17, 23, 26, 30, 33, 42, 44, 48, 93, 96, 99, 100, 103, 106, 108, 109, 112, 114], "take_this_fram": 66, "taken": [3, 27, 40, 42, 83, 95, 106, 108], "tandfonlin": [14, 104], "tarbal": 102, "target": [9, 13, 23, 100, 105], "task": [15, 48, 53, 99, 108, 111], "tatsuo": 104, "tau": 27, "tau1": 27, "tau2": 27, "tau_1": 27, "tau_2": 27, "tau_fram": 27, "tau_max": 27, "tau_tim": 27, "tau_timeseri": 27, "tb": [45, 50], "tcl": 96, "tcount": 27, "tcp": 15, "team": 2, "technic": [2, 3, 4, 88], "techniqu": [7, 32, 33, 34], "technometr": [14, 104], "tediou": [3, 4], "tell": [3, 4, 19, 53, 84, 93, 108], "temp": 57, "temp_fil": 108, "temperatur": [14, 26, 52, 57, 81, 82], "tempfactor": [14, 61, 65, 81, 82, 97, 105, 109], "templat": 16, "temporari": [30, 105], "temporarili": 9, "tend": 4, "tensor": 109, "ter": 98, "term": [19, 57, 80, 85, 87, 99, 106], "term_dict": 57, "termin": [3, 5], "tertiari": [19, 21], "test": [1, 2, 5, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 70, 93, 96, 98, 102, 103, 106, 109, 110, 111, 112, 114], "test_": 108, "test_align": 108, "test_analysi": 108, "test_aug": 105, "test_center_of_mass_compounds_speci": 108, "test_equal_arrai": 108, "test_equal_coordin": 108, "test_foo_is_length_3": 108, "test_for_error": 108, "test_for_warn": 108, "test_open": 108, "test_pdb_writ": 108, "test_positions_share_memori": 108, "test_spars": 108, "test_write_no_arg": 108, "test_write_trajectory_netcdf4": 108, "testcontactmatrix": 108, "tested_expected_failur": 108, "testpypi": 102, "testsuit": [3, 5, 100, 102, 108], "text": [3, 4, 13, 15, 16, 20, 21, 23, 24, 30, 36, 38, 40, 43, 44, 57], "textrm": 26, "th": [34, 40], "than": [3, 13, 14, 15, 18, 19, 26, 28, 30, 36, 40, 42, 50, 53, 57, 60, 65, 71, 75, 83, 88, 99, 105, 106, 108], "thank": 104, "the05": [7, 8, 9, 10, 11, 12, 13, 14, 33, 104], "thei": [0, 3, 4, 7, 10, 12, 15, 16, 19, 20, 27, 32, 34, 37, 38, 42, 46, 48, 50, 57, 60, 61, 66, 79, 89, 92, 98, 100, 101, 102, 103, 105, 107, 108, 109, 111], "them": [1, 3, 4, 7, 9, 10, 13, 15, 18, 19, 22, 34, 38, 39, 42, 43, 44, 45, 46, 50, 52, 53, 55, 60, 61, 66, 68, 79, 81, 82, 89, 95, 101, 102, 103, 104, 105, 106, 108, 109, 112], "theme": 3, "themselv": [36, 108], "theobald": [9, 10, 11, 12, 13, 14, 33, 53, 104], "therebi": 34, "therefor": [3, 4, 13, 14, 15, 19, 33, 37, 42, 43, 50, 52, 53, 72, 79, 92, 95, 98, 108], "theta": 39, "theta_": [26, 31], "thi": [0, 1, 2, 3, 4, 5, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 56, 57, 60, 61, 62, 66, 68, 69, 71, 75, 79, 81, 82, 83, 84, 85, 87, 88, 89, 93, 94, 95, 96, 98, 99, 100, 101, 102, 103, 104, 105, 106, 108, 109, 111, 114], "thing": [3, 4], "think": [12, 16, 26, 53, 56], "third": [13, 53], "thoma": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "thorp": [46, 104], "those": [16, 19, 26, 30, 53, 57, 67, 87, 98, 102, 108], "though": [15, 18, 48, 68], "thought": [53, 99, 105, 111], "thousand": 15, "thr": [27, 36, 37, 53, 105, 107], "thr_c": 36, "thr_c1": 36, "thr_other": 36, "thr_other1": 36, "thread": 15, "threadpoolctl": 3, "three": [4, 13, 14, 16, 19, 22, 23, 26, 34, 42, 44, 49, 50, 83, 105, 108, 109, 114], "threonin": 36, "threshold": 57, "through": [1, 2, 3, 4, 7, 12, 14, 15, 32, 41, 49, 53, 57, 98, 103, 105, 106, 109, 111, 114], "throughout": [3, 4, 9, 10, 14, 19, 26, 27, 30, 34, 39, 48, 50, 53, 55, 98, 105], "throw": 105, "thu": [4, 53, 87], "thumb": 108, "thy": 107, "ti": 114, "tiberti": [42, 43, 44, 45, 104], "tick_interv": 23, "tidi": 34, "tidynam": 3, "tile_univers": 50, "tiled_view": 50, "tim": 3, "time": [3, 4, 12, 13, 14, 15, 16, 18, 19, 20, 26, 30, 33, 34, 36, 37, 38, 40, 52, 53, 55, 56, 57, 61, 63, 67, 68, 72, 78, 79, 88, 89, 94, 99, 102, 103, 105, 106, 108, 111, 112, 114], "time_const": 27, "time_offset": 61, "time_selector": 57, "timeout": 3, "times3": 34, "times_tim": 27, "timescal": 27, "timeseri": [10, 15, 16, 18, 19, 20, 21, 53, 57, 105], "timestamp": 15, "timestep": [9, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 33, 38, 39, 42, 43, 44, 45, 49, 53, 55, 57, 61, 81, 89, 95, 105, 106, 108, 110, 111, 112, 114], "timeunit": [66, 68, 103], "tinker": [3, 58, 59, 61, 97], "tip": 30, "tip3": [26, 28], "tip3p": [26, 113], "tip4p": [48, 113], "titl": [23, 24, 26, 27, 40, 42, 44, 45, 53, 81], "tk": 30, "tmp": 30, "tmp_file": 30, "tmp_hbond": 27, "tmpdir": 108, "tng": [58, 59, 61, 105], "tngreader": 85, "to_csv": 26, "toc": 3, "toctre": 4, "togeth": [2, 53, 99, 103, 112], "toggl": 53, "toler": 19, "tolist": [42, 44], "tom": 78, "toml": 3, "tone": [42, 43, 44, 45, 104], "too": [1, 16, 42, 44, 48, 53, 55, 56, 99, 108], "tool": [3, 4, 7, 15, 19, 30, 33, 34, 48, 53, 67, 78, 80, 96, 99, 100, 103], "toolkit": [2, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 52, 53, 55, 99, 104], "top": [3, 4, 44, 59, 61, 87, 88, 96, 97, 101, 108, 109], "topic": [3, 4], "topologi": [1, 4, 5, 14, 15, 26, 28, 52, 53, 59, 63, 65, 66, 69, 70, 71, 72, 73, 76, 77, 78, 80, 81, 82, 83, 84, 91, 92, 93, 95, 98, 99, 103, 105, 106, 108, 111], "topology_format": [61, 93, 114], "topologyattr": [50, 105], "topologygroup": [50, 109], "topologyobject": [109, 114], "toppars": 86, "torsdof": 82, "torsion": [82, 87, 105], "total": [16, 26, 34, 36, 52, 57, 109], "total_charg": [53, 109], "total_mass": [15, 16, 53, 109], "touch": [3, 61], "toward": [27, 40, 110], "tpb": [7, 41, 42, 43, 44, 45, 104], "tpr": [0, 26, 36, 40, 48, 55, 59, 61, 71, 75, 97, 98, 103, 105, 106, 109, 112, 114], "tpr2021": 98, "tpr_resid_from_on": 105, "tprparser": 105, "tprreaderdevelop": 87, "tpx": 87, "tpxio": 87, "tqdm": [3, 27, 105], "traceback": [0, 108], "traceless": 109, "track": [3, 30, 34, 105], "tracker": [2, 87, 99, 108], "tradition": 60, "traj": 88, "traj1": 114, "traj2": 114, "trajectori": [1, 5, 6, 8, 9, 17, 18, 20, 21, 26, 27, 32, 33, 36, 37, 38, 40, 42, 43, 44, 45, 48, 49, 50, 52, 54, 58, 59, 61, 66, 71, 72, 81, 82, 91, 93, 99, 104, 105, 106, 108, 112, 113, 114], "trajectory1": 103, "trajectory2": 103, "trajectory_slic": 57, "tran": [48, 55, 112], "tranform": 34, "trans1": 34, "transfer": 105, "transfer_to_memori": 103, "transferas": 15, "transform": [3, 6, 7, 13, 15, 32, 33, 34, 105, 109, 111, 114], "transit": [7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 32, 33, 34, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 48, 50, 53, 55, 104], "translat": [13, 38, 48, 50, 55, 105, 109, 112], "transmiss": 59, "transport": [30, 104], "transpos": 48, "travers": 98, "travi": [3, 108], "trc": [58, 61], "treat": [3, 42, 45, 48, 53, 72, 82, 89, 114], "tree": 3, "tri": [3, 61, 67, 79, 86, 109, 114], "triangular": 24, "triclin": [50, 67, 105], "triclinic_dimens": 55, "trigger": [3, 102, 108], "triplet": 40, "tripo": [58, 59, 61, 97], "triu": 24, "triu_indices_from": 24, "trivial": 48, "trj": [52, 58, 59, 61, 68, 79, 114], "trjcat": [89, 94, 114], "trjconv": 48, "trjreader": [52, 88], "troubl": [2, 40], "trp": 107, "trr": [53, 57, 58, 59, 61, 94, 103, 111, 114], "trr_xvf": 57, "trrreader": 89, "trrwriter": 89, "true": [1, 3, 9, 10, 11, 12, 13, 14, 16, 26, 27, 28, 30, 34, 37, 38, 40, 42, 44, 45, 46, 48, 50, 52, 53, 55, 66, 68, 89, 94, 103, 105, 106, 108, 110, 114], "truncat": [30, 89], "truth": 105, "try": [3, 4, 43, 55, 78, 87, 92, 99, 100, 101, 103, 108], "trz": [31, 58, 59, 61, 105], "trz_psf": 31, "trzreader": [90, 105], "trzwriter": 90, "tune": [100, 105], "tupl": [19, 30, 50, 98, 103, 105, 109], "turn": [13, 16, 18, 33, 34, 39, 46, 53, 57, 106, 108], "tutori": [3, 4, 5, 6, 7, 9, 10, 12, 14, 15, 19, 30, 32, 34, 39, 40, 48, 50, 53, 55, 100, 112, 114], "twice": 44, "twine": 102, "twist": 39, "twitter": 102, "two": [3, 4, 5, 6, 7, 8, 10, 15, 17, 19, 26, 27, 31, 32, 38, 42, 44, 46, 50, 53, 60, 98, 99, 103, 105, 106, 109, 114], "tx": [45, 52, 53], "txt": 4, "txyz": [58, 59, 61, 97, 109], "txyzpars": 91, "txyzread": 91, "tyler": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "type": [1, 3, 26, 42, 50, 52, 53, 58, 61, 65, 66, 72, 80, 81, 82, 83, 84, 85, 86, 87, 91, 92, 96, 97, 98, 104, 105, 106, 109, 113], "type_index": 109, "type_indic": [61, 86, 97, 109], "typeerror": 105, "typic": [1, 3, 7, 8, 13, 14, 26, 50, 52, 53, 96, 98, 99, 108, 109, 111, 112, 114], "typo": [2, 3], "tyr": [27, 107], "tyr_thr": 96, "u": [0, 1, 5, 13, 14, 15, 16, 18, 19, 20, 21, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 39, 40, 43, 48, 49, 50, 52, 53, 55, 57, 61, 66, 70, 88, 96, 98, 103, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114], "u1": [22, 38, 42, 44, 45, 46, 109, 114], "u2": [16, 22, 38, 42, 44, 45, 46, 55, 57, 114], "u21": 26, "u3": [42, 44, 45, 46, 114], "u4": [45, 46], "u5": 46, "u_": 50, "u_long": 57, "u_pickl": 103, "u_short": 57, "u_with_box": 111, "uk": 70, "ulimit": 3, "ultim": 103, "umak": 105, "un": 108, "unalign": 11, "unaligned_rmsd": 11, "uncertainti": 12, "unchang": [19, 57, 105], "uncom": [11, 14, 48], "uncommit": 3, "uncompress": [94, 105], "uncorrel": [7, 27, 32, 34], "undefin": 105, "under": [2, 3, 15, 19, 53, 87, 101, 105, 108, 110], "underestim": 101, "underflow": 14, "underli": 60, "underscor": 3, "underscore_method": 3, "understand": 99, "understood": 106, "unexpect": [3, 16], "unfamiliar": 4, "unfold": 19, "unfortun": [48, 50, 102], "unifi": 3, "uninstal": 4, "union": [1, 106], "uniqu": [7, 26, 34, 40, 57, 105, 108], "unit": [1, 5, 26, 48, 49, 50, 52, 53, 63, 66, 67, 68, 76, 79, 81, 82, 88, 101, 103, 105, 106, 108, 112], "unit_dict": 57, "unitcel": [22, 67], "unitless": 92, "univers": [1, 3, 5, 6, 7, 9, 11, 12, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 56, 60, 61, 62, 66, 68, 71, 77, 80, 81, 82, 88, 89, 93, 94, 95, 96, 98, 99, 103, 105, 106, 108, 110, 111, 112], "universe2": 103, "universe_from_origin": 39, "unix": [30, 106], "unk": [81, 82], "unknown": 105, "unless": [4, 42, 61, 87, 100, 106, 114], "unlik": [0, 1, 3, 7, 10, 19, 30, 32, 33, 38, 68, 69, 72, 75, 82, 106], "unload": 79, "unmaintain": 108, "unnecessari": 4, "unoffici": 81, "unpair": 105, "unpickl": [103, 114], "unsupport": 103, "unter": 57, "until": [16, 42, 53, 111], "unus": [44, 105], "unweight": [13, 15, 16], "unwrap": [48, 105, 109, 112], "unzip": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 104], "up": [2, 3, 4, 12, 15, 16, 27, 31, 42, 44, 46, 52, 53, 57, 66, 93, 96, 99, 100, 103, 105, 106, 108, 112], "up_by_2": 112, "up_by_5": 112, "up_by_x": 112, "upcom": 105, "updat": [3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 72, 99, 100, 105, 106, 108, 110, 114], "update_represent": 14, "update_select": [26, 27], "updatingatomgroup": [53, 105, 106], "upgrad": [53, 100, 105, 108], "upload": 3, "upon": [5, 102], "upper": [23, 24, 26, 30, 42, 44, 45], "upstream": [3, 4], "ura": 107, "urei": 87, "ureybradlei": [80, 109], "url": [4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "us": [0, 1, 3, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 26, 27, 31, 33, 34, 36, 37, 39, 40, 41, 42, 44, 45, 46, 48, 50, 51, 53, 55, 58, 60, 61, 67, 72, 78, 79, 80, 81, 82, 83, 85, 86, 89, 92, 93, 94, 95, 96, 99, 100, 101, 102, 103, 105, 106, 109, 110, 111, 112, 113, 114], "usabl": 100, "usag": [3, 4, 26, 34, 53, 99], "useabl": 52, "user": [1, 2, 3, 6, 7, 15, 19, 26, 28, 33, 39, 42, 43, 44, 45, 49, 53, 60, 61, 66, 68, 69, 72, 78, 79, 87, 88, 100, 101, 102, 103, 105, 106, 108, 109, 114], "user_timestep": 114, "usernam": 3, "userwarn": [28, 37], "usr": 3, "usual": [4, 13, 34, 53, 56, 82], "util": [15, 93, 105, 108], "v": [3, 6, 7, 17, 18, 19, 21, 34, 36, 104, 105], "v1": [14, 104], "v2": [105, 108], "v3": 105, "val": [37, 39, 105, 107], "valid": [37, 81, 89, 104, 105, 106], "valu": [1, 3, 7, 8, 11, 12, 13, 14, 15, 19, 24, 26, 27, 30, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 53, 57, 60, 65, 66, 67, 76, 81, 82, 83, 89, 92, 105, 106, 108, 110, 114], "valuabl": 15, "value_nam": 34, "valueerror": [83, 109], "valueerrortraceback": 109, "van": [30, 33, 60, 104, 109, 114], "var_nam": 34, "vari": [4, 37, 38, 44], "variabl": [3, 4, 5, 30, 34, 49, 100, 104, 105], "varianc": [7, 32, 34, 42, 43], "variat": [34, 38], "varieti": 61, "variou": [7, 26, 85, 105], "vdw": 60, "vdwradii": 114, "vdwradii_fil": 30, "ve": [3, 108], "vector": [3, 7, 13, 24, 31, 32, 33, 34, 39, 48, 50, 67, 105, 109], "vel": 57, "velavan": [39, 104], "veloc": [50, 58, 61, 63, 66, 71, 88, 89, 94, 105, 111, 114], "verbos": [3, 16, 26, 27, 28, 53, 102, 103, 108], "veri": [2, 3, 4, 12, 13, 15, 19, 23, 24, 27, 44, 45, 48, 79, 93, 103, 108], "verifi": 49, "verlag": [34, 104], "versa": 109, "version": [3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 67, 70, 71, 85, 99, 105, 109], "version_numb": 102, "versionad": 3, "versionchang": 3, "vert": [48, 109], "via": [3, 4, 26, 27, 28, 33, 43, 77, 98, 100, 102, 104, 105, 107], "vice": 109, "view": [4, 6, 14, 19, 30, 34, 39, 48, 50, 55, 108, 109, 114], "view1": 48, "view2": 48, "view3": 48, "viewer": 4, "viewpoint": 99, "vijai": 52, "vim": 3, "violin": 44, "violinplot": 44, "vir": 57, "viridi": 12, "virtual": [1, 3, 4, 93, 98], "virtualenvwrapp": 3, "visibl": [3, 14, 19], "visit": 104, "visual": [3, 4, 14, 15, 48, 96, 100, 105], "visualis": [7, 9, 10, 19, 22, 23, 24, 32, 33, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 50, 55, 99], "visualstudio": 100, "vlue": 30, "vmax": [42, 44], "vmd": [14, 34, 39, 53, 60, 67, 81, 84, 93, 95, 96, 105], "vmin": [42, 44], "volum": [15, 36, 40, 49, 52, 57], "volumetr": 6, "w": [10, 19, 20, 30, 33, 34, 37, 53, 66, 96, 103, 104, 111], "w477": [19, 20, 104], "w482": [19, 20, 104], "w568": 40, "w570": 40, "w_i": 13, "wa": [3, 4, 26, 50, 57, 71, 72, 83, 95, 102, 105, 106, 108, 109], "waal": [30, 60, 109, 114], "wai": [1, 3, 4, 7, 10, 12, 13, 14, 15, 16, 18, 19, 26, 27, 30, 33, 34, 48, 52, 53, 79, 98, 99, 103, 105, 106, 108, 109, 111, 114], "wait": [15, 102], "wall": 48, "wallac": [30, 104], "walt": [33, 104], "wang": [30, 52, 104], "want": [3, 4, 7, 9, 10, 15, 16, 18, 19, 21, 22, 23, 26, 30, 31, 36, 42, 43, 44, 48, 50, 52, 55, 96, 100, 108, 111], "ward": 46, "warn": [3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 50, 52, 53, 57, 61, 65, 81, 82, 89, 100, 101], "wat": [26, 30], "watch": 67, "water": [28, 36, 40, 49, 52, 55, 98, 105, 106, 112, 113], "water_acceptors_sel": 28, "water_for_ca60": 40, "water_hydrogens_sel": 28, "waterbridgeanalysi": 105, "waterdcd": [26, 49], "waterdynam": [3, 105], "waterpsf": [26, 49], "watson": 105, "watsoncrickdist": 105, "wb": 26, "we": [2, 3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 68, 82, 88, 96, 98, 99, 100, 101, 102, 105, 108, 109], "webserv": 4, "websit": [4, 15], "wed": 78, "weigh": 3, "weight": [15, 16, 26, 27, 30, 34, 38, 45, 46, 48, 65, 112], "weights_groupselect": 13, "weird": 108, "wel62": [14, 104], "welcom": [2, 3], "welford": [14, 104], "well": [1, 2, 4, 7, 15, 32, 33, 44, 48, 61, 67, 99, 101, 105, 108], "wenwei": [33, 104], "were": [4, 19, 28, 34, 67, 98, 102, 104, 105, 106, 108], "what": [3, 6, 30, 50, 53, 98, 101, 108, 109], "wheel": 105, "when": [3, 4, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 19, 22, 23, 24, 26, 27, 28, 30, 33, 34, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 57, 60, 61, 63, 66, 67, 79, 83, 87, 89, 99, 100, 101, 102, 103, 104, 105, 106, 108, 109, 111, 113, 114], "whenc": 95, "whenev": [4, 102, 108], "where": [1, 4, 5, 7, 9, 14, 15, 16, 19, 20, 21, 22, 27, 31, 32, 33, 36, 37, 38, 40, 43, 44, 46, 48, 50, 53, 57, 60, 61, 66, 71, 89, 98, 100, 102, 105, 106, 108, 109], "wherea": [13, 14, 33, 38, 39, 53, 103], "wherev": [87, 99], "whether": [1, 3, 9, 10, 14, 16, 34, 50, 114], "which": [1, 3, 4, 10, 12, 13, 14, 15, 16, 19, 20, 21, 26, 27, 28, 30, 31, 33, 34, 37, 38, 39, 40, 42, 43, 44, 46, 48, 50, 53, 55, 57, 60, 61, 67, 68, 83, 87, 89, 91, 94, 96, 98, 99, 100, 102, 103, 105, 106, 108, 109, 112, 114], "while": [3, 4, 5, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 26, 28, 30, 33, 34, 37, 38, 39, 42, 43, 44, 45, 46, 49, 52, 53, 80, 83, 84, 87, 98, 100, 102, 103, 106, 108, 111], "whilst": [15, 102, 105], "white": [48, 83], "whitespac": [4, 83], "whl": 102, "who": [3, 4, 7, 16, 101], "whole": [3, 42, 53, 55, 105, 108, 112], "wide": [3, 61], "widget": [4, 9, 10, 14, 19, 34, 39, 48, 50, 55, 100], "width": 83, "wiewiora": 52, "wiki": [67, 100], "wildcard": [30, 53, 106], "wildli": 83, "wilei": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 55, 104], "window": [3, 39, 43, 96, 100, 105], "window_s": 43, "window_step": 27, "wirefram": 48, "wise": [6, 7, 17, 23, 53], "wish": [26, 28, 52, 55, 79, 111, 114], "with_box": 111, "within": [1, 6, 7, 16, 17, 18, 19, 20, 22, 26, 28, 30, 36, 38, 40, 42, 43, 44, 45, 50, 53, 57, 60, 67, 77, 105, 106, 111, 112], "without": [3, 4, 13, 15, 28, 30, 34, 37, 50, 53, 61, 87, 99, 103, 104, 105, 106, 108, 109, 114], "wodak": [37, 104], "won": 4, "wonder": 14, "woolf": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 104], "word": [4, 37, 104], "work": [1, 2, 4, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 56, 57, 62, 67, 79, 96, 99, 100, 102, 104, 105, 106, 108, 111], "workaround": [89, 94], "worker": [15, 105], "worker_pool": 15, "workflow": [3, 4, 48, 108], "workon": 3, "workon_hom": 3, "workshop": 5, "worth": 108, "would": [3, 13, 15, 16, 19, 39, 43, 100, 101, 105, 106, 109], "wouter": [42, 43, 44, 45, 104], "wrap": [15, 48, 105, 109, 112], "wrapper": [30, 112], "wrapperclass": 16, "writabl": 89, "write": [4, 6, 7, 9, 11, 12, 14, 15, 17, 19, 20, 21, 22, 23, 24, 30, 34, 46, 48, 50, 52, 61, 62, 64, 68, 78, 90, 99, 105, 111, 113, 114], "write_next_timestep": 105, "writer": [4, 10, 53, 62, 64, 65, 66, 67, 68, 71, 73, 78, 79, 81, 82, 83, 89, 90, 94, 95, 96, 103, 105, 108, 111], "written": [3, 10, 53, 66, 71, 76, 79, 81, 83, 84, 87, 89, 93, 96, 103, 105], "wrong": [67, 105, 114], "www": [3, 4, 19, 20, 30, 34, 37, 99, 104], "x": [0, 3, 4, 12, 13, 14, 15, 16, 18, 19, 20, 21, 30, 31, 34, 44, 48, 49, 50, 53, 56, 57, 66, 67, 81, 82, 83, 87, 95, 104, 105, 106, 112], "x3dna": 105, "x86_64": [3, 100, 105], "xdist": [3, 100, 105, 108], "xdr": [89, 94], "xdrlib": [3, 105], "xfail": [100, 108], "xhgchen": 105, "xlabel": [12, 14, 15, 16, 18, 23, 24, 26, 27, 30, 31, 34, 36, 37, 38, 39, 40, 48, 53, 57], "xml": [59, 61, 97, 109], "xpdb": [58, 59, 61, 97, 109], "xplor": [59, 61, 97], "xtc": [36, 37, 40, 42, 44, 45, 46, 48, 53, 55, 58, 59, 61, 98, 103, 105, 112, 114], "xtcreader": 94, "xtcwriter": 94, "xtick": [42, 44, 45], "xvg_bz2": 57, "xvgfileread": 57, "xvgreader": 57, "xx": 57, "xxx": 87, "xy": [26, 48, 57], "xyz": [10, 50, 53, 58, 59, 61, 73, 91, 97, 98, 103, 109], "xyzpars": 95, "xyzplugin": 95, "xyzread": 95, "xyzwrit": 95, "xz": 57, "y": [3, 12, 13, 15, 16, 19, 20, 34, 48, 49, 50, 57, 66, 81, 82, 83, 95, 106], "yaml": [102, 108], "yank": 102, "yasp": [58, 59, 61], "ye": [87, 104], "yellow": 50, "yet": [3, 108], "yield": [31, 34, 105], "ylabel": [12, 14, 15, 16, 19, 20, 21, 22, 23, 24, 26, 27, 30, 31, 34, 36, 37, 38, 39, 40, 48, 57], "yml": [4, 108], "yn": 106, "ynamic": 104, "york": [34, 104], "you": [1, 2, 3, 4, 5, 6, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 26, 27, 30, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 60, 61, 62, 64, 67, 78, 79, 80, 89, 96, 98, 99, 100, 101, 102, 103, 104, 106, 108, 109, 110, 111, 112, 114], "your": [2, 4, 5, 6, 7, 10, 13, 15, 17, 19, 20, 21, 22, 26, 27, 30, 32, 34, 36, 37, 40, 42, 43, 44, 45, 46, 48, 49, 50, 53, 55, 60, 61, 67, 75, 84, 87, 99, 100, 103, 104, 105, 108, 111, 112], "yourmodul": 104, "yourscript": 104, "yourself": [4, 7, 30, 37, 45, 48], "ython": 104, "ytick": [42, 44, 45], "yutong": 52, "yx": 57, "yy": 57, "yz": 57, "z": [3, 15, 16, 26, 33, 39, 48, 50, 57, 66, 81, 82, 83, 95, 104, 106, 112], "zenodo": 5, "zero": [12, 16, 24, 30, 50, 60, 92], "zeta": 30, "zhao": 52, "zheng": [33, 104], "ziolek": [26, 27, 28], "zip": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 104], "zip_data_with_label": 44, "zlabel": 30, "zmax": 106, "zmin": 106, "zone": 106, "zorder": [14, 22], "zpo": 26, "ztimol": 105, "zx": 57, "zy": 57, "zz": 57, "\u00e5": [15, 16, 19, 26, 28, 38, 48, 53, 67, 83, 113], "\u00e5ngstr\u00f6m": [19, 38, 53, 68, 79, 113], "\u03bc": 113, "\u03c8": [37, 104], "\u03d5": [37, 104]}, "titles": ["Advanced topology concepts", "AtomGroup", "Contributing to MDAnalysis", "Contributing to the main codebase", "Contributing to the user guide", "Example data", "Examples", "Analysis", "Alignments and RMS fitting", "Aligning a structure to another", "Aligning a trajectory to a reference", "Aligning a trajectory to itself", "Calculating the pairwise RMSD of a trajectory", "Calculating the root mean square deviation of atomic structures", "Calculating the root mean square fluctuation over a trajectory", "Parallelizing analysis", "Writing your own trajectory analysis", "Distances and contacts", "Write your own native contacts analysis method", "Fraction of native contacts over a trajectory", "Q1 vs Q2 contact analysis", "Contact analysis: number of contacts within a cutoff", "Atom-wise distances between matching AtomGroups", "All distances between two selections", "All distances within a selection", "Hydrogen Bond Analysis", "Calculating hydrogen bonds: the basics", "Calculating hydrogen bond lifetimes", "Calculating hydrogen bonds: advanced selections", "Polymers and membranes", "Analysing pore dimensions with HOLE2", "Determining the persistence length of a polymer", "Dimension reduction", "Non-linear dimension reduction to diffusion maps", "Principal component analysis of a trajectory", "Structure", "Average radial distribution functions", "Protein dihedral angle analysis", "Elastic network analysis", "Helix analysis", "Calculating the RDF atom-to-atom", "Trajectory similarity", "Calculating the Clustering Ensemble Similarity between ensembles", "Evaluating convergence", "Calculating the Dimension Reduction Ensemble Similarity between ensembles", "Calculating the Harmonic Ensemble Similarity between ensembles", "Comparing the geometric similarity of trajectories", "Volumetric analyses", "Calculating the solvent density around a protein", "Computing mass and charge density on each axis", "Constructing, modifying, and adding to a Universe", "Other", "Using ParmEd with MDAnalysis and OpenMM to simulate a selection of atoms", "Quick start guide", "Transformations", "Centering a trajectory in the box", "Frequently asked questions", "Auxiliary files", "Coordinates", "Format reference", "Guessing", "Format overview", "chemfiles (chemfiles Trajectory or file)", "CONFIG (DL_Poly Config)", "COOR, NAMBDIN (NAMD binary restart files)", "CRD (CHARMM CARD files)", "DATA (LAMMPS)", "DCD (CHARMM, NAMD, or LAMMPS trajectory)", "DCD (Flexible LAMMPS trajectory)", "DMS (Desmond Molecular Structure files)", "GMS (Gamess trajectory)", "GRO (GROMACS structure file)", "GSD (HOOMD GSD file)", "IN, FHIAIMS (FHI-aims input files)", "INPCRD, RESTRT (AMBER restart files)", "ITP (GROMACS portable topology files)", "LAMMPSDUMP (LAMMPS ascii dump file)", "MMTF (Macromolecular Transmission Format)", "MOL2 (Tripos structure)", "NCDF, NC (AMBER NetCDF trajectory)", "ParmEd (ParmEd Structure)", "PDB, ENT (Standard PDB file)", "PDBQT (Autodock structure)", "PQR file (PDB2PQR / APBS)", "PSF (CHARMM, NAMD, or XPLOR protein structure file)", "TNG (Trajectory Next Generation)", "TOP, PRMTOP, PARM7 (AMBER topology)", "TPR (GROMACS run topology files)", "TRJ, MDCRD, CRDBOX (AMBER ASCII trajectory)", "TRR (GROMACS lossless trajectory file)", "TRZ (IBIsCO and YASP trajectory)", "TXYZ, ARC (Tinker)", "XML (HOOMD)", "XPDB (Extended PDB file)", "XTC (GROMACS compressed trajectory file)", "XYZ trajectory", "Selection exporters", "Topology", "Groups of atoms", "Welcome to MDAnalysis User Guide\u2019s documentation!", "Installation", "Module imports in MDAnalysis", "Preparing a release", "Reading and writing files", "References", "MDAnalysis Release Notes", "Atom selection language", "Standard residues in MDAnalysis selections", "Tests in MDAnalysis", "The topology system", "Slicing trajectories", "Trajectories", "On-the-fly transformations", "Units and constants", "Universe"], "titleterms": {"": 99, "0": 105, "1": [16, 105], "2": [16, 105], "2d": 48, "3": 105, "3d": 48, "4": 105, "5": 105, "6": 105, "7": 105, "IN": 73, "In": 103, "On": [3, 4, 112], "The": [40, 109], "With": 3, "__init__": 16, "_single_fram": 16, "abstract": 3, "access": [26, 57], "acid": 107, "acknowledg": 50, "action": 108, "ad": [0, 3, 4, 50, 109], "addit": 100, "advanc": [0, 4, 28], "aim": 73, "align": [7, 8, 9, 10, 11, 14, 46, 48], "alignto": 9, "aligntraj": 10, "all": [23, 24, 27, 28, 55, 61], "also": 15, "amber": [74, 79, 86, 88], "an": [1, 13, 14, 16, 30, 103, 109], "analys": [7, 15, 30, 47, 48], "analysi": [6, 7, 15, 16, 18, 19, 20, 21, 25, 26, 34, 37, 38, 39, 42, 44, 53, 101, 108], "angl": [37, 60, 87], "anoth": 9, "apb": 83, "appli": 15, "approach": 15, "arc": 91, "argument": [43, 57], "around": 48, "arrai": 23, "ascii": [76, 88], "ask": 56, "assert": 108, "atom": [1, 13, 22, 23, 24, 28, 31, 36, 37, 40, 52, 53, 56, 81, 98, 103, 106], "atomgroup": [1, 13, 22, 53, 96, 109, 114], "attribut": [50, 57, 61, 86, 97, 109, 114], "autodock": 82, "automat": [4, 53], "auxiliari": 57, "averag": [14, 36, 48], "axi": 49, "azur": 108, "b": 14, "back": 55, "backbon": [31, 107], "background": [12, 13, 14, 15, 18, 19, 20, 21, 30], "base": [3, 57, 113], "basic": 26, "befor": 55, "between": [12, 13, 22, 23, 28, 42, 44, 45, 52], "binari": 64, "blank": 50, "block": 15, "blog": 102, "bond": [7, 25, 26, 27, 28, 50, 60, 87], "boolean": 106, "boundari": 22, "box": 55, "branch": [3, 102], "bridg": 18, "bug": 105, "build": [3, 4, 102, 103], "ca": 22, "calcul": [12, 13, 14, 20, 21, 22, 23, 24, 26, 27, 28, 31, 36, 37, 40, 42, 44, 45, 48], "canon": 109, "card": 65, "case": 98, "center": [48, 55], "chain": 31, "chainid": 87, "chang": [3, 4, 56, 105], "charg": [49, 113], "charmm": [65, 67, 84], "chemfil": 62, "choos": 31, "ci": [102, 108], "cirru": [102, 108], "citat": [53, 104], "class": [3, 16], "clean": 102, "clone": 4, "close": 38, "cluster": [42, 43], "code": [3, 101], "codebas": 3, "codecov": 108, "combin": 15, "commit": [3, 4], "commun": 99, "compar": [43, 46], "compil": 100, "complet": 102, "complianc": 3, "compon": 34, "compress": 94, "comput": 49, "concept": 0, "conda": [3, 100, 102], "condit": 22, "config": 63, "connect": [106, 109], "constant": [27, 113], "construct": [1, 50, 114], "contact": [7, 17, 18, 19, 20, 21, 38], "content": 34, "continu": 108, "contribut": [2, 3, 4, 16], "contributor": 105, "control": 2, "convent": 108, "converg": [34, 43], "convers": 113, "coor": 64, "coordin": [10, 13, 23, 53, 58, 61], "copi": 10, "core": 101, "cosin": 34, "coverag": 108, "crd": 65, "crdbox": 88, "creat": [1, 3, 4, 14, 16, 28, 50, 52, 87, 102, 109, 114], "cryst1": 81, "custom": [0, 13, 100, 112], "cutoff": [19, 21], "cython": 3, "czi": 105, "darker": 3, "dask": 15, "data": [5, 13, 26, 30, 57, 66, 108], "dataset": 100, "dcd": [67, 68], "default": [42, 43, 44, 109], "defin": [16, 18, 19, 21], "delet": [30, 109], "densiti": [40, 48, 49, 113], "depend": [3, 7, 101], "deprec": 105, "desmond": 69, "determin": 31, "develop": [3, 4, 86, 87, 89, 91, 100, 102], "deviat": 13, "differ": [42, 43, 44, 52, 108], "diffus": 33, "dihedr": [37, 60, 87], "dimens": [7, 30, 32, 33, 43, 44], "dimension": [34, 43], "directli": 57, "directori": 108, "discret": 46, "distanc": [7, 17, 22, 23, 24, 46], "distribut": [36, 40], "dl_poli": 63, "dm": 69, "do": [55, 56], "doc": 3, "docstr": 3, "document": [3, 4, 99, 102], "duecredit": [53, 104], "dump": 76, "dynam": [1, 53, 106], "each": [24, 49], "edit": 4, "edr": 57, "elast": 38, "empti": 1, "enchanc": 105, "energi": 113, "enhanc": 105, "ensembl": [42, 43, 44, 45], "ensur": 3, "ent": 81, "entri": 87, "environ": [3, 4], "eoss": 105, "error": [42, 44], "estim": [42, 44], "evalu": 43, "exampl": [5, 6, 112], "except": 108, "export": 96, "extend": 93, "extens": 82, "factor": 14, "fail": 108, "failur": 105, "fashion": 15, "fhi": 73, "fhiaim": 73, "field": 81, "file": [4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 55, 57, 62, 64, 65, 69, 71, 72, 73, 74, 75, 76, 81, 83, 84, 87, 89, 93, 94, 102, 103, 108, 114], "find": [26, 27, 28], "first": 11, "fit": [7, 8], "fix": 105, "fixtur": 108, "flag": 100, "flexibl": 68, "fluctuat": 14, "fly": [48, 55, 112], "forc": 113, "forg": [3, 102], "fork": [3, 4], "form": 15, "format": [3, 57, 59, 61, 77, 82, 87, 103, 109], "fraction": 19, "fragment": 98, "frame": [11, 15, 53, 57, 103], "frequent": 56, "from": [1, 16, 53, 86, 109, 114], "fr\u00e9chet": 46, "function": [15, 16, 18, 26, 36, 40, 108], "further": 26, "gamess": 70, "gaussian": 38, "gener": [6, 46, 85, 87, 101, 108], "geometr": [46, 106], "get": [2, 53, 102], "gh": 4, "git": 2, "github": [2, 3, 108], "gm": 70, "gro": 71, "gromac": [71, 75, 87, 89, 94], "group": [1, 19, 21, 28, 36, 37, 53, 98], "groupbi": 1, "gsd": 72, "guess": [60, 114], "guess_acceptor": 28, "guess_hydrogen": 28, "guid": [4, 53, 99], "guidelin": 3, "gyrat": [15, 16], "handl": 57, "hard": 19, "harmon": 45, "hausdorff": 46, "heatmap": 23, "helix": 39, "helper": 26, "hetatm": 81, "histori": 63, "hole": 30, "hole2": [4, 30], "hook": 4, "hoomd": [72, 92], "hydrogen": [7, 25, 26, 27, 28], "ibisco": 90, "imag": 48, "import": [7, 101, 108], "improp": [60, 87], "improv": 105, "increment": 102, "index": [1, 106], "individu": 27, "inform": [53, 58, 61, 109], "inpcrd": 74, "input": [73, 103, 108], "instal": 100, "integr": 108, "interact": [3, 48], "intermitt": 27, "issu": 105, "iter": 57, "itp": 75, "itself": [11, 12, 36], "janin": 37, "jupyt": 4, "keyword": [86, 106], "known": 105, "lammp": [66, 67, 68, 76], "lammpsdump": 76, "languag": [1, 106], "larger": 50, "length": [31, 113], "level": 109, "lifetim": 27, "linear": 33, "list": [98, 101], "load": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 57, 114], "lossless": 89, "mac": 3, "macromolecular": 77, "main": 3, "major": 105, "make": 48, "mamba": 3, "mandatori": 3, "manual": 102, "map": 33, "mass": [13, 49, 60], "match": [22, 23], "matplotlib": 48, "mdanalysi": [2, 3, 16, 52, 61, 87, 99, 101, 105, 107, 108, 113], "mdanalysisdata": 5, "mdanalysistest": 5, "mdcrd": 88, "mean": [13, 14], "measur": [34, 43], "membran": [7, 29], "memori": [57, 103], "merg": 50, "method": [1, 16, 18, 42, 43, 44, 46, 53, 109, 114], "mmtf": 77, "model": 38, "modifi": [50, 106, 109], "modul": [3, 101, 108], "mol2": 78, "molecul": [0, 48], "molecular": 69, "more": 28, "multipl": [13, 15, 19, 42, 44, 96, 103], "multiprocess": 15, "nambdin": 64, "namd": [64, 67, 84], "nativ": [18, 19], "nbval": 4, "nc": 79, "ncdf": 79, "netcdf": 79, "network": 38, "new": [3, 4, 10, 50, 105, 108], "next": [85, 102], "nglview": 48, "non": [23, 33], "note": [86, 87, 89, 91, 95, 105], "notebook": 4, "nucleic": 107, "nucleobas": 107, "number": [21, 102], "object": 109, "old": 102, "one": [42, 44], "onli": 38, "openmm": 52, "oper": 1, "optimis": 100, "option": [3, 4, 101], "order": [1, 30, 106], "other": [15, 16, 51], "out": [42, 44, 53, 65, 66, 67, 71, 79, 81, 82, 83, 89], "outlin": 102, "output": 103, "over": [14, 19, 56, 57], "overview": [4, 53, 61], "own": [16, 18], "packag": [3, 102], "page": 4, "pairwis": 12, "parallel": [15, 108], "paramet": [30, 42, 44], "parm": [52, 80], "parm7": 86, "pars": [86, 87], "parser": [61, 97], "particip": 99, "pass": 57, "path": 46, "pdb": [30, 81, 82, 93], "pdb2pqr": 83, "pdbqt": 82, "pep8": 3, "per": 15, "perform": 105, "period": 22, "persist": 31, "pickl": 103, "pip": [3, 100], "plot": [13, 14, 18, 19, 20, 21, 22, 23, 24, 30, 37, 42, 44, 45, 46, 48], "polici": 102, "polym": [7, 29, 31], "popul": 50, "pore": 30, "portabl": 75, "posit": [50, 53, 56], "possibl": 15, "post": 102, "pqr": 83, "pre": 4, "preexist": 106, "prepar": 102, "preview": 4, "princip": 34, "prmtop": 86, "profil": 30, "project": 34, "properti": 114, "protein": [37, 48, 50, 55, 84, 107], "psf": 84, "pull": 3, "push": 3, "pytest": 4, "python": 3, "pyvista": 48, "q1": 20, "q2": 20, "question": 56, "quick": 53, "radial": [36, 40], "radiu": [15, 16, 19], "ramachandran": 37, "rdf": 40, "read": [57, 58, 61, 65, 66, 67, 70, 71, 72, 76, 79, 81, 82, 83, 84, 85, 87, 88, 89, 94, 95, 96, 97, 103], "reader": [58, 61], "readi": 102, "rebas": 3, "recreat": 57, "reduc": 34, "reduct": [7, 32, 33, 43, 44], "refer": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 59, 104], "releas": [102, 105], "request": 3, "residu": [0, 23, 24, 98, 107], "restart": [64, 74], "restrt": 74, "restructuredtext": 4, "result": [15, 26], "rm": [7, 8], "rmsd": [12, 13, 53], "rmsf": 14, "root": [13, 14], "rule": 101, "run": [39, 87, 108], "salt": 18, "same": 108, "sanit": 4, "scikit": 48, "scratch": 114, "see": 15, "segid": 87, "segment": [0, 50, 98], "select": [1, 13, 23, 24, 28, 37, 52, 53, 57, 96, 103, 106, 107], "sequenc": 98, "serial": 15, "set": [1, 13, 42, 44], "similar": [7, 41, 42, 43, 44, 45, 46, 106], "simpl": [15, 106], "simul": 52, "singl": [19, 53, 96], "site": 40, "skip": 108, "slice": [1, 110], "soft": 19, "solvent": [48, 55], "space": 34, "specif": [28, 40, 78, 81, 82, 83, 84, 86, 87, 95, 109], "speed": 113, "split": [1, 15], "squar": [13, 14], "standalon": 57, "standard": [81, 107], "start": [2, 53], "static": 48, "step": 4, "store": 26, "structur": [7, 9, 13, 14, 35, 53, 69, 71, 78, 80, 82, 84], "sugar": 107, "suit": [101, 108], "summari": 102, "support": [57, 58, 61, 87, 96, 97], "surfac": [30, 48], "system": [52, 109], "tabl": [58, 61, 97], "task": 102, "temporari": [102, 108], "test": [3, 4, 100, 101, 105, 108], "thi": 55, "third": 11, "tile": 50, "time": [27, 113], "tinker": 91, "tip": 4, "tng": 85, "tool": 108, "top": 86, "topologi": [0, 50, 61, 75, 86, 87, 97, 109, 114], "topologyattr": [0, 109], "tpr": 87, "tprparser": 87, "trajectori": [7, 10, 11, 12, 13, 14, 15, 16, 19, 30, 34, 41, 46, 53, 55, 56, 57, 62, 67, 68, 70, 79, 85, 88, 89, 90, 94, 95, 103, 110, 111], "transfer": 103, "transform": [16, 48, 54, 55, 112], "transmiss": 77, "triangul": 48, "tripo": 78, "trj": 88, "trr": 89, "try": [42, 44], "trz": 90, "two": [12, 13, 23, 36], "txyz": 91, "type": 60, "typic": 102, "uniqu": 1, "unit": [57, 113], "univers": [0, 10, 13, 50, 57, 109, 114], "unwrap": 55, "up": 102, "updat": [1, 102], "upload": 102, "us": [4, 28, 30, 38, 43, 52, 57, 87, 98, 104, 108], "usag": 57, "user": [4, 99], "userguid": [4, 102], "v": 20, "valu": 109, "version": [2, 87, 100, 102], "view": 3, "virtualenv": 3, "visual": [101, 108], "visualis": [14, 30, 34, 48], "vmd": 30, "volumetr": [7, 47], "warn": 108, "water": [26, 48, 50], "weight": 13, "welcom": 99, "what": 4, "wheel": 102, "where": [2, 3], "whole": 48, "why": [56, 99], "wise": [15, 22, 24], "within": [21, 24], "without": 40, "work": [3, 30, 53], "workflow": [102, 112], "wrap": 55, "write": [3, 10, 16, 18, 53, 65, 66, 67, 71, 79, 81, 82, 83, 89, 96, 103, 108], "xml": 92, "xpdb": 93, "xplor": 84, "xtc": 94, "xvg": 57, "xyz": 95, "yasp": 90, "your": [3, 16, 18]}})
\ No newline at end of file
+Search.setIndex({"alltitles": {"1. Define __init__": [[16, "1.-Define-__init__"]], "2. Define your analysis in _single_frame() and other methods": [[16, "2.-Define-your-analysis-in-_single_frame()-and-other-methods"]], "2D averaging": [[48, "2D-averaging"]], "AMBER specification": [[86, "amber-specification"]], "ATOM/HETATM fields": [[81, "id2"]], "Accessing auxiliary attributes": [[57, "accessing-auxiliary-attributes"]], "Accessing the results": [[26, "Accessing-the-results"]], "Acknowledgments": [[50, "Acknowledgments"]], "Adding TopologyAttrs": [[109, "adding-topologyattrs"]], "Adding a Residue or Segment to a Universe": [[0, "adding-a-residue-or-segment-to-a-universe"]], "Adding a new segment": [[50, "Adding-a-new-segment"]], "Adding bonds": [[50, "Adding-bonds"]], "Adding changes to the UserGuide": [[4, "adding-changes-to-the-userguide"]], "Adding custom TopologyAttrs": [[0, "adding-custom-topologyattrs"]], "Adding new documentation": [[4, "adding-new-documentation"]], "Adding positions": [[50, "Adding-positions"]], "Adding to a Universe": [[109, "adding-to-a-universe"]], "Adding topology attributes": [[50, "Adding-topology-attributes"]], "Adding your code to MDAnalysis": [[3, "adding-your-code-to-mdanalysis"]], "Adding your documentation to MDAnalysis": [[3, "adding-your-documentation-to-mdanalysis"]], "Additional datasets": [[100, "additional-datasets"]], "Advanced preview with gh-pages": [[4, "advanced-preview-with-gh-pages"]], "Advanced topology concepts": [[0, null]], "Aligning a structure to another": [[9, null]], "Aligning a structure with align.alignto": [[9, "Aligning-a-structure-with-align.alignto"]], "Aligning a trajectory to a reference": [[10, null]], "Aligning a trajectory to itself": [[11, null]], "Aligning a trajectory to the first frame": [[11, "Aligning-a-trajectory-to-the-first-frame"]], "Aligning a trajectory to the third frame": [[11, "Aligning-a-trajectory-to-the-third-frame"]], "Aligning a trajectory with AlignTraj": [[10, "Aligning-a-trajectory-with-AlignTraj"]], "Aligning the trajectory to a reference": [[14, "Aligning-the-trajectory-to-a-reference"]], "Aligning trajectories": [[46, "Aligning-trajectories"]], "Alignments and RMS fitting": [[7, "alignments-and-rms-fitting"], [8, null]], "All distances between two selections": [[23, null]], "All distances within a selection": [[24, null]], "Analysing pore dimensions with HOLE2": [[30, null]], "Analysing the density of water around the protein": [[48, "Analysing-the-density-of-water-around-the-protein"]], "Analysis": [[6, null], [7, null], [53, "Analysis"]], "Apply the analysis per block": [[15, "Apply-the-analysis-per-block"]], "Assertions": [[108, "assertions"]], "Atom selection language": [[1, "atom-selection-language"], [106, null]], "Atom-wise distances between matching AtomGroups": [[22, null]], "AtomGroup": [[1, null]], "AtomGroup positions and methods": [[53, "AtomGroup-positions-and-methods"]], "Attributes parsed from AMBER keywords": [[86, "id1"]], "Automatic citations with duecredit": [[53, "Automatic-citations-with-duecredit"]], "Automatically building documentation": [[4, "automatically-building-documentation"]], "Auxiliary files": [[57, null]], "Average radial distribution functions": [[36, null]], "Azure": [[108, "azure"]], "Background": [[12, "Background"], [13, "Background"], [14, "Background"], [15, "Background"], [18, "Background"], [19, "Background"], [20, "Background"], [21, "Background"], [30, "Background"]], "Base units in MDAnalysis": [[113, "id1"]], "Before transformation": [[55, "Before-transformation"]], "Block analysis function": [[15, "Block-analysis-function"]], "Bonds": [[87, "bonds"]], "Bonds, Angles, Dihedrals, Impropers": [[60, "bonds-angles-dihedrals-impropers"]], "Boolean": [[106, "boolean"]], "Branches in MDAnalysis": [[3, "branches-in-mdanalysis"]], "Bug fixes": [[105, "bug-fixes"], [105, "id12"], [105, "id13"]], "Bug fixes and changes": [[105, "bug-fixes-and-changes"]], "Building MDAnalysis": [[3, "building-mdanalysis"]], "Building the documentation": [[3, "building-the-documentation"]], "Building the user guide": [[4, "building-the-user-guide"]], "Building trajectories in memory": [[103, "building-trajectories-in-memory"]], "CONFIG (DL_Poly Config)": [[63, null]], "COOR, NAMBDIN (NAMD binary restart files)": [[64, null]], "CRD (CHARMM CARD files)": [[65, null]], "CRYST1 fields": [[81, "id1"]], "CZI EOSS Performance Improvements:": [[105, "czi-eoss-performance-improvements"]], "Calculate hydrogen bond lifetimes": [[27, "Calculate-hydrogen-bond-lifetimes"]], "Calculating Q1 vs Q2": [[20, "Calculating-Q1-vs-Q2"]], "Calculating RMSF": [[14, "Calculating-RMSF"]], "Calculating atom-to-atom distances between non-matching coordinate arrays": [[23, "Calculating-atom-to-atom-distances-between-non-matching-coordinate-arrays"]], "Calculating atom-wise distances": [[24, "Calculating-atom-wise-distances"]], "Calculating clustering similarity with default settings": [[42, "Calculating-clustering-similarity-with-default-settings"]], "Calculating clustering similarity with multiple methods": [[42, "Calculating-clustering-similarity-with-multiple-methods"]], "Calculating clustering similarity with one method": [[42, "Calculating-clustering-similarity-with-one-method"]], "Calculating dihedral angles": [[37, "Calculating-dihedral-angles"]], "Calculating dimension reduction similarity with default settings": [[44, "Calculating-dimension-reduction-similarity-with-default-settings"]], "Calculating dimension reduction similarity with multiple methods": [[44, "Calculating-dimension-reduction-similarity-with-multiple-methods"]], "Calculating dimension reduction similarity with one method": [[44, "Calculating-dimension-reduction-similarity-with-one-method"]], "Calculating distances for each residue": [[24, "Calculating-distances-for-each-residue"]], "Calculating harmonic similarity": [[45, "Calculating-harmonic-similarity"]], "Calculating hydrogen bond lifetimes": [[27, null]], "Calculating hydrogen bonds: advanced selections": [[28, null]], "Calculating hydrogen bonds: the basics": [[26, null]], "Calculating number of contacts within a cutoff": [[21, "Calculating-number-of-contacts-within-a-cutoff"]], "Calculating residue-to-residue distances": [[23, "Calculating-residue-to-residue-distances"]], "Calculating the Clustering Ensemble Similarity between ensembles": [[42, null]], "Calculating the Dimension Reduction Ensemble Similarity between ensembles": [[44, null]], "Calculating the Harmonic Ensemble Similarity between ensembles": [[45, null]], "Calculating the RDF atom-to-atom": [[40, null]], "Calculating the average radial distribution function for a group of atoms to itself": [[36, "Calculating-the-average-radial-distribution-function-for-a-group-of-atoms-to-itself"]], "Calculating the average radial distribution function for two groups of atoms": [[36, "Calculating-the-average-radial-distribution-function-for-two-groups-of-atoms"]], "Calculating the distance between CA atoms": [[22, "Calculating-the-distance-between-CA-atoms"]], "Calculating the distance with periodic boundary conditions": [[22, "Calculating-the-distance-with-periodic-boundary-conditions"]], "Calculating the pairwise RMSD of a trajectory": [[12, null]], "Calculating the persistence length": [[31, "Calculating-the-persistence-length"]], "Calculating the root mean square deviation of atomic structures": [[13, null]], "Calculating the root mean square fluctuation over a trajectory": [[14, null]], "Calculating the site-specific radial distribution function": [[40, "Calculating-the-site-specific-radial-distribution-function"]], "Calculating the solvent density around a protein": [[48, null]], "Calculating the time constant": [[27, "Calculating-the-time-constant"]], "Canonical attributes": [[109, "canonical-attributes"]], "Centering a trajectory in the box": [[55, null]], "Centering in the box": [[55, "Centering-in-the-box"]], "Centering, aligning, and making molecules whole with on-the-fly transformations": [[48, "Centering,-aligning,-and-making-molecules-whole-with-on-the-fly-transformations"]], "Changes:": [[105, "changes"], [105, "id5"], [105, "id10"], [105, "id17"], [105, "id23"], [105, "id28"], [105, "id33"], [105, "id39"]], "Charge": [[113, "charge"]], "Choosing the chains and backbone atoms": [[31, "Choosing-the-chains-and-backbone-atoms"]], "Cirrus CI": [[108, "cirrus-ci"]], "Citations using Duecredit": [[104, "citations-using-duecredit"]], "Clean up old developer builds of the documentation": [[102, "clean-up-old-developer-builds-of-the-documentation"]], "Code formatting in Python": [[3, "code-formatting-in-python"]], "Codecov": [[108, "codecov"]], "Combine the results": [[15, "Combine-the-results"]], "Committing your code": [[3, "committing-your-code"]], "Communications": [[99, "communications"]], "Comparing different clustering methods": [[43, "Comparing-different-clustering-methods"]], "Comparing different dimensionality reduction methods": [[43, "Comparing-different-dimensionality-reduction-methods"]], "Comparing the geometric similarity of trajectories": [[46, null]], "Completing the release": [[102, "completing-the-release"]], "Computing mass and charge density on each axis": [[49, null]], "Connectivity information": [[109, "connectivity-information"]], "Constants": [[113, "constants"]], "Constructing from AtomGroups": [[114, "constructing-from-atomgroups"]], "Constructing from Atoms": [[1, "constructing-from-atoms"]], "Constructing from scratch": [[114, "constructing-from-scratch"]], "Constructing, modifying, and adding to a Universe": [[50, null]], "Contact analysis: number of contacts within a cutoff": [[21, null]], "Continuous Integration tools": [[108, "continuous-integration-tools"]], "Contributing to MDAnalysis": [[2, null], [16, "Contributing-to-MDAnalysis"]], "Contributing to the main codebase": [[3, null]], "Contributing to the user guide": [[4, null]], "Coordinates": [[58, null], [61, "coordinates"]], "Copying coordinates into a new Universe": [[10, "Copying-coordinates-into-a-new-Universe"]], "Create a blog post outlining the release": [[102, "create-a-blog-post-outlining-the-release"]], "Create a release of the UserGuide": [[102, "create-a-release-of-the-userguide"]], "Creating a Universe": [[114, "creating-a-universe"]], "Creating a blank Universe": [[50, "Creating-a-blank-Universe"]], "Creating a branch": [[3, "creating-a-branch"]], "Creating a development environment": [[3, "creating-a-development-environment"], [4, "creating-a-development-environment"]], "Creating a pull request": [[3, "creating-a-pull-request"]], "Creating an AtomGroup": [[1, "creating-an-atomgroup"]], "Creating an analysis from a function": [[16, "Creating-an-analysis-from-a-function"]], "Creating an average structure": [[14, "Creating-an-average-structure"]], "Creating and populating a Universe with water": [[50, "Creating-and-populating-a-Universe-with-water"]], "Creating with an AtomGroup": [[109, "creating-with-an-atomgroup"]], "Creating your own class": [[16, "Creating-your-own-class"]], "Custom compiler flags and optimised installations": [[100, "custom-compiler-flags-and-optimised-installations"]], "Custom transformations": [[112, "custom-transformations"]], "Custom weights": [[13, "Custom-weights"]], "DATA (LAMMPS)": [[66, null]], "DCD (CHARMM, NAMD, or LAMMPS trajectory)": [[67, null]], "DCD (Flexible LAMMPS trajectory)": [[68, null]], "DMS (Desmond Molecular Structure files)": [[69, null]], "Default values and attribute levels": [[109, "default-values-and-attribute-levels"]], "Define your own function": [[18, "Define-your-own-function"]], "Defining salt bridges": [[18, "Defining-salt-bridges"]], "Defining the groups for contact analysis": [[19, "Defining-the-groups-for-contact-analysis"], [21, "Defining-the-groups-for-contact-analysis"]], "Deleting HOLE files": [[30, "Deleting-HOLE-files"]], "Deleting from a Universe": [[109, "deleting-from-a-universe"]], "Density": [[113, "density"]], "Deprecations:": [[105, "deprecations"], [105, "id6"], [105, "id18"], [105, "id24"], [105, "id29"], [105, "id34"], [105, "id40"]], "Determining the persistence length of a polymer": [[31, null]], "Developer notes": [[86, "developer-notes"], [87, "developer-notes"], [89, "developer-notes"], [91, "developer-notes"]], "Developing in Cython": [[3, "developing-in-cython"]], "Development versions": [[100, "development-versions"]], "Diffusion maps": [[33, "Diffusion-maps"]], "Dimension reduction": [[7, "dimension-reduction"], [32, null]], "Discrete Fr\u00e9chet distances": [[46, "Discrete-Fr\u00e9chet-distances"]], "Distances and contacts": [[7, "distances-and-contacts"], [17, null]], "Documenting changes": [[3, "documenting-changes"]], "Documenting your code": [[3, "documenting-your-code"]], "Doing all this on-the-fly": [[55, "Doing-all-this-on-the-fly"]], "Dynamic selection": [[53, "Dynamic-selection"]], "Dynamic selections": [[106, "dynamic-selections"]], "Dynamically updating AtomGroups": [[1, "dynamically-updating-atomgroups"]], "EDR Files": [[57, "edr-files"]], "Elastic network analysis": [[38, null]], "Empty AtomGroups": [[1, "empty-atomgroups"]], "Enchancements:": [[105, "enchancements"], [105, "id16"]], "Energy": [[113, "energy"]], "Enhancements:": [[105, "enhancements"], [105, "id4"], [105, "id22"], [105, "id26"], [105, "id31"], [105, "id37"]], "Ensure PEP8 compliance (mandatory) and format your code with Darker (optional)": [[3, "ensure-pep8-compliance-mandatory-and-format-your-code-with-darker-optional"]], "Estimating the error in a clustering ensemble similarity analysis": [[42, "Estimating-the-error-in-a-clustering-ensemble-similarity-analysis"]], "Estimating the error in a dimension reduction ensemble similarity analysis": [[44, "Estimating-the-error-in-a-dimension-reduction-ensemble-similarity-analysis"]], "Evaluating convergence": [[43, null]], "Evaluating convergence with similarity measures": [[43, "Evaluating-convergence-with-similarity-measures"]], "Example data": [[5, null]], "Example workflows": [[112, "example-workflows"]], "Examples": [[6, null]], "Failing tests": [[108, "failing-tests"]], "Find all hydrogen bonds": [[27, "Find-all-hydrogen-bonds"], [28, "Find-all-hydrogen-bonds"]], "Find water-water hydrogen bonds": [[26, "Find-water-water-hydrogen-bonds"]], "Fixes:": [[105, "fixes"], [105, "id3"], [105, "id9"], [105, "id15"], [105, "id21"], [105, "id27"], [105, "id32"], [105, "id38"]], "Fixtures": [[108, "fixtures"]], "Force": [[113, "force"]], "Forking": [[3, "forking"]], "Forking and cloning the User Guide": [[4, "forking-and-cloning-the-user-guide"]], "Format overview": [[61, null]], "Format reference": [[59, null]], "Format-specific attributes": [[109, "format-specific-attributes"]], "Fraction of native contacts over a trajectory": [[19, null]], "Fragments": [[98, "fragments"]], "Frame-wise form of the function": [[15, "Frame-wise-form-of-the-function"]], "Frames and trajectories": [[103, "frames-and-trajectories"]], "Frequently asked questions": [[56, null]], "Further analysis": [[26, "Further-analysis"]], "GMS (Gamess trajectory)": [[70, null]], "GRO (GROMACS structure file)": [[71, null]], "GROMACS entries used to create angles.": [[87, "id3"]], "GROMACS entries used to create bonds.": [[87, "id2"]], "GROMACS entries used to create dihedrals.": [[87, "id4"]], "GROMACS entries used to create improper dihedrals.": [[87, "id5"]], "GSD (HOOMD GSD file)": [[72, null]], "General": [[6, null]], "General conventions": [[108, "general-conventions"]], "General rules for importing": [[101, "general-rules-for-importing"]], "Generating paths": [[46, "Generating-paths"]], "Geometric": [[106, "geometric"]], "Getting atom information from AtomGroups": [[53, "Getting-atom-information-from-AtomGroups"]], "Getting started with Git": [[2, "getting-started-with-git"]], "Getting the develop branch ready for a release": [[102, "getting-the-develop-branch-ready-for-a-release"]], "GitHub Actions": [[108, "github-actions"]], "Group operators and set methods": [[1, "group-operators-and-set-methods"]], "Groupby and split": [[1, "groupby-and-split"]], "Groups of atoms": [[98, null]], "Guessing": [[60, null]], "Guessing topology attributes": [[114, "guessing-topology-attributes"]], "Guidelines for writing docstrings": [[3, "guidelines-for-writing-docstrings"]], "HISTORY (DL_Poly Config)": [[63, "history-dl-poly-config"]], "Hard cutoff with a single reference": [[19, "Hard-cutoff-with-a-single-reference"]], "Hausdorff method": [[46, "Hausdorff-method"]], "Helix analysis": [[39, null], [39, "id6"]], "Helper functions": [[26, "Helper-functions"]], "Hydrogen Bond Analysis": [[7, "hydrogen-bond-analysis"], [25, null]], "Hydrogen bond lifetime of individual hydrogen bonds": [[27, "Hydrogen-bond-lifetime-of-individual-hydrogen-bonds"]], "Hydrogen bonds": [[26, "Hydrogen-bonds"]], "Hydrogen bonds between specific groups": [[28, "Hydrogen-bonds-between-specific-groups"]], "IN, FHIAIMS (FHI-aims input files)": [[73, null]], "INPCRD, RESTRT (AMBER restart files)": [[74, null]], "ITP (GROMACS portable topology files)": [[75, null]], "Imports and dependencies": [[7, "imports-and-dependencies"]], "In-memory trajectories": [[103, "in-memory-trajectories"]], "In-memory trajectories of an atom selection": [[103, "in-memory-trajectories-of-an-atom-selection"]], "Increment develop branch files ready for the next version": [[102, "increment-develop-branch-files-ready-for-the-next-version"]], "Index": [[106, "index"]], "Indexing and slicing": [[1, "indexing-and-slicing"]], "Input": [[103, "input"]], "Installation": [[100, null]], "Intermittent lifetime": [[27, "Intermittent-lifetime"]], "Iterating over auxiliary data": [[57, "iterating-over-auxiliary-data"]], "Janin analysis": [[37, "Janin-analysis"]], "Jupyter notebook files": [[4, "jupyter-notebook-files"]], "Known issues:": [[105, "known-issues"]], "Known test failures:": [[105, "known-test-failures"], [105, "id35"]], "LAMMPSDUMP (LAMMPS ascii dump file)": [[76, null]], "Length": [[113, "length"]], "List of core module dependencies": [[101, "list-of-core-module-dependencies"]], "Loading a structure or trajectory": [[53, "Loading-a-structure-or-trajectory"]], "Loading data into a Universe": [[57, "loading-data-into-a-universe"]], "Loading files": [[9, "Loading-files"], [10, "Loading-files"], [11, "Loading-files"], [12, "Loading-files"], [13, "Loading-files"], [14, "Loading-files"], [15, "Loading-files"], [16, "Loading-files"], [18, "Loading-files"], [19, "Loading-files"], [20, "Loading-files"], [21, "Loading-files"], [22, "Loading-files"], [23, "Loading-files"], [24, "Loading-files"], [26, "Loading-files"], [27, "Loading-files"], [28, "Loading-files"], [31, "Loading-files"], [33, "Loading-files"], [34, "Loading-files"], [36, "Loading-files"], [37, "Loading-files"], [38, "Loading-files"], [39, "Loading-files"], [40, "Loading-files"], [42, "Loading-files"], [43, "Loading-files"], [44, "Loading-files"], [45, "Loading-files"], [46, "Loading-files"], [48, "Loading-files"], [49, "Loading-files"], [55, "Loading-files"]], "Loading files: the difference between ParmEd and MDAnalysis": [[52, "Loading-files:-the-difference-between-ParmEd-and-MDAnalysis"]], "Loading from files": [[114, "loading-from-files"]], "MDAnalysis Release Notes": [[105, null]], "MDAnalysisData": [[5, "mdanalysisdata"]], "MDAnalysisTests": [[5, "mdanalysistests"]], "MMTF (Macromolecular Transmission Format)": [[77, null]], "MOL2 (Tripos structure)": [[78, null]], "MOL2 specification": [[78, "mol2-specification"]], "Major changes:": [[105, "major-changes"], [105, "id2"], [105, "id8"], [105, "id14"], [105, "id20"], [105, "id25"], [105, "id30"], [105, "id36"]], "Manually upload Cirrus CI wheels (temporary)": [[102, "manually-upload-cirrus-ci-wheels-temporary"]], "Mass": [[13, "Mass"]], "Masses": [[60, "masses"]], "Measuring convergence with cosine content": [[34, "Measuring-convergence-with-cosine-content"]], "Memory Usage": [[57, "memory-usage"]], "Merging with a protein": [[50, "Merging-with-a-protein"]], "Methods": [[1, "methods"]], "Modifying TopologyAttrs": [[109, "modifying-topologyattrs"]], "Module dependencies in the code": [[101, "module-dependencies-in-the-code"]], "Module imports": [[108, "module-imports"]], "Module imports in MDAnalysis": [[101, null]], "Module imports in MDAnalysis.analysis": [[101, "module-imports-in-mdanalysis-analysis"]], "Module imports in the test suite": [[101, "module-imports-in-the-test-suite"]], "Modules and dependencies": [[3, "modules-and-dependencies"]], "Modules in the \u201ccore\u201d": [[101, "modules-in-the-core"]], "Molecules": [[0, "molecules"]], "More advanced selections": [[28, "More-advanced-selections"]], "Multiple references": [[19, "Multiple-references"]], "Multiple selections": [[96, "multiple-selections"]], "NCDF, NC (AMBER NetCDF trajectory)": [[79, null]], "New Contributors": [[105, "new-contributors"], [105, "id1"], [105, "id7"], [105, "id11"], [105, "id19"]], "Non-linear dimension reduction to diffusion maps": [[33, null]], "Note": [[95, "note"]], "Notes:": [[105, "notes"]], "Nucleic acids": [[107, "nucleic-acids"]], "Nucleic backbone": [[107, "nucleic-backbone"]], "Nucleic sugars": [[107, "nucleic-sugars"]], "Nucleobases": [[107, "nucleobases"]], "On a Mac": [[3, "on-a-mac"]], "On the hole2 notebook": [[4, "on-the-hole2-notebook"]], "On-the-fly transformations": [[112, null]], "Optional modules in MDAnalysis.analysis and MDAnalysis.visualization": [[101, "optional-modules-in-mdanalysis-analysis-and-mdanalysis-visualization"]], "Optional steps and tips": [[4, "optional-steps-and-tips"]], "Order and uniqueness": [[1, "order-and-uniqueness"]], "Ordered selections": [[106, "ordered-selections"]], "Ordering HOLE profiles with an order parameter": [[30, "Ordering-HOLE-profiles-with-an-order-parameter"]], "Other": [[51, null]], "Other possible parallelism approaches for multiple analyses": [[15, "Other-possible-parallelism-approaches-for-multiple-analyses"]], "Output": [[103, "output"]], "Overview": [[4, "overview"], [53, "Overview"]], "PDB format with AutoDOCK extensions for the PDBQT format.": [[82, "id1"]], "PDB specification": [[81, "pdb-specification"]], "PDB, ENT (Standard PDB file)": [[81, null]], "PDBQT (Autodock structure)": [[82, null]], "PDBQT specification": [[82, "pdbqt-specification"]], "PQR file (PDB2PQR / APBS)": [[83, null]], "PQR specification": [[83, "pqr-specification"]], "PSF (CHARMM, NAMD, or XPLOR protein structure file)": [[84, null]], "PSF specification": [[84, "psf-specification"]], "Packaging the release": [[102, "packaging-the-release"]], "Pairwise RMSD between two trajectories": [[12, "Pairwise-RMSD-between-two-trajectories"]], "Pairwise RMSD of a trajectory to itself": [[12, "Pairwise-RMSD-of-a-trajectory-to-itself"]], "Parallelization in a simple per-frame fashion": [[15, "Parallelization-in-a-simple-per-frame-fashion"]], "Parallelization in a split-apply-combine fashion": [[15, "Parallelization-in-a-split-apply-combine-fashion"]], "Parallelization with dask": [[15, "Parallelization-with-dask"]], "Parallelization with multiprocessing": [[15, "Parallelization-with-multiprocessing"]], "Parallelizing analysis": [[15, null]], "ParmEd (ParmEd Structure)": [[80, null]], "Participating": [[99, "participating"]], "Passing arguments to auxiliary data": [[57, "passing-arguments-to-auxiliary-data"]], "Pickling": [[103, "pickling"]], "Plotting": [[18, "Plotting"], [19, "Plotting"], [19, "id6"], [19, "id7"], [20, "Plotting"], [21, "Plotting"], [22, "Plotting"], [22, "id4"], [23, "Plotting"], [24, "Plotting"], [24, "id4"], [30, "Plotting"], [30, "id8"], [37, "Plotting"], [42, "Plotting"], [42, "id5"], [42, "id6"], [44, "Plotting"], [44, "id5"], [44, "id6"], [45, "Plotting"], [46, "Plotting"], [46, "id5"]], "Plotting RMSF": [[14, "Plotting-RMSF"]], "Plotting distance as a heatmap": [[23, "Plotting-distance-as-a-heatmap"]], "Plotting the data": [[13, "Plotting-the-data"]], "Polymers and membranes": [[7, "polymers-and-membranes"], [29, null]], "Preexisting selections and modifiers": [[106, "preexisting-selections-and-modifiers"]], "Preparing a release": [[102, null]], "Principal component analysis": [[34, "Principal-component-analysis"]], "Principal component analysis of a trajectory": [[34, null]], "Protein backbone": [[107, "protein-backbone"]], "Protein dihedral angle analysis": [[37, null]], "Proteins": [[107, "proteins"]], "Pushing your code to GitHub": [[3, "pushing-your-code-to-github"]], "Q1 vs Q2 contact analysis": [[20, null]], "Quick start guide": [[53, null]], "RMSD": [[53, "RMSD"]], "RMSD between two sets of coordinates": [[13, "RMSD-between-two-sets-of-coordinates"]], "RMSD of a Universe with multiple selections": [[13, "RMSD-of-a-Universe-with-multiple-selections"]], "RMSD of an AtomGroup with multiple selections": [[13, "RMSD-of-an-AtomGroup-with-multiple-selections"]], "Radius cutoff": [[19, "Radius-cutoff"]], "Radius of gyration": [[15, "Radius-of-gyration"], [16, "Radius-of-gyration"]], "Ramachandran analysis": [[37, "Ramachandran-analysis"]], "Reading and writing files": [[103, null]], "Reading data directly": [[57, "reading-data-directly"]], "Reading in": [[65, "reading-in"], [66, "reading-in"], [67, "reading-in"], [70, "reading-in"], [71, "reading-in"], [72, "reading-in"], [76, "reading-in"], [79, "reading-in"], [81, "reading-in"], [82, "reading-in"], [83, "reading-in"], [84, "reading-in"], [85, "reading-in"], [88, "reading-in"], [89, "reading-in"], [94, "reading-in"], [95, "reading-in"]], "Reading in selections": [[96, "reading-in-selections"]], "Reading multiple trajectories": [[103, "reading-multiple-trajectories"]], "Reading trajectories into memory": [[103, "reading-trajectories-into-memory"]], "Rebasing your code": [[3, "rebasing-your-code"]], "Recreating auxiliaries": [[57, "recreating-auxiliaries"]], "References": [[9, "References"], [10, "References"], [11, "References"], [12, "References"], [13, "References"], [14, "References"], [15, "References"], [16, "References"], [18, "References"], [19, "References"], [20, "References"], [21, "References"], [22, "References"], [23, "References"], [24, "References"], [26, "References"], [27, "References"], [28, "References"], [30, "References"], [31, "References"], [33, "References"], [34, "References"], [36, "References"], [37, "References"], [38, "References"], [39, "References"], [40, "References"], [42, "References"], [43, "References"], [44, "References"], [45, "References"], [45, "id5"], [46, "References"], [48, "References"], [49, "References"], [50, "References"], [52, "References"], [53, "References"], [55, "References"], [104, null]], "Release 2.0.0 of MDAnalysis": [[105, "release-2-0-0-of-mdanalysis"]], "Release 2.1.0 of MDAnalysis": [[105, "release-2-1-0-of-mdanalysis"]], "Release 2.2.0 of MDAnalysis": [[105, "release-2-2-0-of-mdanalysis"]], "Release 2.3.0 of MDAnalysis": [[105, "release-2-3-0-of-mdanalysis"]], "Release 2.4.0 of MDAnalysis": [[105, "release-2-4-0-of-mdanalysis"]], "Release 2.4.1 of MDAnalysis": [[105, "release-2-4-1-of-mdanalysis"]], "Release 2.4.2 of MDAnalysis": [[105, "release-2-4-2-of-mdanalysis"]], "Release 2.4.3 of MDAnalysis": [[105, "release-2-4-3-of-mdanalysis"]], "Release 2.5.0 of MDAnalysis": [[105, "release-2-5-0-of-mdanalysis"]], "Release 2.6.0 of MDAnalysis": [[105, "release-2-6-0-of-mdanalysis"]], "Release 2.6.1 of MDAnalysis": [[105, "release-2-6-1-of-mdanalysis"]], "Release 2.7.0 of MDAnalysis": [[105, "release-2-7-0-of-mdanalysis"]], "Release policy and release numbering": [[102, "release-policy-and-release-numbering"]], "Residues and Segments": [[98, "residues-and-segments"]], "Running the analysis": [[39, "Running-the-analysis"]], "Running the test suite": [[108, "running-the-test-suite"]], "Sanitization": [[4, "sanitization"]], "See Also": [[15, "See-Also"]], "Selecting Trajectory Frames Based on Auxiliary Data": [[57, "selecting-trajectory-frames-based-on-auxiliary-data"]], "Selecting atoms": [[53, "Selecting-atoms"]], "Selecting dihedral atom groups": [[37, "Selecting-dihedral-atom-groups"]], "Selection Keywords": [[106, "selection-keywords"]], "Selection exporters": [[96, null]], "Serial Analysis": [[15, "Serial-Analysis"]], "Similarity and connectivity": [[106, "similarity-and-connectivity"]], "Simple selections": [[106, "simple-selections"]], "Single AtomGroup": [[96, "single-atomgroup"]], "Single frame": [[53, "Single-frame"]], "Skipping tests": [[108, "skipping-tests"]], "Slicing trajectories": [[110, null]], "Soft cutoff": [[19, "Soft-cutoff"]], "Soft cutoff and multiple references": [[19, "Soft-cutoff-and-multiple-references"]], "Speed": [[113, "speed"]], "Split the trajectory": [[15, "Split-the-trajectory"]], "Standalone Usage": [[57, "standalone-usage"]], "Standard residues in MDAnalysis selections": [[107, null]], "Store data": [[26, "Store-data"]], "Structure": [[7, "structure"], [35, null]], "Summary of tasks": [[102, "summary-of-tasks"]], "Supported formats": [[57, "supported-formats"]], "Supported selection exporters": [[96, "id2"]], "Supported versions": [[87, "supported-versions"]], "TNG (Trajectory Next Generation)": [[85, null]], "TOP, PRMTOP, PARM7 (AMBER topology)": [[86, null]], "TPR (GROMACS run topology files)": [[87, null]], "TPR format versions and generations read by MDAnalysis.topology.TPRParser.parse().": [[87, "id1"]], "TPR specification": [[87, "tpr-specification"]], "TRJ, MDCRD, CRDBOX (AMBER ASCII trajectory)": [[88, null]], "TRR (GROMACS lossless trajectory file)": [[89, null]], "TRZ (IBIsCO and YASP trajectory)": [[90, null]], "TXYZ, ARC (Tinker)": [[91, null]], "Table of all supported formats in MDAnalysis": [[61, "id10"]], "Table of supported coordinate readers and the information read": [[58, "id2"], [61, "id12"]], "Table of supported topology parsers and the attributes read": [[61, "id11"], [97, "id1"]], "Temporary files and directories": [[108, "temporary-files-and-directories"]], "Test coverage": [[108, "test-coverage"]], "Test with pytest and nbval": [[4, "test-with-pytest-and-nbval"]], "Testing": [[100, "testing"]], "Testing exceptions and warnings": [[108, "testing-exceptions-and-warnings"]], "Testing in parallel": [[108, "testing-in-parallel"]], "Testing the same function with different inputs": [[108, "testing-the-same-function-with-different-inputs"]], "Testing your code": [[3, "testing-your-code"]], "Tests for analysis and visualization modules": [[108, "tests-for-analysis-and-visualization-modules"]], "Tests in MDAnalysis": [[108, null]], "The site-specific RDF without densities": [[40, "The-site-specific-RDF-without-densities"]], "The topology system": [[109, null]], "Tiling into a larger Universe": [[50, "Tiling-into-a-larger-Universe"]], "Time": [[113, "time"]], "Topology": [[61, "topology"], [97, null]], "Topology attributes": [[109, "topology-attributes"]], "Topology objects": [[109, "topology-objects"]], "Topology-specific methods": [[109, "topology-specific-methods"]], "Trajectories": [[53, "Trajectories"], [56, "trajectories"], [111, null]], "Trajectory formats": [[103, "trajectory-formats"]], "Trajectory similarity": [[7, "trajectory-similarity"], [41, null]], "Transferring trajectories into memory": [[103, "transferring-trajectories-into-memory"]], "Transformations": [[54, null]], "Transforming a function into a class": [[16, "Transforming-a-function-into-a-class"]], "Trying out different clustering parameters": [[42, "Trying-out-different-clustering-parameters"]], "Trying out different dimension reduction parameters": [[44, "Trying-out-different-dimension-reduction-parameters"]], "Types": [[60, "types"]], "Typical workflow for preparing a release": [[102, "typical-workflow-for-preparing-a-release"]], "Unit Handling": [[57, "unit-handling"]], "Unit conversion": [[113, "unit-conversion"]], "Units and constants": [[113, null]], "Universe": [[114, null]], "Universe properties and methods": [[114, "universe-properties-and-methods"]], "Unwrapping the protein": [[55, "Unwrapping-the-protein"]], "Update conda-forge packages": [[102, "update-conda-forge-packages"]], "Use case: Atoms list grouped by residues": [[98, "use-case-atoms-list-grouped-by-residues"]], "Use case: Sequence of residues by segment": [[98, "use-case-sequence-of-residues-by-segment"]], "Use guess_acceptors and guess_hydrogens to create atom selections": [[28, "Use-guess_acceptors-and-guess_hydrogens-to-create-atom-selections"]], "Use with Trajectories": [[57, "use-with-trajectories"]], "Using HOLE with a PDB file": [[30, "Using-HOLE-with-a-PDB-file"]], "Using HOLE with a trajectory": [[30, "Using-HOLE-with-a-trajectory"]], "Using MDAnalysis to select atoms": [[52, "Using-MDAnalysis-to-select-atoms"]], "Using ParmEd and OpenMM to create a simulation system": [[52, "Using-ParmEd-and-OpenMM-to-create-a-simulation-system"]], "Using ParmEd with MDAnalysis and OpenMM to simulate a selection of atoms": [[52, null]], "Using a Gaussian network model": [[38, "Using-a-Gaussian-network-model"]], "Using a Gaussian network model with only close contacts": [[38, "Using-a-Gaussian-network-model-with-only-close-contacts"]], "Using default arguments with clustering ensemble similarity": [[43, "Using-default-arguments-with-clustering-ensemble-similarity"]], "Using default arguments with dimension reduction ensemble similarity": [[43, "Using-default-arguments-with-dimension-reduction-ensemble-similarity"]], "Using pre-commit hooks": [[4, "using-pre-commit-hooks"]], "Using test data files": [[108, "using-test-data-files"]], "Version control, Git, and GitHub": [[2, "version-control-git-and-github"]], "Viewing the documentation interactively": [[3, "viewing-the-documentation-interactively"]], "Visualisation": [[48, "Visualisation"]], "Visualising RMSF as B-factors": [[14, "Visualising-RMSF-as-B-factors"]], "Visualising projections into a reduced dimensional space": [[34, "Visualising-projections-into-a-reduced-dimensional-space"]], "Visualising the VMD surface": [[30, "Visualising-the-VMD-surface"]], "Volumetric analyses": [[7, "volumetric-analyses"], [47, null]], "Weighted RMSD of a trajectory": [[13, "Weighted-RMSD-of-a-trajectory"]], "Welcome to MDAnalysis User Guide\u2019s documentation!": [[99, null]], "What file to edit": [[4, "what-file-to-edit"]], "Where to start?": [[2, "where-to-start"]], "Where to write docstrings": [[3, "where-to-write-docstrings"]], "Why MDAnalysis?": [[99, "why-mdanalysis"]], "Why do the atom positions change over trajectories?": [[56, "why-do-the-atom-positions-change-over-trajectories"]], "With conda-forge packages": [[3, "with-conda-forge-packages"]], "With mamba/conda": [[3, "with-mamba-conda"]], "With pip and virtualenv": [[3, "with-pip-and-virtualenv"], [3, "id1"]], "Working with groups of atoms": [[53, "Working-with-groups-of-atoms"]], "Working with the code": [[3, "working-with-the-code"]], "Working with the code documentation": [[3, "working-with-the-code-documentation"]], "Working with the data": [[30, "Working-with-the-data"]], "Working with trajectories": [[53, "Working-with-trajectories"]], "Wrapping the solvent back into the box": [[55, "Wrapping-the-solvent-back-into-the-box"]], "Write your own native contacts analysis method": [[18, null]], "Writing docs for abstract base classes": [[3, "writing-docs-for-abstract-base-classes"]], "Writing new code": [[3, "writing-new-code"]], "Writing new tests": [[108, "writing-new-tests"]], "Writing out": [[65, "writing-out"], [66, "writing-out"], [67, "writing-out"], [71, "writing-out"], [79, "writing-out"], [81, "writing-out"], [82, "writing-out"], [83, "writing-out"], [89, "writing-out"]], "Writing out coordinates": [[53, "Writing-out-coordinates"]], "Writing selections": [[96, "writing-selections"]], "Writing trajectories to a file": [[10, "Writing-trajectories-to-a-file"]], "Writing your own trajectory analysis": [[16, null]], "XML (HOOMD)": [[92, null]], "XPDB (Extended PDB file)": [[93, null]], "XTC (GROMACS compressed trajectory file)": [[94, null]], "XVG Files": [[57, "xvg-files"]], "XYZ specification": [[95, "xyz-specification"]], "XYZ trajectory": [[95, null]], "chemfiles (chemfiles Trajectory or file)": [[62, null]], "conda": [[100, "conda"]], "matplotlib (3D static plot)": [[48, "matplotlib-(3D-static-plot)"]], "nglview (interactive)": [[48, "nglview-(interactive)"]], "pip": [[100, "pip"]], "pyvista (3D surface)": [[48, "pyvista-(3D-surface)"]], "reStructuredText files": [[4, "restructuredtext-files"]], "scikit-image (triangulated surface)": [[48, "scikit-image-(triangulated-surface)"]], "segid and chainID": [[87, "segid-and-chainid"]]}, "docnames": ["advanced_topology", "atomgroup", "contributing", "contributing_code", "contributing_docs", "datasets", "examples/README", "examples/analysis/README", "examples/analysis/alignment_and_rms/README", "examples/analysis/alignment_and_rms/aligning_structure_to_another", "examples/analysis/alignment_and_rms/aligning_trajectory", "examples/analysis/alignment_and_rms/aligning_trajectory_to_frame", "examples/analysis/alignment_and_rms/pairwise_rmsd", "examples/analysis/alignment_and_rms/rmsd", "examples/analysis/alignment_and_rms/rmsf", "examples/analysis/custom_parallel_analysis", "examples/analysis/custom_trajectory_analysis", "examples/analysis/distances_and_contacts/README", "examples/analysis/distances_and_contacts/contacts_custom", "examples/analysis/distances_and_contacts/contacts_native_fraction", "examples/analysis/distances_and_contacts/contacts_q1q2", "examples/analysis/distances_and_contacts/contacts_within_cutoff", "examples/analysis/distances_and_contacts/distances_between_atomgroups", "examples/analysis/distances_and_contacts/distances_between_selections", "examples/analysis/distances_and_contacts/distances_within_selection", "examples/analysis/hydrogen_bonds/README", "examples/analysis/hydrogen_bonds/hbonds", "examples/analysis/hydrogen_bonds/hbonds-lifetimes", "examples/analysis/hydrogen_bonds/hbonds-selections", "examples/analysis/polymers_and_membranes/README", "examples/analysis/polymers_and_membranes/hole2", "examples/analysis/polymers_and_membranes/polymer", "examples/analysis/reduced_dimensions/README", "examples/analysis/reduced_dimensions/diffusion_map", "examples/analysis/reduced_dimensions/pca", "examples/analysis/structure/README", "examples/analysis/structure/average_rdf", "examples/analysis/structure/dihedrals", "examples/analysis/structure/elastic_network", "examples/analysis/structure/helanal", "examples/analysis/structure/site_specific_rdf", "examples/analysis/trajectory_similarity/README", "examples/analysis/trajectory_similarity/clustering_ensemble_similarity", "examples/analysis/trajectory_similarity/convergence", "examples/analysis/trajectory_similarity/dimension_reduction_ensemble_similarity", "examples/analysis/trajectory_similarity/harmonic_ensemble_similarity", "examples/analysis/trajectory_similarity/psa", "examples/analysis/volumetric/README", "examples/analysis/volumetric/density_analysis", "examples/analysis/volumetric/linear_density", "examples/constructing_universe", "examples/other/README", "examples/other/parmed_sim", "examples/quickstart", "examples/transformations/README", "examples/transformations/center_protein_in_box", "faq", "formats/auxiliary", "formats/coordinates", "formats/format_reference", "formats/guessing", "formats/index", "formats/reference/chemfiles", "formats/reference/config", "formats/reference/coor", "formats/reference/crd", "formats/reference/data", "formats/reference/dcd", "formats/reference/dcd_lammps", "formats/reference/dms", "formats/reference/gms", "formats/reference/gro", "formats/reference/gsd", "formats/reference/in", "formats/reference/inpcrd", "formats/reference/itp", "formats/reference/lammpsdump", "formats/reference/mmtf", "formats/reference/mol2", "formats/reference/ncdf", "formats/reference/parmed", "formats/reference/pdb", "formats/reference/pdbqt", "formats/reference/pqr", "formats/reference/psf", "formats/reference/tng", "formats/reference/top", "formats/reference/tpr", "formats/reference/trj", "formats/reference/trr", "formats/reference/trz", "formats/reference/txyz", "formats/reference/xml", "formats/reference/xpdb", "formats/reference/xtc", "formats/reference/xyz", "formats/selection_exporters", "formats/topology", "groups_of_atoms", "index", "installation", "module_imports", "preparing_releases_and_hotfixes", "reading_and_writing", "references", "releases", "selections", "standard_selections", "testing", "topology_system", "trajectories/slicing_trajectories", "trajectories/trajectories", "trajectories/transformations", "units", "universe"], "envversion": {"nbsphinx": 4, "sphinx": 64, "sphinx.domains.c": 3, "sphinx.domains.changeset": 1, "sphinx.domains.citation": 1, "sphinx.domains.cpp": 9, "sphinx.domains.index": 1, "sphinx.domains.javascript": 3, "sphinx.domains.math": 2, "sphinx.domains.python": 4, "sphinx.domains.rst": 2, "sphinx.domains.std": 2, "sphinx.ext.intersphinx": 1, "sphinx.ext.viewcode": 1, "sphinxcontrib.bibtex": 9}, "filenames": ["advanced_topology.rst", "atomgroup.rst", "contributing.rst", "contributing_code.rst", "contributing_docs.rst", "datasets.rst", "examples/README.rst", "examples/analysis/README.rst", "examples/analysis/alignment_and_rms/README.rst", "examples/analysis/alignment_and_rms/aligning_structure_to_another.ipynb", "examples/analysis/alignment_and_rms/aligning_trajectory.ipynb", "examples/analysis/alignment_and_rms/aligning_trajectory_to_frame.ipynb", "examples/analysis/alignment_and_rms/pairwise_rmsd.ipynb", "examples/analysis/alignment_and_rms/rmsd.ipynb", "examples/analysis/alignment_and_rms/rmsf.ipynb", "examples/analysis/custom_parallel_analysis.ipynb", "examples/analysis/custom_trajectory_analysis.ipynb", "examples/analysis/distances_and_contacts/README.rst", "examples/analysis/distances_and_contacts/contacts_custom.ipynb", "examples/analysis/distances_and_contacts/contacts_native_fraction.ipynb", "examples/analysis/distances_and_contacts/contacts_q1q2.ipynb", "examples/analysis/distances_and_contacts/contacts_within_cutoff.ipynb", "examples/analysis/distances_and_contacts/distances_between_atomgroups.ipynb", "examples/analysis/distances_and_contacts/distances_between_selections.ipynb", "examples/analysis/distances_and_contacts/distances_within_selection.ipynb", "examples/analysis/hydrogen_bonds/README.rst", "examples/analysis/hydrogen_bonds/hbonds.ipynb", "examples/analysis/hydrogen_bonds/hbonds-lifetimes.ipynb", "examples/analysis/hydrogen_bonds/hbonds-selections.ipynb", "examples/analysis/polymers_and_membranes/README.rst", "examples/analysis/polymers_and_membranes/hole2.ipynb", "examples/analysis/polymers_and_membranes/polymer.ipynb", "examples/analysis/reduced_dimensions/README.rst", "examples/analysis/reduced_dimensions/diffusion_map.ipynb", "examples/analysis/reduced_dimensions/pca.ipynb", "examples/analysis/structure/README.rst", "examples/analysis/structure/average_rdf.ipynb", "examples/analysis/structure/dihedrals.ipynb", "examples/analysis/structure/elastic_network.ipynb", "examples/analysis/structure/helanal.ipynb", "examples/analysis/structure/site_specific_rdf.ipynb", "examples/analysis/trajectory_similarity/README.rst", "examples/analysis/trajectory_similarity/clustering_ensemble_similarity.ipynb", "examples/analysis/trajectory_similarity/convergence.ipynb", "examples/analysis/trajectory_similarity/dimension_reduction_ensemble_similarity.ipynb", "examples/analysis/trajectory_similarity/harmonic_ensemble_similarity.ipynb", "examples/analysis/trajectory_similarity/psa.ipynb", "examples/analysis/volumetric/README.rst", "examples/analysis/volumetric/density_analysis.ipynb", "examples/analysis/volumetric/linear_density.ipynb", "examples/constructing_universe.ipynb", "examples/other/README.rst", "examples/other/parmed_sim.ipynb", "examples/quickstart.ipynb", "examples/transformations/README.rst", "examples/transformations/center_protein_in_box.ipynb", "faq.rst", "formats/auxiliary.rst", "formats/coordinates.rst", "formats/format_reference.rst", "formats/guessing.rst", "formats/index.rst", "formats/reference/chemfiles.rst", "formats/reference/config.rst", "formats/reference/coor.rst", "formats/reference/crd.rst", "formats/reference/data.rst", "formats/reference/dcd.rst", "formats/reference/dcd_lammps.rst", "formats/reference/dms.rst", "formats/reference/gms.rst", "formats/reference/gro.rst", "formats/reference/gsd.rst", "formats/reference/in.rst", "formats/reference/inpcrd.rst", "formats/reference/itp.rst", "formats/reference/lammpsdump.rst", "formats/reference/mmtf.rst", "formats/reference/mol2.rst", "formats/reference/ncdf.rst", "formats/reference/parmed.rst", "formats/reference/pdb.rst", "formats/reference/pdbqt.rst", "formats/reference/pqr.rst", "formats/reference/psf.rst", "formats/reference/tng.rst", "formats/reference/top.rst", "formats/reference/tpr.rst", "formats/reference/trj.rst", "formats/reference/trr.rst", "formats/reference/trz.rst", "formats/reference/txyz.rst", "formats/reference/xml.rst", "formats/reference/xpdb.rst", "formats/reference/xtc.rst", "formats/reference/xyz.rst", "formats/selection_exporters.rst", "formats/topology.rst", "groups_of_atoms.rst", "index.rst", "installation.rst", "module_imports.rst", "preparing_releases_and_hotfixes.rst", "reading_and_writing.rst", "references.rst", "releases.md", "selections.rst", "standard_selections.rst", "testing.rst", "topology_system.rst", "trajectories/slicing_trajectories.rst", "trajectories/trajectories.rst", "trajectories/transformations.rst", "units.rst", "universe.rst"], "indexentries": {"atomname": [[83, "term-atomName", true]], "chainid": [[83, "term-chainID", true]], "charge": [[83, "term-charge", true]], "duecredit_enable": [[104, "index-0", false]], "environment variable": [[104, "index-0", false]], "radius": [[83, "term-radius", true]], "recordname": [[83, "term-recordName", true]], "residuename": [[83, "term-residueName", true]], "residuenumber": [[83, "term-residueNumber", true]], "serial": [[83, "term-serial", true]], "x y z": [[83, "term-X-Y-Z", true]]}, "objects": {}, "objnames": {}, "objtypes": {}, "terms": {"": [1, 2, 3, 4, 9, 10, 13, 16, 19, 26, 27, 30, 33, 34, 37, 39, 40, 42, 44, 45, 48, 50, 52, 53, 55, 56, 57, 60, 67, 81, 87, 96, 98, 101, 102, 103, 104, 105, 109, 111, 113, 114], "0": [0, 1, 2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 89, 90, 91, 92, 93, 94, 95, 96, 97, 98, 99, 100, 101, 102, 103, 104, 106, 107, 108, 109, 110, 111, 112, 113, 114], "00": [13, 30, 36, 42, 53, 78, 82, 98, 109], "000": [30, 52, 78], "0000": 43, "00000": [30, 104], "000000": [13, 16, 18, 19, 20], "0000000000000007": 52, "00000000e": 42, "00000762939453": 57, "00001525878906": 57, "00002": [14, 104], "0000305175781": 57, "0000610351562": 57, "00009": [30, 104], "00011079": 49, "00020": [38, 104], "00022158": 49, "00024": [9, 10, 55, 104], "00024669": 40, "00025464": 40, "00026781": 49, "00028": 40, "00031": [42, 43, 44, 45, 104], "0003116": 40, "00033237": 49, "00038": [33, 104], "00044316": 49, "00050771": 49, "00053562": 49, "00054276": 49, "00055068": 40, "00055396": 49, "00066475": 49, "00073491": 49, "0007466": 40, "00080344": 49, "00083": [19, 20, 104], "00085": [33, 104], "00088633": 49, "00094167": 40, "00099712": 49, "000e": [36, 109], "001": 113, "00106921": 40, "00107": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55, 104], "00107125": 49, "00108553": 49, "00111344": 49, "00112985": 49, "00114292": 40, "00115669": 49, "00122727": 49, "00127": [9, 10, 11, 12, 13, 14, 33, 104], "00129204": 49, "001312": 49, "00132949": 49, "00133906": 49, "00144029": 49, "00152": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "001589": 16, "00160687": 49, "00175": [39, 104], "00177266": 49, "00177646": 49, "0018406": 49, "002": 82, "00210503": 49, "0022": [37, 104], "00220": [33, 104], "0022283678904084": [37, 104], "0023665": 40, "00241031": 49, "00259": [19, 20, 104], "00279604": 49, "0033": 53, "003316543310998": 111, "00348": 104, "00348155": 49, "00401706": [14, 104], "00522": [30, 104], "006": [33, 82, 104], "0063": 113, "007": [1, 53, 82], "00778": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 55, 104], "008": [1, 53], "00874": [37, 104], "00876945": 49, "009": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 104], "00935": [30, 104], "00e": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "01": [13, 30, 36, 53, 104], "010": 52, "010261e": 13, "0103643": 113, "010e": 36, "011": [1, 39, 53], "011126": 53, "012": 82, "013": [15, 82, 104], "0135559": 49, "014111": [34, 104], "01418196": 109, "01688797": 49, "01691979": 49, "017": 103, "01700328": 49, "0175389": 49, "017e": 36, "018": [98, 104], "019": 82, "01957657": 49, "019587": 16, "0196": 53, "0196814": 49, "02": [27, 36, 104], "02096112": 49, "020e": 36, "021": 82, "02131476": 49, "02166694e": 42, "02179554": 49, "02271": [33, 104], "022757": 33, "02339659": 49, "024": [30, 82, 104], "024e": 36, "02689655": 49, "02691": 50, "02791523": 49, "028398": 33, "029266e": 13, "02954": 57, "029879e": 13, "03": [3, 36, 37, 42, 104, 107, 109], "03125632": 43, "031910": 104, "031958e": 13, "03231": 50, "03400656": 49, "03402765": 49, "034909350700361955": 52, "03504874": 109, "03507781": 49, "035526": 33, "036821e": 13, "037335": 16, "0374380078872": 52, "037768e": 13, "0378": 57, "038": 98, "038469": 33, "038667": 33, "038766": 34, "03881675": 44, "039": 103, "03997": [37, 104], "04": [33, 104], "041445": 33, "042": 83, "04223882": 109, "04277601": 49, "04737475": 46, "04737477": 46, "0485004790689": 52, "0488882": 113, "05": [30, 104], "05076614": 44, "052": 82, "052780e": 53, "054": 82, "054708": 33, "0567": 43, "057143": 33, "059": 82, "06": [1, 38, 104, 113], "060914": 33, "061491": 16, "06153911": 44, "062": 82, "0625": 57, "06342056": 43, "064333": 16, "066": [33, 104], "067112": 33, "067632": 33, "06808195": 53, "07": [13, 38, 50, 53, 104], "070": 82, "07027348": 103, "072": 103, "073": 82, "07391102": [39, 104], "075950": 33, "075991": 53, "077": 82, "0784": 53, "07957562": 46, "07957565": 46, "08": [13, 26, 50, 53, 57, 99], "081": 82, "088241": 34, "088865": 16, "089e": 36, "09": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 104, 113], "091": 78, "094409": 33, "094795": 33, "0962": 30, "0991": 43, "0f": 53, "0f99b0dc5f49": 109, "0x13a476d30": 14, "0x140451fd0": 53, "0x14115fdf0": 26, "0x1444979d0": 48, "0x7f0442bc0af0": 36, "0x7f0442f64370": 36, "0x7f0443041df0": 36, "0x7f044305ffa0": 36, "0x7f0554052c40": 38, "0x7f05540e1ac0": 38, "0x7f05569e96d0": 38, "0x7f0556a1f8e0": 38, "0x7f06d09bc700": 22, "0x7f06d2a3b7c0": 22, "0x7f1a146af610": 30, "0x7f2cca7d3a60": 27, "0x7f2cca7db1c0": 27, "0x7f2e804833d0": 13, "0x7f2e80483490": 13, "0x7f2e80561610": 13, "0x7f2e830164f0": 13, "0x7f4b7ddfd160": 31, "0x7f5d682b3b20": 49, "0x7f75f0149520": 33, "0x7f75f1291520": 33, "0x7f75f1291970": 33, "0x7f8bf93611c0": 15, "0x7f9000474df0": 16, "0x7f9000500820": 16, "0x7f90006ca9d0": 16, "0x7f901a31bca0": 16, "0x7f9e98499ee0": 43, "0x7f9eb2146160": 43, "0x7faa885ab280": 40, "0x7fcd2b8cb430": 37, "0x7fcd2ba11580": 37, "0x7fce5096fd60": 28, "0x7fce50983790": 28, "0x7fce5098a250": 28, "0x7fce51309190": 28, "0x7fd0e5c7a850": 12, "0x7fd0e5ddcc40": 12, "0x7fd1d0c7ad00": 44, "0x7fd2165443a0": 44, "0x7fd216582df0": 44, "0x7fd21662ec10": 44, "0x7ffbb1e508b0": 57, "0x7ffbb2006650": 57, "0x7ffbb2284c70": 57, "1": [0, 1, 3, 4, 9, 10, 11, 12, 13, 14, 15, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 60, 61, 66, 69, 75, 78, 81, 82, 83, 84, 87, 88, 89, 91, 93, 94, 95, 96, 98, 102, 103, 104, 106, 108, 109, 110, 111, 112, 113, 114], "10": [1, 3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 71, 78, 82, 83, 87, 98, 103, 104, 105, 106, 108, 109, 110, 111, 112, 113, 114], "100": [0, 1, 14, 19, 26, 27, 30, 42, 44, 52, 53, 57, 87, 113, 114], "1000": [27, 44, 50, 105, 106, 113, 114], "100000": [105, 113], "1002": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 52, 53, 55, 104], "1003": 52, "1004415": [42, 43, 44, 45, 104], "1004568": [46, 104], "1007": [34, 104], "100th": 14, "101": [9, 82, 98], "10101525": 33, "1016": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 30, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 104], "102": [12, 42, 44, 45, 46, 98], "1021": [38, 104], "10286": [37, 104], "1029": 98, "103": 87, "1030": 98, "1031": 98, "1032": 98, "1033": 98, "1034": 98, "103407": 33, "1035": 98, "1036": 98, "1037": 98, "1038": 98, "1039": [26, 27, 28, 98], "104": [27, 50], "1040": [1, 98], "1041": [40, 98], "1042": 98, "1043": 98, "1044": 98, "1045": 98, "10490022": [14, 104], "105": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 103, 104], "10506570": [39, 104], "106": 53, "1063": [27, 33, 34, 104], "107": 34, "1073": [19, 20, 104], "107425": 33, "108": 27, "1080": [14, 39, 104], "1082": 57, "1084": 57, "1093": [9, 10, 19, 20, 52, 55, 104], "10th": [16, 106], "11": [1, 3, 9, 10, 13, 14, 15, 16, 19, 24, 26, 27, 28, 30, 33, 34, 36, 37, 38, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 78, 81, 82, 83, 87, 98, 103, 104, 105, 106, 109, 110, 112, 113, 114], "110": [19, 20, 34, 87, 104], "1103": 104, "1107": [9, 10, 11, 12, 13, 14, 33, 104], "11084": 1, "11086": 0, "11087": 0, "11088": 0, "111": [37, 44, 48], "111460": 33, "112": [34, 87, 103], "113": [82, 98], "11394": [38, 104], "114": 82, "11401": [38, 104], "11404": 1, "114195": 16, "115": 34, "1159": 101, "116": 87, "118": 34, "11th": 106, "12": [1, 3, 9, 10, 13, 14, 15, 16, 19, 26, 27, 30, 33, 34, 36, 37, 40, 42, 43, 44, 46, 48, 49, 50, 52, 53, 55, 57, 78, 82, 86, 98, 103, 104, 105, 106, 109, 110, 111, 112, 113, 114], "121": [13, 39, 46, 50, 52], "122": [13, 14, 22, 23, 50, 82, 98], "123": 98, "123456789": 82, "124": 27, "1241": [9, 10, 52, 55, 104], "124116": [33, 104], "1242": [9, 10, 52, 55, 104], "125": [37, 82, 104], "1264": 105, "1265": 53, "127": 15, "128": [57, 82], "129": [37, 38, 98, 104], "13": [1, 9, 10, 13, 14, 15, 16, 19, 26, 27, 30, 34, 36, 37, 40, 42, 43, 44, 48, 49, 50, 52, 53, 55, 57, 81, 82, 98, 103, 106, 109, 110, 112, 114], "130": [48, 106], "1300": 105, "130355": 53, "1311599110": [19, 20, 104], "132017": 33, "133": [27, 98], "134": [15, 33, 104], "135": 82, "1371": [42, 43, 44, 45, 46, 104], "137593e": 13, "137873": 16, "138474e": 13, "1386": 57, "139": 30, "13913721": 43, "139156e": 13, "14": [1, 9, 10, 13, 15, 16, 19, 26, 27, 30, 34, 36, 40, 42, 43, 44, 48, 49, 50, 52, 53, 55, 57, 82, 98, 100, 103, 104, 105, 106, 109, 110, 112, 114], "140": 96, "140631869613383": 52, "140e": 36, "141": [34, 96, 104], "141134e": 13, "142": [15, 27, 104], "143": 27, "143376e": 13, "144": 82, "145622": 45, "145e": 36, "146": [27, 57], "1464": 43, "149": [30, 34, 104], "15": [1, 7, 10, 13, 15, 16, 19, 26, 27, 30, 34, 36, 40, 41, 42, 43, 44, 45, 48, 49, 50, 52, 53, 57, 81, 82, 98, 103, 104, 106, 109, 110, 112, 114], "150": [26, 28, 82], "150901": [34, 104], "153": 52, "154": 52, "154475": 33, "154986e": 53, "155": [52, 98], "1552": 57, "1561": 53, "1563": 53, "159": [13, 14, 22, 23, 50, 98], "15th": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "16": [1, 3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 81, 82, 98, 103, 104, 105, 106, 109, 110, 111, 112], "160": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 104], "1600": 0, "160e": 36, "161": 39, "161102": 45, "161863": 16, "163276": 16, "164": 98, "165": [11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 33, 38, 39, 42, 43, 44, 45, 49], "1659867": 45, "1660": 113, "166068": 33, "16618489": 103, "168": 98, "168397e": 13, "168694": 33, "169": 37, "17": [1, 12, 15, 16, 19, 20, 21, 26, 27, 30, 33, 34, 36, 39, 42, 44, 48, 49, 50, 52, 53, 57, 69, 81, 82, 87, 98, 103, 104, 106, 109, 110, 111, 112], "171873": 33, "1738": 105, "175": 78, "176": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 82, 104], "1760": 105, "177": 82, "1785": 105, "17874": [19, 20, 104], "17879": [19, 20, 104], "179": 31, "18": [1, 9, 15, 16, 19, 26, 27, 30, 42, 44, 46, 48, 49, 50, 52, 53, 57, 78, 81, 82, 86, 98, 103, 105, 106, 109, 110, 112, 113], "180": [67, 113], "1801": 57, "182243": 16, "183": 52, "1849904397706": 52, "186e": 36, "187": [39, 67], "1879874": 45, "188": 103, "189": 101, "1893": [89, 94], "18980852": 43, "18th": [15, 104], "19": [1, 15, 16, 19, 22, 23, 24, 26, 27, 28, 30, 37, 40, 42, 44, 48, 49, 50, 52, 53, 57, 82, 98, 103, 104, 105, 106, 109, 112, 113], "190": 106, "1901": 105, "19053": 34, "190e": 36, "1929": 98, "193": 27, "193e": 36, "1959": 98, "196": [82, 98], "1960": 98, "1961": 98, "1962": [14, 104], "1967": 104, "197": 27, "197000e": 13, "1978": [37, 104], "197e": 36, "198": 30, "1983": 43, "1988": [78, 105], "199": 27, "1993": [30, 34, 104], "1996": [30, 104], "199960": 33, "19th": [33, 104], "19xx": 105, "1a": 106, "1ake": 13, "1c": 106, "1d": [12, 43], "1e": 113, "1f": 45, "1x": 84, "2": [0, 1, 2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 89, 90, 91, 92, 93, 94, 95, 96, 97, 98, 99, 100, 101, 102, 103, 104, 106, 107, 108, 109, 110, 111, 112, 113, 114], "20": [1, 15, 16, 19, 26, 30, 31, 42, 44, 48, 49, 50, 52, 53, 57, 82, 98, 103, 105, 106, 110, 111, 112, 113], "200": [27, 42, 49, 52, 57, 102, 114], "2000": [39, 50, 104], "20000000000000015": 52, "2002": [34, 104], "2003": [37, 104], "2005": [9, 10, 11, 12, 13, 14, 33, 53, 104], "2006": [33, 104], "2007": [19, 20, 38, 104], "2008": [33, 104], "2009": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 53, 55, 104], "200e": 36, "201": 48, "2010": 53, "2011": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 52, 53, 55, 104], "2013": [19, 20, 30, 67, 104], "2014": [30, 34, 104], "2015": [27, 42, 43, 44, 45, 46, 104], "2016": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 87, 104], "2017": [14, 52, 104], "2018": [9, 10, 26, 27, 28, 34, 52, 55, 87, 104], "2019": [15, 71, 87, 104], "2020": [3, 104, 105], "2021": [104, 105], "2022": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 105], "2023": [3, 105], "2024": 99, "204": [27, 98], "205": 30, "206": 27, "207": 78, "208": 27, "209": 82, "2093": 15, "21": [1, 9, 15, 16, 26, 27, 28, 30, 31, 33, 42, 44, 48, 49, 50, 52, 53, 57, 71, 81, 82, 98, 103, 104, 105, 106, 109, 112, 113, 114], "210": [27, 37, 53, 82], "211": 27, "21124": 57, "2118": 105, "212": [37, 53], "2124": 57, "213": 53, "214": [9, 13, 24, 27, 37, 46, 50, 53], "21439": [9, 10, 11, 14, 104], "21787": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 52, 53, 55, 104], "219e": 36, "22": [1, 15, 16, 26, 30, 44, 46, 48, 49, 50, 53, 57, 81, 82, 98, 103, 105, 106, 112], "220": [37, 82], "22084172": 103, "221": 30, "22168": 1, "222": 82, "2223": [86, 113], "222884": 16, "223": 98, "2245": 83, "224907": 27, "225": 98, "226": 82, "22634681": 50, "2278": 0, "22791": 24, "228815": 33, "229": 52, "23": [1, 3, 15, 16, 26, 30, 34, 44, 48, 49, 50, 53, 57, 81, 82, 87, 93, 98, 103, 106, 112], "230": 98, "2319": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 52, 53, 55, 104], "2327": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 52, 53, 55, 104], "2332": 57, "234": 98, "235205e": 53, "2364": 105, "237": [30, 82], "237e": 36, "238": 82, "23853": 1, "239": [98, 103], "239006": 113, "23912": 50, "2393": 63, "24": [1, 3, 15, 16, 26, 27, 30, 34, 39, 44, 49, 50, 53, 57, 81, 82, 87, 98, 103, 105, 112], "2422": 105, "24269804": 43, "243": 30, "2438": 105, "244e": 36, "2450": 3, "2452": 105, "24545978": 44, "2455": [30, 104], "24595657": 50, "246": 57, "2460": [30, 104], "2468": 105, "2484": 57, "249": 98, "24955": 45, "25": [1, 15, 26, 27, 30, 34, 46, 49, 50, 53, 57, 81, 82, 83, 98, 103, 105], "250384": 33, "2508": 105, "25080": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "251": 52, "2522": 43, "255": 48, "256": 3, "25614133": 53, "2565": [34, 45], "257429": 16, "26": [1, 15, 26, 30, 34, 49, 50, 53, 57, 81, 82, 83, 87, 93, 98, 103], "262": 82, "263638e": 53, "26432545e": 42, "265": 82, "26549552": 16, "2666": 105, "2668": 105, "267": 82, "2699": 57, "27": [1, 15, 26, 30, 49, 50, 53, 57, 81, 82, 93, 98, 103, 104, 107, 113], "270191e": 13, "2703": 105, "27156576e": 50, "2723": 105, "27269": 57, "2728": 105, "2739": 105, "2744": 50, "2746": 105, "275": 98, "276497e": 13, "276639": 16, "276e": 36, "279498e": 53, "28": [1, 3, 15, 30, 49, 50, 53, 57, 78, 98, 103], "28004": 50, "2811": 105, "2821": 105, "2827": 105, "2836": [37, 104], "2842": 105, "2849": 57, "285": 82, "2854886173518": 52, "2863": 105, "2866": 105, "287": 98, "2887": 103, "289": 1, "2898": 105, "29": [1, 13, 15, 30, 34, 46, 49, 50, 53, 57, 98, 103, 113], "290": 98, "290068": 53, "290153": 16, "290e": 36, "2913": 105, "2917": 105, "29185734": 16, "2927": 105, "293e": 36, "2956": 105, "2957448": 103, "296": 30, "2977": 105, "298": 82, "2984": 105, "298539": 16, "298e": 36, "2d": [12, 13, 14, 43], "2e": 57, "2f": [11, 26, 27, 30, 53], "2g14": 84, "2gb": 105, "2lyz": 98, "3": [1, 3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 60, 78, 81, 82, 83, 84, 87, 93, 94, 95, 96, 98, 103, 104, 106, 108, 109, 110, 111, 112, 113, 114], "30": [1, 13, 14, 15, 22, 23, 30, 33, 42, 49, 50, 53, 57, 78, 98, 103, 104, 110, 112, 113], "300": [44, 52, 57, 114], "3000": [50, 83], "3002": 105, "300e": 36, "301": 96, "3025": 52, "3026": 52, "3030": 105, "3044": 105, "3054": 105, "30580288e": 50, "306": 82, "306984": 34, "307": 83, "309": 98, "3092": 105, "31": [1, 15, 16, 19, 30, 48, 49, 50, 53, 57, 81, 82, 98, 103], "310e": 36, "3115": 105, "3118": 57, "3119": 105, "312": [1, 98, 104, 108], "3127": 105, "313": [98, 108], "314": 108, "31415": 30, "3144": 105, "3149": 105, "3152": 105, "316": 108, "317": 108, "3170": 43, "31770319": 43, "318": 53, "3180": 105, "3183": 105, "318859e": 13, "319": [53, 82], "32": [1, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 50, 52, 53, 55, 57, 98, 104, 105], "320": 53, "3200": 105, "320e": 36, "32166": 57, "324": 103, "32501": 57, "3257": 105, "3261": 105, "3271": 53, "3272": 53, "3273": 53, "328": 82, "32873678": 103, "329": 104, "33": [1, 15, 49, 50, 53, 57, 81, 82], "3305": 105, "3314": 105, "3317": 105, "33312648": 46, "33312649": 46, "33355791": 50, "3336": 105, "3337": 53, "3338": 53, "3339": 53, "3340": 53, "3341": [10, 15, 53, 96, 98, 103], "3352": 105, "3358": 105, "3364": 105, "3375": 105, "3385": 105, "3386": 105, "338e": 109, "339": 82, "339e": 109, "34": [1, 9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 30, 33, 37, 38, 39, 40, 42, 43, 44, 45, 49, 50, 52, 53, 55, 57, 81, 82, 98, 104], "340170408": [34, 104], "3403": 105, "340e": 109, "341467": 34, "3415": 105, "3416": 105, "3419": 105, "342": 103, "3423": 105, "3429": 105, "3437": 105, "3443": 105, "3445": 105, "3466": 105, "3469": 105, "3470": 105, "3472": 105, "349": 98, "349043": 16, "3495": [30, 104], "349e": 36, "35": [1, 19, 20, 30, 49, 50, 53, 57, 98, 103, 104], "3500816": 103, "3501": 105, "3511": 105, "3512": 105, "3514": 105, "353": 78, "3539": 105, "354": [30, 104], "3543": 105, "35433": 15, "3548": 105, "3556": 105, "3565": 105, "3569857": [33, 104], "357": [37, 104], "3571": 105, "3572": 105, "3596": 105, "35975078": 103, "3598": 105, "36": [1, 49, 50, 53, 57, 83], "360": [30, 104], "360050708": 104, "3611": 105, "3617": 105, "3621": 105, "364e": 36, "3654": 105, "3657": 105, "3664": 105, "3671": 105, "3678": 105, "3680": 105, "3683": 105, "3685": 105, "3687": 105, "37": [1, 38, 49, 50, 53, 57, 83, 98, 104], "3701": 105, "3703": 105, "3710": 105, "3711": 105, "371346e": 53, "3718": 113, "37205967": 46, "37206002": 46, "3721": 105, "3730": 105, "3735": 105, "37359575": 16, "374": 98, "3744": 105, "3749": 105, "3755": 105, "376": [30, 104], "3765": 105, "3767": 57, "378": 82, "3783": 105, "379": 30, "379e": 36, "38": [1, 16, 23, 49, 52, 53, 57, 81, 82], "3810": 105, "38143802": 103, "3825": 105, "382960": 16, "382e": 36, "3832": 105, "3844": 105, "3846": 105, "3848": 105, "385": [82, 98, 104], "386": [37, 98, 104], "387": [34, 104], "3876": 105, "388": 82, "3887": 105, "3889": [11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 33, 38, 39, 43, 44, 49], "389": 30, "3890": 105, "3894": 105, "39": [1, 13, 15, 16, 18, 20, 21, 23, 24, 26, 30, 31, 36, 37, 38, 39, 40, 42, 43, 44, 48, 49, 50, 52, 53, 57, 81, 82], "3904": 105, "3905": 105, "3906": 105, "391": 30, "3913": 105, "3914": 105, "393473": 53, "3935": 105, "394": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 78, 104], "395": 98, "3951": 105, "3953": 105, "3956": 105, "3958": 105, "3959": 105, "3967": 30, "3976": 105, "3977": 105, "3983": 105, "3988": 105, "399": [30, 98], "3991666": 46, "39916723": 46, "3996": 105, "3999": 105, "3d": [30, 43, 44, 53], "3f": [30, 31, 34, 39], "3n": [7, 32, 34, 41], "3rd": 12, "3x3": 3, "4": [1, 3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 60, 78, 82, 83, 87, 88, 93, 96, 98, 100, 102, 103, 104, 106, 108, 109, 110, 111, 112, 114], "40": [1, 19, 30, 49, 53, 57, 81, 82, 98, 103, 110], "400": [52, 57, 114], "4000": 15, "4000000000000003": 52, "4003": 105, "4007": 105, "4008": 105, "4009": 105, "4010": 105, "4015": 105, "402": 98, "40210": 87, "4022": 105, "4027": 105, "4028": 43, "4031": 105, "4032": 105, "4037": 105, "4039": 105, "4040": 105, "4043": 105, "4047": 105, "4049": 105, "405": 98, "4054": 105, "4059": 105, "4066": 105, "407": 37, "4070": 105, "4072": [57, 105], "4073": 105, "40737137186695": 52, "4074": 105, "4075": 105, "4076": 105, "408": 98, "408413": 34, "4085": 105, "4089": 105, "4091": 105, "4092": 105, "4096": 3, "41": [1, 30, 49, 57, 81, 82, 98], "410": 83, "4105": 105, "4108": 105, "4109": 105, "4115": 105, "41177493": 43, "411e": 36, "412": [34, 104], "41377455": 103, "414": [78, 98], "4140": 105, "414839": 53, "415": 98, "4153": 105, "416": 98, "4160": 105, "4161": 105, "4163": 105, "4167": 105, "4168": 105, "417": 98, "4170": 105, "4174": 105, "4176": 105, "418": 98, "4182": 105, "4184": 105, "4187": 15, "419": [14, 30, 98, 104], "4191": 105, "419340e": [13, 53], "4198": 105, "42": [30, 48, 49, 57, 103, 106], "420": [14, 98, 104], "4200": 105, "4203": 34, "4214": 105, "421683": 16, "4219": 105, "4220": 105, "42282569": 46, "42282661": 46, "4230": 105, "4237": 105, "4246": 105, "4247": 105, "4248": 105, "425": [30, 34, 104], "4253": 105, "4255": 105, "4258": 105, "426": [30, 82, 104], "4261": 105, "427098": 34, "4271": 105, "4273": 105, "4281": 105, "4283": 105, "4284": 105, "4289": 105, "4292": 105, "429350": 16, "4294": 105, "43": [3, 49, 57, 103], "430": 98, "4300": 105, "4301": 105, "4309": 105, "431": 82, "4319": 105, "4325": 105, "4327": 105, "4329": 105, "4331": 105, "4332": 105, "4333": 105, "4335": 105, "434": 52, "4340": 105, "4342": 105, "4343": 105, "4344215": 53, "4346": 105, "4359": 105, "4366": 105, "437": [37, 104], "4374": 40, "438": 30, "44": [19, 20, 30, 48, 49, 57, 103, 104], "442": 30, "442750": 16, "443": 30, "443243": 16, "443850e": 53, "444213": 16, "444711": 16, "445914": 16, "44733fc214dcfdcc2b7cb3e3705258781bb491bd": 105, "449": 82, "449275": 19, "45": [16, 49, 50, 57, 98], "450": [37, 104], "451285": 16, "451335": 16, "45325": 52, "4548": 113, "456": 82, "46": [49, 52, 57, 81, 82, 98, 106], "460": 98, "4600": 83, "463": 87, "463768": 19, "464154": 34, "46589388029852": 52, "47": [49, 57, 81, 82, 103, 109], "4721781": [9, 10, 55, 104], "47680": 1, "47681": [53, 103, 114], "478": [9, 10, 11, 12, 13, 14, 33, 53, 104], "47995117": 103, "48": [30, 49, 52, 57, 81, 82, 98], "480": [9, 10, 11, 12, 13, 14, 33, 53, 83, 104], "480681e": 13, "4819": 43, "482385": 16, "483e": 36, "484": 57, "485": 82, "487021": 16, "4885338": [34, 104], "489046": 16, "48955173": 26, "49": [42, 49, 57], "492": 98, "4922445": 27, "49225059e": 50, "492754": 19, "493": 57, "496493": 16, "498081e": 13, "499": 83, "4ake": [0, 13, 50, 53, 83, 106], "4f": [43, 53], "4th": [10, 34, 39, 48], "5": [1, 3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 67, 71, 78, 82, 87, 93, 98, 102, 103, 104, 106, 108, 109, 110, 111, 112, 114], "50": [3, 19, 37, 44, 49, 52, 53, 57, 104, 110, 113], "500": [37, 52, 57, 114], "500640": 16, "50182419815255": 52, "501e": 36, "504430e": 13, "5049637": [34, 104], "506": 79, "507119e": 13, "507246": 19, "507396": 16, "507e": 36, "508649": 16, "508946e": 13, "509": [33, 104], "51": [26, 30, 53, 57, 98, 103], "5108170": [14, 104], "511": 30, "51332265e": 50, "5134845": 53, "514341": 16, "52": [16, 57, 98, 103], "522": 82, "522147": 16, "523": 52, "524600": 57, "525164": 57, "5262336": 103, "529": 98, "52911": 57, "52934648642113": 52, "52983036": 43, "53": [57, 98], "530339": 16, "5305598": 103, "531": 40, "533": 30, "533023": 16, "533e": 36, "535": 82, "537": 98, "5373676523751": 52, "537926": 16, "539112": 16, "53a6": 107, "54": [30, 53, 57, 81, 82, 113], "540e": 36, "542": [52, 78], "542565": 16, "543": [30, 82], "544784": 16, "545": 83, "55": [57, 81, 82, 110], "550": 98, "550181e": 13, "55032598": 46, "55032613": 46, "550571": 16, "551": [98, 103], "551e": 36, "55204678": 46, "55204694": 46, "5526783580306": 52, "554": 98, "555": 103, "55559436896063": 52, "556": 108, "556e": 36, "557": [52, 82], "557e": 36, "56": [30, 53, 57, 103], "560575": 16, "560e": 36, "561879": 34, "562034": 16, "567": 30, "568": 40, "568381": 16, "57": [30, 52, 57, 103], "570": [40, 52], "571st": 40, "575": 52, "57584035": 103, "578": 98, "58": [30, 57, 87], "581": 82, "583": 98, "584163": 16, "584302": 34, "58767": 50, "588600e": [13, 53], "589": [37, 57], "59": [13, 14, 16, 22, 23, 50, 57], "591575": 16, "592": 98, "593": 98, "59556372": 44, "59975057e": 42, "5f": [34, 40], "5th": 106, "6": [1, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 66, 69, 78, 81, 82, 83, 84, 87, 91, 93, 98, 102, 103, 104, 106, 109, 110, 111, 112, 114], "60": [13, 36, 40, 46, 50, 57, 81, 82, 110], "600": [52, 57, 98, 114], "6000000000000004": 52, "60069985": 44, "601": 98, "602176565": 113, "60218e": 113, "603": 52, "603098": 16, "603704620787127": 9, "60502842": 50, "606": 52, "6084": [14, 104], "61": [9, 10, 11, 12, 13, 14, 30, 33, 40, 53, 57, 81, 82, 98, 104], "612": 98, "612104": 34, "612923": 53, "612989e": 13, "613": 98, "6132305": 53, "614": 52, "614469": 16, "616e": 36, "61919832973248": 52, "62": [30, 40, 57, 103], "6204634": 103, "621": 82, "623": 52, "6234": 57, "625": 49, "627": 82, "629e541a": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "63": [30, 40, 52, 57], "630e": 36, "635": 98, "636": 98, "636592e": [13, 53], "64": [30, 57], "640025": 16, "640x480": 46, "644": 82, "6454": 57, "646130": 16, "646981": 16, "65": [30, 57, 104], "650": 82, "652498": 34, "653968": 16, "656678": 16, "658": [57, 98], "659": 82, "66": [16, 30, 57, 81, 82], "66053892103219": 113, "66053906660": 113, "66054e": 113, "6608682": 103, "663": 30, "66369356": 44, "664622": 53, "66508082": 50, "666": 101, "667": 82, "667003": 16, "6682": 10, "6690": 53, "669018": [16, 53], "669018368649777": 111, "67": [57, 81, 82], "67052241": 46, "67052252": 46, "673": 104, "6732": 53, "673217": [16, 53], "675616": 34, "677194": 16, "6779995219885": 52, "679": 104, "679625": 16, "68": [57, 98], "68070702": 42, "681294": 16, "68134177": 44, "682": 82, "684": 103, "68452079": 44, "68682809": 42, "69": [19, 21, 57, 98], "69314718": 42, "69380623": 103, "696454": 16, "697": 78, "6th": [1, 106], "7": [1, 3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 21, 22, 23, 24, 26, 27, 28, 30, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 66, 78, 81, 82, 87, 98, 102, 103, 104, 106, 109, 110, 111, 112, 114], "70": [19, 53, 57, 82, 98, 108, 110], "700": [57, 114], "700e": 36, "704": 82, "704494": 16, "70556": 50, "707": 98, "708": 82, "71": [27, 30, 82, 98], "712154435976014": 9, "71288": 57, "713": 98, "713e": 36, "715": 39, "7185": 53, "719242": 19, "71996": 50, "72": [11, 53], "722": 103, "722283": [16, 53], "7223": 53, "723": [34, 83], "727": 98, "73": [11, 16, 21, 30, 50, 87], "731454": [16, 53], "7315": 53, "735": [30, 104], "739": 57, "739184e": 13, "74": [30, 98, 103], "740e": 36, "743": 98, "74314071570579": 52, "743960893217544": 111, "743961": [16, 53], "743983e": [13, 53], "7440": 53, "745": 98, "74534511": 46, "74534554": 46, "745572e": 13, "746624": 34, "747461": 16, "748416e": 53, "749": 82, "749343": 16, "75": [19, 36, 40, 49], "751": [28, 30, 104], "753": 103, "754418e": 13, "75524844": 53, "76": [27, 81, 82], "760545": 16, "762": 105, "7638984": 53, "764": 82, "767501": 19, "77": [21, 81], "770653826924175": 109, "771949": 16, "774": 82, "7741": 53, "7764": 53, "777": 82, "7776190679035": 52, "777e": 36, "78": [37, 81, 104], "780732": 16, "780e": 36, "781": 78, "78155009e": 50, "781e": 36, "78220560918737": 37, "783": 98, "783e": 36, "784": 82, "7855": [30, 104], "786797": 34, "788": 98, "788027": 19, "78938645874581": 111, "7894": 53, "79": [52, 81, 82], "795031e": 13, "79514029": 50, "79665166": 53, "7ddc1dd1": [15, 104], "8": [0, 1, 2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 17, 19, 20, 22, 23, 24, 25, 26, 27, 28, 29, 30, 32, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 89, 90, 91, 92, 93, 94, 95, 96, 97, 98, 99, 100, 101, 102, 103, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114], "80": [3, 16, 19, 81, 82, 105, 106, 110], "800": [57, 114], "8000": [4, 83], "8000000000000006": 52, "800e": 36, "801": 82, "801342": 16, "8036403": 103, "804": 103, "804211e": 13, "8064191062": 52, "807987e": 13, "80th": 16, "81": [11, 30, 98, 106], "811": [39, 104], "81293": [30, 104], "814": 98, "814553": 16, "817293751703919": 9, "817898e": 13, "817e": 36, "819": [39, 104], "8195947370533": 52, "820322e": 13, "821": 98, "821205e": 13, "823686867261616": 13, "824e": 36, "827": 82, "82744082": 26, "828": [82, 103], "8289": 53, "829219": 19, "829e": 36, "83": [26, 87], "831": 98, "833500": 19, "834": 82, "834344e": [13, 53], "835": 98, "8358787": 103, "839346": 16, "84": [11, 30], "845": 98, "85": [21, 108], "8500": 83, "8521": 53, "852127": 16, "852774844656239": 53, "85342131": 16, "854": 83, "8549": 53, "855": 34, "8566": 113, "86": 39, "868e": 36, "87": 30, "871241": 16, "871915e": 13, "8723": 53, "87231363208217": 111, "87503334950912": 52, "878262": 16, "8787": 15, "878e": 36, "879": 30, "88": 30, "882": 82, "884": 30, "8844": 57, "885": [82, 98], "8864": 113, "889": 98, "8th": 16, "9": [1, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 24, 26, 27, 28, 30, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 78, 81, 82, 84, 87, 98, 102, 103, 105, 106, 109, 110, 111, 112, 114], "90": [3, 22, 34, 37, 49, 50, 100, 106, 108, 110, 111, 112], "900": [57, 98, 114], "900327": 16, "900e": 36, "903": 34, "904": 98, "90408": [37, 104], "906": 34, "91": 30, "910": 82, "9108": 53, "910e": 36, "912": 82, "914": 98, "915": 82, "917": [31, 106], "918": 98, "919": 98, "92": 27, "920274": 34, "920e": 36, "921": [83, 106], "921486e": 13, "922e": 36, "923": 106, "93": [13, 16, 27, 30, 104], "933480028298": 52, "934167e": 53, "935": 98, "936": 78, "939": 78, "939111e": 53, "94": [13, 16, 98], "940994e": 13, "942533": 16, "943820": 18, "943e": 36, "946": 98, "946494": 20, "948339": 20, "949262": 20, "9494": 53, "95": [13, 16, 27], "950e": 36, "951": 34, "951107": 20, "952952": 20, "954": 98, "95442": [34, 104], "958": 98, "95908": 50, "959755": 53, "96": [13, 16, 27, 30, 34, 50, 104], "960": [34, 98], "961": 103, "964": 34, "967": 57, "968": 98, "969": 98, "97": [13, 16, 27, 30, 104], "970027": 20, "970184": 19, "972752": 20, "97364299e": 50, "973660": 20, "975": 82, "976": 98, "977444": 16, "978": [34, 104], "9780387954424": [34, 104], "98": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104, 111], "980425": 19, "980926": 20, "980e": 36, "981": 82, "9810": 53, "983": 98, "983231": 53, "9845": [26, 27, 28], "984544": 19, "984928": 19, "9857": [26, 27, 28], "986": 82, "988": [103, 105], "988764": 18, "988937528818184": 52, "98977": 1, "99": [37, 53, 65, 93, 105], "9900092": 45, "991465038265208": 9, "997": 30, "998": 98, "999": [1, 53, 65, 93], "999094": 19, "999991": [13, 16], "999992": [13, 16], "999993": 16, "999994": 16, "999995": 16, "999996": 16, "999997": 16, "999998": 16, "999999": 16, "9999996476800743": 111, "9999999119200186": 111, "99sb": 107, "A": [0, 1, 3, 4, 5, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 56, 57, 60, 61, 63, 67, 71, 72, 75, 81, 82, 83, 84, 87, 88, 95, 98, 101, 102, 103, 104, 105, 106, 107, 108, 109, 112, 113, 114], "And": [5, 55, 96, 100], "As": [2, 3, 4, 10, 12, 13, 14, 15, 16, 23, 24, 30, 33, 34, 39, 42, 43, 44, 48, 50, 53, 55, 57, 61, 84, 93, 95, 96, 98, 100, 102, 103, 105, 106, 108, 109, 113], "At": [3, 102, 106, 108, 112], "BY": 15, "Be": [2, 15, 100], "By": [9, 19, 26, 30, 42, 44, 49, 61, 66, 68, 99, 106], "For": [1, 2, 3, 4, 7, 9, 12, 13, 15, 16, 19, 26, 28, 30, 32, 33, 34, 37, 39, 40, 42, 43, 44, 46, 50, 52, 53, 55, 57, 60, 61, 66, 78, 83, 87, 89, 96, 98, 100, 101, 102, 103, 104, 105, 106, 108, 109, 110, 111, 112, 114], "IN": [58, 59, 61, 97, 109], "If": [2, 3, 4, 7, 9, 10, 11, 12, 13, 15, 16, 23, 26, 27, 30, 34, 36, 37, 38, 40, 42, 44, 46, 50, 52, 53, 55, 57, 61, 65, 66, 67, 68, 79, 81, 82, 83, 84, 88, 89, 92, 96, 99, 100, 101, 102, 103, 105, 106, 108, 109, 112, 114], "In": [0, 1, 3, 4, 5, 7, 9, 11, 12, 13, 14, 15, 16, 18, 19, 26, 27, 30, 33, 34, 36, 38, 42, 44, 45, 46, 48, 50, 52, 53, 57, 61, 66, 67, 79, 88, 89, 93, 96, 98, 99, 100, 101, 104, 105, 106, 108, 109, 110, 111, 112, 114], "It": [2, 3, 4, 7, 9, 12, 13, 14, 15, 16, 21, 22, 26, 27, 28, 30, 32, 33, 34, 36, 37, 40, 45, 48, 49, 50, 53, 57, 60, 61, 67, 76, 78, 82, 85, 87, 89, 99, 104, 106, 108, 110, 112, 114], "NOT": 95, "No": [19, 21, 28, 101, 108, 109], "Not": 53, "Of": 4, "On": [26, 27, 28, 48, 50, 55, 57, 87, 102, 108], "One": [3, 4, 13, 14, 18, 30, 48, 52, 57, 103, 109], "Or": [3, 30, 57], "THE": 3, "That": [3, 19], "The": [1, 2, 3, 4, 5, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 41, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 56, 57, 60, 61, 62, 66, 67, 68, 69, 70, 72, 73, 77, 78, 79, 80, 83, 84, 85, 86, 87, 88, 89, 92, 93, 94, 95, 96, 98, 99, 100, 101, 102, 103, 104, 105, 106, 107, 108, 110, 111, 112, 113, 114], "Then": [3, 4, 12, 13, 15, 18, 24, 53], "There": [3, 12, 19, 26, 30, 33, 34, 36, 37, 40, 50, 81, 82, 99, 112, 114], "These": [1, 3, 4, 5, 7, 8, 17, 24, 37, 43, 48, 53, 57, 72, 81, 82, 89, 94, 98, 106, 108, 109], "To": [0, 2, 3, 4, 10, 12, 16, 19, 22, 26, 27, 28, 30, 42, 43, 44, 46, 48, 50, 53, 57, 66, 86, 100, 102, 105, 108], "With": [13, 34, 50, 103, 109], "_": [2, 3, 13, 26, 31, 44, 48, 87, 99], "__class__": 0, "__future__": 101, "__getattr__": 0, "__init__": [101, 102], "__main__": 16, "__name__": 0, "__version__": [3, 50, 53, 102], "_conclud": [16, 105], "_conclude_fft": 105, "_conclude_simpl": 105, "_dcdmodul": 3, "_distanc": 3, "_eigenvector": 33, "_eprint": [34, 104], "_frame_index": 16, "_i": [13, 14, 16, 31, 34, 36], "_j": 36, "_offset": [89, 94], "_prepar": 16, "_privat": 108, "_t": 16, "_test_write_trajectori": 108, "_trajectori": 16, "_verbos": 16, "a1": 82, "a10": 82, "a11": 82, "a11_11": 82, "a12": 82, "a13": 82, "a14": 82, "a15": 82, "a16": 82, "a17": 82, "a17_17": 82, "a18": 82, "a19": 82, "a2": 82, "a20": 82, "a3": 82, "a4": [82, 84], "a5": 82, "a6": 82, "a7": 82, "a7_7": 82, "a8": [82, 84], "a9": 82, "a9_9": 82, "a_": 31, "a_1": 46, "a_2": 46, "a_i": [31, 46], "a_ix": 27, "a_l": 46, "aa": [12, 13, 14, 26, 30, 48, 107], "aarch64": [102, 105], "ab": [14, 34, 36, 40, 104, 106], "abhinav": [34, 104], "abid": 99, "abil": [4, 105], "abl": [3, 4, 30, 101, 102, 105, 108], "about": [3, 4, 7, 9, 14, 15, 26, 32, 33, 34, 37, 46, 53, 70, 84, 87, 99, 105, 108, 109], "abov": [1, 3, 10, 13, 16, 23, 24, 26, 27, 28, 39, 48, 53, 55, 57, 83, 102, 103, 105, 106, 108, 109, 111], "abs_dev": 39, "absent": 106, "absolut": [16, 26, 101, 106, 108, 109], "absolute_import": 101, "ac": 107, "ac_timeseri": 27, "academ": [9, 10, 19, 20, 55, 104], "academi": [19, 20, 104], "acceler": 15, "accept": [3, 13, 30, 43, 44, 53, 105, 106, 109, 112], "acceptor": [26, 27, 28, 84], "acceptor_index": 26, "acceptor_ix": 26, "acceptors_sel": [26, 27, 28], "access": [0, 1, 3, 5, 16, 42, 50, 53, 56, 89, 94, 98, 99, 105, 106, 107, 109, 114], "accetptor": 28, "accident": 105, "accompani": 57, "accomplish": [10, 30, 48], "accord": [1, 13, 14, 87, 91, 106, 109], "accordingli": [15, 102, 111], "account": [2, 3, 4, 7, 32, 34, 40, 49], "accur": [53, 105], "accuraci": 105, "acess": 57, "acha": [33, 104], "achar": [81, 82], "achiev": [1, 15], "acid": [13, 18, 19, 20, 21, 26, 27, 28, 37, 53, 104, 105], "acidic_2": 19, "across": [3, 12, 48, 50, 89, 94, 102, 106], "act": [93, 111], "acta": [9, 10, 11, 12, 13, 14, 33, 53, 104], "action": 102, "activ": [3, 4, 82, 100], "actual": [3, 4, 5, 16, 40, 52, 56, 108, 111, 112], "ad": [6, 34, 42, 44, 57, 60, 85, 98, 99, 105, 107, 108, 114], "adam": 104, "adapt": 3, "add": [0, 1, 3, 4, 5, 14, 15, 16, 22, 23, 24, 50, 60, 99, 100, 102, 105, 106, 108, 109, 114], "add_angl": 109, "add_auxiliari": 57, "add_bond": 109, "add_compon": 48, "add_dihedr": 109, "add_improp": 109, "add_mesh": 48, "add_nois": 42, "add_represent": [48, 50, 55], "add_residu": [0, 105, 114], "add_seg": [0, 50, 105, 114], "add_subplot": [37, 44, 48], "add_surfac": 48, "add_topologyattr": [14, 50, 109, 114], "add_trajectori": 39, "add_transform": [48, 55, 112], "addit": [2, 3, 7, 44, 57, 61, 82, 96, 98, 101, 102, 103, 105, 106, 108, 109], "addition": 105, "address": [3, 108], "adenyl": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 53, 55, 104], "adequ": [102, 108], "adher": [2, 102], "adjust": 44, "adk": [5, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55], "adk_clos": [9, 10, 12, 19], "adk_closed_view": [9, 19], "adk_coord": 10, "adk_equilibrium": 15, "adk_open": [9, 10, 12, 19], "adk_open_view": [9, 19], "adk_oplsaa": [103, 114], "adk_traj_coord": 10, "adopt": 83, "advanc": [7, 15, 25, 26, 27, 46, 100], "advantag": 4, "advertis": [2, 105], "advis": [30, 105], "affect": [3, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 27, 33, 38, 39, 43, 44, 49, 105], "affin": 42, "affinitypropagationn": 42, "aforement": 15, "africa": [33, 104], "after": [3, 4, 13, 26, 30, 36, 48, 53, 57, 95, 103, 105, 106, 108, 111], "afterward": 103, "ag": [1, 10, 13, 40, 96, 98, 103], "ag1": [1, 40], "ag2": [1, 40], "ag_upd": 106, "again": [3, 13, 19, 30, 34, 37, 43, 46, 89, 96, 105, 108], "against": [2, 4, 102, 105], "aggreg": 30, "agrafioti": [9, 10, 11, 14, 53, 104], "agraw": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 52, 53, 55, 104], "agre": [2, 99], "ahead": [3, 102, 108], "ahm": 105, "aim": [3, 15, 58, 59, 61, 97, 105, 108], "aip": [34, 104], "akeco": 0, "akma": [67, 68, 113], "al": [12, 26, 27, 28, 53], "ala": [37, 52, 53, 87, 96, 98, 106, 107], "ala2_shel": 52, "ala_select": 96, "alad": 107, "alanin": [37, 96, 106], "alb93": [34, 104], "alexand": [9, 10, 52, 55, 104], "algorithm": [7, 8, 9, 10, 11, 12, 13, 14, 16, 19, 33, 34, 39, 41, 42, 43, 44, 48, 52, 53, 60, 100, 104], "alia": 109, "alias": 105, "align": [6, 12, 13, 34, 42, 44, 45, 53, 57, 83, 105, 109, 112], "align_principal_axi": 109, "align_structur": [7, 8], "align_trajectori": [7, 8], "align_trajectory_first": [7, 8], "align_transform": 112, "aligned_coord": 10, "aligned_rmsd": 11, "aligned_rmsd_3": 11, "aligned_to_first_fram": 11, "aligned_traj": 14, "aligned_view": 9, "alignto": [10, 11], "aligntraj": [11, 12, 14, 34, 45], "all": [1, 2, 3, 4, 6, 7, 9, 11, 12, 13, 14, 15, 16, 17, 19, 20, 26, 30, 33, 34, 37, 38, 44, 46, 48, 50, 53, 57, 66, 81, 83, 92, 95, 98, 99, 100, 101, 102, 103, 105, 106, 108, 109, 112, 114], "all_atoms_in_residu": 98, "all_bend": 39, "all_coordin": 114, "all_data": 57, "all_residu": 98, "allevi": 4, "allow": [1, 2, 3, 4, 10, 13, 14, 19, 27, 28, 30, 36, 37, 40, 42, 43, 44, 52, 53, 56, 57, 60, 96, 99, 100, 103, 105, 106, 108, 110, 114], "allowai": 104, "almost": [19, 53, 109, 114], "alon": 57, "along": [12, 15, 19, 20, 22, 30, 42, 44, 46, 49], "alongsid": 85, "alpha": [9, 11, 13, 14, 19, 20, 22, 23, 24, 39, 40, 48, 50, 53, 55, 60, 67, 81, 82, 103, 106], "alpha_al": 103, "alpha_skip2": 103, "alpha_som": 103, "alreadi": [3, 7, 11, 14, 16, 33, 34, 46, 50, 53, 66, 99, 100, 106, 109], "also": [1, 2, 3, 4, 6, 7, 9, 10, 11, 12, 13, 14, 16, 18, 19, 20, 21, 26, 27, 28, 30, 32, 34, 37, 39, 40, 41, 42, 44, 48, 53, 55, 57, 61, 62, 81, 82, 87, 89, 98, 100, 101, 102, 103, 105, 106, 108, 109, 110, 111, 112, 113, 114], "alter": [34, 48], "altern": [1, 3, 13, 20, 30, 48, 57, 77, 81, 82, 96, 103, 106, 108, 109, 112], "although": [3, 7, 16, 30, 48, 63, 67, 79, 82, 83, 84, 105, 111, 112], "altloc": [1, 14, 61, 81, 82, 97, 106, 109], "alwai": [2, 3, 4, 10, 15, 16, 20, 26, 33, 34, 53, 57, 60, 61, 67, 79, 81, 83, 84, 87, 88, 96, 99, 101, 103, 106, 108, 109, 111, 113], "amadei": [34, 104], "amass": 84, "amber": [58, 59, 61, 97, 105, 107, 109, 113], "amber_atom_typ": 86, "amberparm": 52, "ambient": 48, "amend": [3, 105], "american": [34, 38, 104], "amid": 13, "amino": [13, 37, 104, 105], "amount": [15, 102, 108], "amp": [13, 14, 22, 23], "amstat": [14, 104], "amu": 63, "an": [2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 18, 19, 20, 21, 22, 23, 24, 26, 31, 33, 34, 37, 38, 39, 40, 42, 43, 44, 46, 48, 49, 50, 52, 53, 57, 60, 62, 66, 67, 69, 71, 72, 78, 80, 83, 84, 85, 87, 88, 89, 94, 96, 98, 99, 100, 101, 102, 104, 105, 106, 108, 110, 112, 114], "anaconda": 3, "analog": [30, 53], "analys": [3, 4, 6, 13, 16, 17, 25, 26, 28, 29, 52, 53, 99, 105], "analysi": [0, 1, 3, 4, 8, 9, 10, 11, 12, 13, 14, 17, 22, 23, 24, 27, 28, 30, 31, 32, 33, 35, 36, 40, 41, 43, 45, 46, 48, 49, 52, 55, 57, 85, 98, 99, 100, 103, 104, 105, 109, 110, 113, 114], "analysis_class": 16, "analysis_ensembl": 15, "analysisbas": [3, 15, 16, 105], "analysisfromfunct": [10, 15, 16], "analyt": 15, "analyz": [15, 66], "analyze_block": 15, "anchor_nam": 114, "andi": [38, 104], "andrea": [34, 104], "andrew": [33, 52, 104], "ang": 37, "angl": [1, 6, 7, 22, 26, 27, 28, 35, 39, 50, 53, 57, 61, 66, 67, 84, 86, 92, 97, 99, 104, 105, 106, 109, 113, 114], "angle_hnh": 53, "angle_nhh": 53, "angles_inc_hydrogen": 86, "angles_without_hydrogen": 86, "angstrom": [13, 20, 22, 23, 24, 30, 36, 40, 42, 48, 49, 50, 52, 63, 66, 79, 81, 82, 88, 106, 110, 112, 113], "ani": [1, 2, 3, 4, 11, 15, 16, 18, 27, 28, 30, 31, 37, 42, 43, 44, 46, 49, 50, 53, 56, 57, 61, 67, 89, 98, 99, 100, 101, 102, 103, 104, 105, 106, 108, 112], "anim": 30, "annot": [3, 46, 105], "announc": 102, "anoth": [0, 1, 4, 6, 7, 8, 10, 11, 12, 14, 19, 34, 50, 53, 96, 98, 106, 108], "answer": 34, "antoniu": [34, 104], "anybodi": 99, "anyth": [83, 100, 108], "anywai": 92, "anywher": 12, "ap": 104, "apach": 105, "apart": 39, "apb": 59, "apex": 53, "api": [3, 9, 10, 11, 13, 14, 15, 19, 22, 23, 24, 30, 31, 34, 36, 37, 38, 40, 42, 43, 44, 45, 46, 49, 85, 102, 103, 105], "app": 52, "appar": 43, "appear": [3, 34, 38, 48, 63, 68, 96, 102, 103], "append": [15, 21, 26, 27, 50, 52, 53, 96, 98, 102], "appl": 114, "appli": [3, 13, 16, 19, 30, 33, 36, 38, 42, 43, 44, 98, 104, 105, 106, 109, 111, 112], "applic": [4, 37, 58, 61, 66, 98, 114], "approach": [3, 4, 27, 33, 38, 104], "appropri": [15, 19, 36, 57, 68, 96, 103, 106, 108], "approv": [3, 102], "approx": [31, 108], "approxim": [7, 32, 33], "appveyor": [3, 108], "april": [9, 10, 39, 55, 104], "ar": [0, 1, 2, 3, 4, 5, 7, 8, 9, 10, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 60, 61, 65, 66, 67, 68, 69, 70, 72, 73, 75, 76, 77, 78, 79, 81, 82, 83, 84, 87, 88, 89, 92, 93, 94, 95, 96, 98, 99, 100, 101, 102, 103, 104, 105, 106, 107, 108, 109, 111, 112, 113, 114], "arallel": 104, "arang": [15, 23, 37, 42, 44, 45], "arbitrari": [57, 85], "arbitrarili": 114, "arc": [58, 59, 61, 97, 109], "architectur": [3, 100, 105], "area": [14, 26, 37, 42, 108], "aren": 106, "arendal": [37, 104], "arg": [1, 15, 18, 19, 21, 27, 28, 53, 83, 98, 106, 107, 109], "arg1": 3, "arg2": 3, "argmax": 40, "argn": 107, "argument": [13, 15, 16, 18, 19, 27, 30, 33, 37, 42, 44, 48, 50, 53, 61, 66, 67, 81, 88, 89, 94, 95, 96, 103, 105, 106, 108, 109, 112, 114], "aris": [1, 4], "arm": [100, 105], "arm64": [102, 105], "aromat": [105, 109], "around": [6, 7, 13, 14, 16, 19, 22, 26, 28, 30, 34, 36, 40, 42, 47, 50, 52, 53, 99, 100, 106, 114], "arr": 1, "arrai": [0, 1, 7, 12, 13, 15, 16, 17, 18, 19, 21, 24, 26, 27, 30, 33, 34, 36, 37, 39, 40, 42, 43, 44, 46, 48, 49, 50, 53, 57, 98, 103, 105, 108, 109, 112], "arrang": [31, 46], "array1": 108, "array2": 108, "articl": [9, 10, 14, 19, 20, 30, 37, 42, 43, 44, 45, 55, 104], "arxiv": 104, "as_cwd": 108, "asarrai": 15, "ascii": [58, 59, 61, 97], "asel": 105, "asf": 107, "ash": 107, "ask": [2, 3, 4, 16, 99, 100, 102, 108], "asn": [53, 107], "asn1": 107, "asp": [18, 19, 21, 27, 53, 107], "aspect": 2, "asph": 107, "aspher": [105, 109], "assert": 50, "assert_almost_equ": 108, "assert_array_almost_equ": 108, "assert_array_equ": 108, "assert_equ": 108, "assert_rais": 108, "assertionerror": 108, "assess": 53, "assign": [0, 19, 24, 50, 53, 57, 60, 61, 66, 95, 105, 109, 110, 114], "associ": [15, 33, 34, 38, 44, 50, 52, 53, 57, 98, 104, 105, 109, 111], "assum": [3, 50, 53, 57, 60, 61, 66, 67, 68, 79, 83, 88, 100, 114], "astyp": 26, "asu": [30, 104], "athanassio": [33, 104], "atom": [0, 3, 6, 7, 8, 9, 10, 11, 14, 15, 16, 17, 18, 19, 20, 26, 27, 30, 32, 33, 34, 35, 38, 39, 41, 42, 44, 46, 48, 49, 50, 51, 55, 60, 61, 65, 66, 69, 70, 71, 75, 76, 78, 82, 83, 84, 87, 88, 89, 91, 92, 95, 96, 99, 105, 107, 108, 109, 110, 111, 112, 114], "atom1": [1, 95], "atom2": [1, 95], "atom3": 1, "atom_nam": 86, "atom_resindex": [50, 114], "atom_styl": [66, 103], "atom_typ": [60, 66], "atom_type_index": 86, "atomgroup": [0, 6, 7, 9, 15, 16, 17, 19, 26, 31, 37, 39, 40, 50, 52, 55, 60, 71, 98, 103, 105, 106, 112], "atomic_numb": 86, "atomiccharg": [61, 97, 109], "atomicdist": 105, "atomist": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 104], "atomn": 95, "atomnam": [83, 106], "atomno": 65, "atomnum": [61, 97, 109], "atoms_in_residu": 98, "atomselect": 96, "atomtyp": 82, "atp": [13, 14, 22, 23], "attach": [50, 103], "attempt": [9, 81, 105], "attr": 0, "attribut": [0, 1, 3, 4, 14, 15, 26, 30, 39, 40, 53, 56, 60, 65, 66, 77, 81, 83, 87, 99, 103, 105, 106, 108], "attributeerror": 0, "atttempt": 105, "august": [14, 104], "austin": [45, 52, 53], "author": [3, 101, 102], "auto": [27, 42, 43, 44], "autobuild": [3, 4], "autocorrel": [27, 31], "autodetect": [68, 88], "autodock": 59, "autom": [3, 53, 102, 108], "automat": [3, 7, 10, 16, 18, 30, 55, 57, 65, 66, 76, 79, 89, 94, 99, 101, 102, 103, 104, 106, 114], "autovectoris": 100, "aux": 57, "aux_edr": 57, "aux_edr_tpr": 57, "aux_edr_xtc": 57, "aux_list": 57, "aux_n": 57, "auxdata": 57, "auxialliari": 105, "auxilliari": 105, "auxnam": 57, "auxread": [57, 105], "avail": [1, 2, 3, 4, 7, 15, 16, 19, 32, 33, 36, 40, 42, 43, 44, 53, 56, 57, 60, 66, 73, 77, 79, 82, 87, 96, 98, 99, 100, 102, 105, 106, 108, 109, 114], "averag": [6, 7, 8, 16, 26, 27, 31, 34, 35, 39, 40, 42, 44, 45, 49, 55], "averagestructur": 14, "avg": [42, 44, 48], "avid": 104, "avishek": [46, 104], "avoid": [3, 4, 14, 15, 16, 36, 42, 44, 48, 57, 98, 100, 101, 102, 105], "awai": [40, 50, 106], "awar": [15, 108], "ax": [13, 16, 23, 24, 33, 37, 38, 39, 42, 44, 45, 46, 48, 49, 53, 109], "ax0": [42, 44], "ax1": [42, 44], "ax2": [23, 24], "ax_10": 16, "ax_charg": 13, "ax_mass": 13, "ax_polar": 37, "axes3d": [44, 48], "axes3dsubplot": 30, "axessubplot": [18, 30, 31, 37], "axi": [6, 7, 10, 12, 15, 16, 22, 30, 34, 39, 44, 47, 48, 50, 55, 71, 109, 112], "axisgrid": 33, "axvspan": [14, 22], "aya9aladdin": 105, "b": [3, 4, 9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 61, 67, 81, 82, 87, 88, 98, 104, 106, 108, 109], "b98835": [34, 104], "b_1": 46, "b_2": 46, "b_i": 46, "b_l": 46, "back": [9, 48, 52, 53, 62, 79, 80, 86, 102, 103, 108, 110, 111, 112, 113], "backbon": [9, 11, 13, 14, 33, 34, 37, 45, 53, 98, 106], "backend": 105, "background": 99, "background_color": 48, "backslash": 3, "backward": [102, 105], "bakker": [37, 104], "balanc": 15, "ball": 50, "bandwidth": 44, "bansal": [39, 104], "bar": [4, 15, 31, 100, 103, 105], "barnoud": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "barrier": 15, "base": [2, 4, 5, 9, 10, 11, 12, 13, 14, 15, 16, 19, 28, 33, 39, 42, 44, 46, 50, 52, 53, 60, 61, 65, 79, 87, 89, 94, 102, 103, 104, 105, 106, 107, 108, 109], "bashrc": [3, 5], "basi": [40, 83], "basic": [7, 18, 19, 21, 25, 27, 28, 53, 65, 87], "basic_2": 19, "basisc": 28, "bat": 105, "bath": 52, "bb": [31, 53], "bbox": 109, "bdpw09": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55, 104], "bead": [1, 9, 53], "beauchamp": 52, "becaus": [3, 10, 13, 15, 16, 48, 50, 53, 56, 66, 68, 79, 101, 108, 111], "beckstein": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 104], "becom": [3, 4, 7, 9, 10, 31, 32, 33, 36, 40, 109], "been": [3, 15, 16, 18, 37, 48, 53, 60, 67, 70, 87, 102, 104, 105, 108, 109], "befor": [2, 3, 4, 13, 16, 30, 36, 45, 48, 60, 89, 100, 101, 102, 105, 106, 108, 111], "begin": [12, 16, 24, 30, 114], "behav": 106, "behavior": [11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 33, 38, 39, 43, 44, 49], "behaviour": [16, 28, 42, 45, 61, 71, 98, 105, 106, 114], "behind": 3, "being": [53, 56, 61, 93, 102, 105], "believ": 4, "bell": 57, "belleman": 87, "belong": [1, 28, 50, 53, 61, 98, 106, 107], "below": [1, 2, 3, 4, 5, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 21, 22, 26, 27, 28, 30, 33, 34, 36, 37, 38, 39, 40, 42, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 61, 98, 103, 106, 107, 108, 109, 112, 113, 114], "benchmark": [14, 104, 105], "bend": [39, 87], "benefit": [16, 99], "bengtsen": [42, 43, 44, 45, 104], "benjamin": [38, 104], "benthal": [45, 52, 53], "benzen": 78, "berendsen": [34, 104], "berk": 104, "bernard": [37, 52, 104], "besid": 15, "bespok": 105, "best": [3, 4, 12, 19, 20, 104, 108], "beta": [19, 22, 39, 50, 55, 67, 81, 82, 102], "better": [105, 108], "between": [2, 3, 4, 6, 7, 8, 9, 11, 14, 16, 17, 18, 19, 21, 24, 26, 27, 30, 32, 33, 34, 36, 38, 39, 40, 41, 46, 50, 53, 60, 80, 82, 83, 91, 99, 105, 108, 114], "bfactor": [14, 66, 87, 105, 106], "bfactor2rmsf": 105, "bfedder": 105, "bhe13": [19, 20, 104], "bibtex": [3, 53, 104], "bicub": 48, "biexponenti": 27, "big": 3, "bigg": 27, "bigger": 50, "biggin": [38, 104], "bilay": 26, "bin": [3, 9, 10, 11, 12, 13, 14, 26, 30, 33, 36, 40, 48, 49, 104, 105], "bin_cent": 26, "bin_edg": 26, "bin_radii": 30, "binari": [30, 57, 58, 59, 61, 79, 85, 87, 88, 90, 100], "bind": [13, 14, 22, 23, 105], "binder": 6, "binsiz": 49, "bio": 105, "bioinformat": [9, 10, 34, 37, 52, 55, 104], "biol": [45, 50, 52], "biolog": 60, "biologi": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 30, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55, 104], "biomolecular": [39, 68, 104], "biophys": [30, 104], "biopolym": 104, "biopython": [3, 101, 105], "bip": 104, "bisect": 39, "bit": [4, 12, 105], "bkv00": [39, 104], "bla": 3, "black": [3, 37], "blame": 99, "blank": [3, 82, 95, 105, 114], "block": [3, 12, 16, 30, 36, 53, 85, 99], "blockslic": 15, "blog": [55, 100, 105, 112], "blue": [30, 37, 48, 50, 72], "blurri": 114, "bold": [26, 27], "boldsymbol": 109, "boltzman_const": 105, "boltzmann_const": 105, "bond": [1, 13, 31, 49, 52, 53, 55, 57, 61, 66, 78, 80, 81, 82, 84, 86, 91, 92, 97, 98, 99, 104, 105, 106, 109, 114], "bonds_inc_hydrogen": 86, "bonds_without_hydrogen": 86, "bondtyp": [52, 80], "book": [34, 104], "bool": [1, 3, 18, 50, 109, 110], "boolean": [1, 53, 108, 110], "boomsma": [42, 43, 44, 45, 104], "boost": [26, 100], "bootstrap": [42, 44], "border": 55, "bot": [3, 102], "both": [1, 3, 4, 13, 15, 16, 22, 30, 38, 48, 50, 52, 53, 60, 63, 72, 81, 85, 87, 91, 98, 100, 102, 103, 105, 108, 109, 114], "bound": [3, 38, 42, 44, 45, 53, 103], "boundari": [48, 105, 106, 112], "box": [22, 23, 26, 40, 48, 49, 50, 52, 54, 57, 67, 71, 88, 105, 111, 112, 114], "box_cent": 55, "bradlei": 87, "branch": [4, 82, 105, 108], "brand": 2, "break": [3, 27, 66, 101, 105, 108], "breakdown": [3, 114], "brett": 2, "bridg": [19, 21], "bring": 3, "broader": 2, "broken": [48, 50, 105], "brook": 52, "browser": [4, 108], "bryan": [37, 104], "bsphere": [53, 109], "btx789": [9, 10, 52, 55, 104], "buchoux": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "bug": [2, 3, 16, 88, 102], "bugfix": 105, "build": [2, 15, 16, 50, 53, 65, 87, 99, 100, 105], "build_ext": 3, "built": [3, 4, 30, 87, 108], "bulk": 48, "bullet": 3, "bump": 102, "bumpi": 102, "bunch": 53, "bundl": 7, "button": [3, 4], "bynum": 106, "byre": 106, "byte": [57, 90], "bzip2": 105, "c": [1, 3, 13, 27, 30, 31, 34, 36, 37, 38, 39, 46, 48, 50, 52, 53, 62, 67, 78, 81, 82, 85, 87, 88, 98, 100, 102, 103, 104, 105, 106, 107, 113], "c1": [78, 106, 107], "c2": [78, 106, 107], "c21": 82, "c21_21": 82, "c22": 82, "c22_23": 82, "c3": [78, 106, 107], "c36b2": 67, "c4": [78, 106, 107], "c5": [78, 106, 107], "c5m": 107, "c6": [78, 107], "c8": 107, "c9cp01532a": [26, 27, 28], "c_": 53, "c_alpha": 14, "ca": [1, 9, 10, 11, 12, 13, 14, 16, 18, 20, 21, 23, 24, 36, 37, 38, 39, 40, 42, 43, 44, 46, 53, 60, 98, 103, 106, 107], "ca1": [19, 22], "ca1_df": 19, "ca2": [19, 22], "ca2_df": 19, "ca3": 19, "ca3_df": 19, "ca60": 40, "ca61": 40, "ca61_h2o_571": 40, "ca62": 40, "ca_df": [18, 21], "cach": [5, 15, 100], "cala": 107, "calc_bond": 105, "calcium": [53, 60], "calcrmsdrotationalmatrix": 105, "calcul": [6, 7, 8, 9, 10, 11, 16, 18, 19, 25, 33, 34, 35, 39, 41, 46, 47, 53, 55, 57, 61, 100, 104, 105, 109], "call": [0, 1, 3, 4, 7, 12, 15, 16, 19, 28, 30, 32, 34, 37, 50, 53, 68, 98, 99, 105, 106, 108, 109, 112], "callowai": 15, "calpha": 53, "came": [2, 108], "can": [1, 2, 3, 4, 5, 6, 7, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 60, 61, 62, 63, 64, 66, 67, 68, 69, 70, 71, 72, 74, 78, 79, 80, 81, 83, 84, 89, 91, 92, 94, 95, 96, 98, 99, 100, 101, 102, 103, 104, 105, 106, 108, 109, 110, 111, 112, 113, 114], "cannot": [7, 15, 32, 33, 37, 60, 68, 81, 82, 83, 103, 108, 109], "canon": 37, "capit": 3, "capitalclass": 3, "caption": 4, "carbon": [9, 11, 13, 14, 19, 20, 22, 23, 24, 31, 36, 40, 60, 106], "carbonn": 27, "card": [58, 59, 61, 97], "care": [30, 40, 83], "carefulli": [42, 67], "carg": 107, "carl": 114, "carpentri": 108, "carri": [14, 48], "carriag": 4, "cartesian": [34, 49, 104, 105], "case": [3, 4, 9, 10, 12, 13, 14, 15, 27, 28, 30, 36, 44, 48, 52, 53, 55, 57, 68, 82, 87, 89, 96, 99, 100, 104, 105, 106, 108, 111, 114], "casf": 107, "casn": 107, "casp": 107, "cast": 26, "catch": 4, "categori": [108, 109], "caught": 108, "caus": [84, 101, 102, 106], "caution": [98, 105], "cb": [1, 36, 53, 98], "cbar": [23, 24, 45, 48], "cbar0": [42, 44], "cbar1": [42, 44], "cbar2": [23, 24, 42, 44], "cc": [15, 34], "ccy": 107, "ccyx": 107, "cd": [3, 4, 100, 102, 104, 108], "cdf": 40, "cdot": [13, 31, 34, 60], "ce": [42, 53], "cecilia": [33, 104], "cell": [4, 9, 10, 11, 14, 19, 26, 34, 39, 48, 49, 50, 53, 55, 67, 81, 82, 105, 106, 108, 112], "cen_line_d": 30, "center": [13, 15, 16, 23, 24, 26, 30, 36, 40, 50, 53, 54, 105, 106, 109, 112], "center_in_box": [48, 55, 112], "center_of_charg": [105, 109], "center_of_geometri": [30, 50, 53, 55, 109], "center_of_mass": [15, 16, 23, 24, 53, 55, 60, 108, 109], "centr": 30, "central": 53, "centroid": [42, 43, 109], "certain": [5, 7, 13, 17, 19, 21, 30, 40, 42, 53, 57, 61, 66, 98, 106, 108, 109, 110, 114], "ces0": 42, "ces1": 42, "ces2": 42, "ces_ax": 43, "ces_ax2": 43, "ces_conv": 43, "ces_conv2": 43, "ces_converg": 43, "ces_fig": 43, "ces_fig2": 43, "cfg": [4, 100], "cg": [53, 84], "cg1": 105, "cg2": 36, "cgi": [9, 10, 11, 12, 13, 14, 19, 20, 33, 104], "cgln": 107, "cglu": 107, "cgly": 107, "ch": 31, "chain": [13, 14, 37, 50, 81, 82, 83, 96, 104, 105, 109, 112], "chained_ag_upd": 106, "chainid": [50, 61, 65, 81, 82, 83, 97, 105, 109], "chainread": [103, 105, 114], "chang": [1, 5, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 26, 27, 28, 30, 33, 34, 38, 39, 42, 43, 44, 45, 49, 53, 55, 57, 61, 71, 72, 81, 87, 89, 100, 102, 103, 106, 108, 111], "changelog": [3, 102, 105], "channel": [30, 48, 99, 104], "chapter": 69, "char": [96, 105], "charact": [3, 30, 71, 81, 82, 83, 93, 106], "character": [38, 39, 104], "characteris": [19, 20, 38, 39], "characterist": [9, 10, 11, 12, 13, 14, 33, 53, 104], "charg": [6, 7, 13, 28, 47, 48, 61, 66, 81, 82, 83, 86, 87, 92, 97, 105, 106, 109, 114], "charge_dens": [49, 105], "charge_density_stddev": 49, "chargegroup": 109, "charmm": [26, 58, 59, 61, 68, 81, 83, 88, 96, 97, 103, 106, 107], "chaya": 52, "chdir": 108, "check": [3, 4, 5, 11, 26, 27, 28, 50, 53, 57, 60, 66, 67, 72, 89, 102, 108], "checklist": 3, "checkout": [3, 4], "chem": [26, 27, 28, 45, 52, 53, 78], "chembl30": 105, "chemfil": [3, 58, 59, 61], "chemfilesread": 62, "chemfileswrit": 62, "chemic": [33, 34, 38, 53, 98, 104, 114], "chemistri": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 55, 104], "cheq": 84, "chi": 37, "chi1_select": [37, 105], "chi_1": 37, "chi_2": 37, "chi_n": 37, "chid": 107, "chie": 107, "chip": 107, "chiral": [105, 109], "chodera": 52, "choic": [3, 4, 38, 108], "choos": [3, 10, 13, 16, 19, 20, 26, 30, 34, 36, 42, 43, 48, 49, 53, 103], "chosen": [5, 27, 42, 44, 57, 112], "chri": 15, "chrispfa": 105, "christian": [26, 27, 28], "chunk": [30, 36], "ci": 34, "cienc": 104, "cile": 107, "circumv": 106, "citat": 7, "cite": [7, 8, 9, 10, 11, 12, 13, 14, 16, 26, 27, 28, 30, 33, 34, 38, 39, 42, 43, 44, 45, 46, 53, 104], "cl": [0, 30], "cl06": [33, 104], "claim": 105, "clang": 3, "clarif": 105, "clariti": [2, 26], "class": [4, 7, 12, 13, 14, 15, 17, 18, 19, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 49, 53, 57, 83, 96, 98, 100, 101, 103, 105, 108, 109, 113, 114], "classic": 105, "clean": 100, "clear": [3, 4, 5, 9], "clear_data_hom": 5, "clear_represent": 48, "clearli": [42, 83], "clementi": [33, 104], "cleu": 107, "click": [3, 108], "client": 15, "clm": [42, 43], "clone": [3, 100], "close": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 30, 33, 34, 37, 39, 40, 42, 43, 44, 45, 46, 48, 50, 53, 55, 104], "closecontactgnmanalysi": 38, "closer": [19, 44], "closest": 48, "clustalw": 3, "cluster": [6, 7, 15, 41, 44, 46], "cluster_collect": 42, "clustercollect": 42, "clustering_ensemble_similar": 43, "clustering_method": [42, 43], "clusteringmethod": [42, 43], "cly": 107, "cm": 113, "cmap": [12, 109], "cme": 107, "cmet": 107, "co": [31, 67], "coars": [1, 9, 19, 20, 53, 104], "cobrotoxin": 57, "code": [1, 2, 4, 5, 6, 7, 11, 13, 14, 15, 16, 30, 36, 48, 50, 57, 67, 78, 81, 82, 84, 93, 98, 99, 102, 103, 104, 105, 106, 108, 109, 112, 114], "codebas": [2, 16, 105], "codecov": 3, "coeff": 105, "coeffici": 52, "cog": [50, 106], "cog2": 50, "coifman": [33, 104], "col": [15, 16, 34], "collect": [5, 6, 7, 30, 32, 34, 53, 104, 105, 112], "colon": 106, "color": [14, 22, 30, 37, 48], "color_palett": [33, 34], "color_schem": [14, 50], "colorbar": [12, 23, 24, 42, 44, 45, 48], "colour": [10, 14, 30, 48, 108], "column": [12, 13, 16, 18, 19, 20, 21, 26, 33, 34, 50, 53, 81, 82, 83, 84, 91, 93, 103, 105, 108], "com": [3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 100, 104, 105, 108], "comar": 15, "combin": [3, 4, 7, 26, 32, 34, 42, 50, 53, 87, 106, 114], "combined_view": 50, "come": [3, 53, 84, 99, 102, 108, 114], "comfort": 2, "command": [3, 4, 5, 48, 53, 66, 68, 76, 96, 100, 104, 108], "comment": [3, 4, 9, 10, 14, 19, 34, 39, 48, 50, 55, 91, 95, 108], "commit": [102, 105], "common": [1, 3, 7, 12, 13, 14, 15, 22, 26, 31, 32, 34, 53, 55, 68, 70, 104, 106, 108], "commonli": [14, 50, 78, 98], "commun": [2, 3, 88], "commut": 46, "compact": 16, "compar": [1, 6, 7, 9, 10, 11, 12, 14, 15, 17, 19, 22, 32, 34, 40, 41, 42, 44, 45, 108], "comparison": [22, 42, 43, 44, 45, 104, 105, 106], "compat": [95, 100, 101, 102, 105, 108], "compet": 105, "compil": [3, 4, 79, 105], "complet": [2, 3, 5, 30, 53, 57, 112], "complex": [4, 15, 16, 28, 53, 99], "compli": 3, "complic": [61, 106], "compnd": [81, 82], "compon": [6, 7, 32, 33, 43, 44, 104, 108], "compos": [4, 98], "compound": [23, 24, 48, 55, 81, 87, 105, 108, 109, 112], "comprehens": [15, 98], "compress": [58, 59, 61, 105], "compris": 37, "comput": [3, 6, 7, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 47, 52, 53, 55, 56, 99, 100, 104, 108, 109, 113], "concat": 1, "concaten": [1, 15, 53, 103, 106, 114], "concept": [53, 56, 98], "concert": 38, "concis": 3, "conda": [4, 7, 53, 79], "conda_build_config": 102, "condit": [1, 15, 105, 106, 108, 110, 112], "conduct": [2, 99], "conect": [81, 105], "conf": 4, "confer": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "confid": 34, "confidenti": 108, "config": [15, 58, 59, 61, 97, 109], "configpars": 63, "configread": 63, "configur": [2, 3, 7, 19, 23, 32, 41, 67, 108], "confin": 93, "confirm": 102, "conflict": [3, 4, 88, 108], "conform": [3, 7, 9, 10, 11, 12, 13, 14, 18, 19, 20, 21, 22, 32, 33, 34, 37, 38, 41, 42, 43, 44, 45, 46, 53, 83, 104], "conjug": 105, "connect": [1, 3, 4, 33, 50, 52, 53, 60, 61, 82, 87, 91, 105, 114], "consecut": 27, "consensu": 108, "conserv": 57, "consid": [0, 2, 3, 7, 13, 15, 16, 27, 32, 34, 38, 41, 42, 98, 100, 101, 106, 108, 114], "consist": [4, 50, 53, 71, 87, 106], "consol": 30, "consolid": 15, "constant": [4, 26, 33, 49, 52, 66, 76, 105, 106], "constant_dt": 57, "constantli": [4, 33], "constr": 57, "constraint": [52, 87], "construct": [3, 6, 7, 15, 32, 34, 99], "constructing_univers": 114, "constructor": 114, "contact": [6, 99, 104], "contact_matrix": 21, "contactanalysi": 105, "contacts_within_cutoff": 21, "contain": [1, 3, 4, 7, 8, 12, 14, 15, 17, 26, 30, 34, 37, 39, 40, 41, 42, 44, 46, 48, 50, 53, 55, 57, 66, 72, 81, 84, 87, 88, 89, 91, 92, 93, 96, 98, 101, 102, 103, 104, 105, 106, 108, 109, 111, 112, 114], "contat": 19, "content": [3, 4, 95], "context": [1, 15, 30, 52, 53, 96, 108], "contigu": [39, 105], "continu": [2, 19, 27, 48, 89, 94, 102, 103, 105, 109, 114], "contour": 48, "contrast": 10, "contrib": [10, 14, 34, 39, 48, 55], "contribut": [7, 13, 36, 99, 102, 105, 108], "contributor": [3, 108], "contriv": 9, "control": [19, 39, 42, 44, 48, 110], "conveni": [15, 16, 30, 31, 37, 46, 53, 57], "convent": [13, 15, 22, 23, 60, 66, 67, 102, 105], "converg": [6, 7, 12, 13, 38, 41, 42, 104], "convergence_it": 42, "convers": [3, 13, 57, 99], "convert": [3, 4, 24, 37, 48, 52, 53, 57, 62, 63, 76, 78, 80, 81, 83, 86, 105, 113], "convert_dens": 48, "convert_length": 48, "convert_to": 52, "convert_unit": 57, "converterbas": 105, "coor": [58, 59, 61], "coord": 95, "coord_arrai": 50, "coordiant": 83, "coordin": [3, 7, 8, 11, 12, 14, 15, 16, 17, 18, 19, 20, 21, 24, 26, 28, 30, 32, 33, 34, 36, 38, 39, 42, 43, 44, 45, 49, 50, 52, 55, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 76, 77, 78, 79, 80, 81, 82, 83, 85, 87, 88, 89, 90, 91, 93, 94, 95, 103, 104, 105, 106, 108, 109, 111, 112, 114], "copi": [3, 4, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 33, 38, 39, 42, 43, 44, 45, 49, 50, 57, 102, 105, 108], "copy_coord": 10, "copyleft": 2, "core": [0, 2, 3, 13, 14, 15, 22, 23, 42, 44, 50, 53, 57, 83, 100, 102, 103, 105, 109, 112], "core_atom": 50, "core_seg": 50, "core_sel": 46, "corner": 106, "corr": 57, "correct": [4, 14, 26, 50, 53, 67, 102, 104, 105, 108], "correctli": [3, 4, 60, 67, 88, 104, 105, 108], "correspond": [1, 3, 12, 13, 14, 16, 24, 26, 27, 40, 55, 71, 98, 108, 109], "corrupt": 105, "cosin": 67, "cosine_cont": 34, "cosmo": 114, "coul": 57, "could": [9, 13, 16, 18, 23, 24, 34, 48, 88, 109], "coulomb": 57, "count": [19, 21, 26, 27, 36, 40, 96, 105], "count_by_id": [26, 27], "count_by_tim": 26, "count_by_typ": 26, "counter": 50, "coupl": 46, "cours": [4, 37, 55], "cov": [3, 108], "cov_estim": 45, "covari": [34, 45, 105], "covariance_matrix": 105, "cover": 108, "coverag": [3, 101], "cphe": 107, "cplett": [33, 104], "cpoint": 30, "cpro": 107, "cpu": 100, "cpu_count": 15, "crd": [9, 10, 12, 13, 45, 46, 52, 53, 58, 59, 61, 88, 97, 105, 109], "crdbox": [58, 59, 61], "crdparser": 65, "crdreader": 65, "crdwriter": 65, "creat": [0, 2, 9, 10, 12, 15, 19, 20, 24, 26, 30, 34, 36, 39, 49, 53, 57, 60, 71, 75, 78, 80, 81, 83, 84, 89, 94, 99, 100, 103, 105, 106, 108, 110, 112], "create_vmd_surfac": 30, "createsystem": 52, "creation": [3, 57, 78, 102, 105], "crick": 105, "criteria": 26, "cross": [48, 87], "crucial": [53, 106, 108], "cryst1": 82, "crystal": 106, "crystallographi": [9, 10, 11, 12, 13, 14, 33, 104], "crystallographica": [9, 10, 11, 12, 13, 14, 33, 53, 104], "cser": 107, "csv": 26, "cthr": 107, "ctrl": 4, "ctrp": 107, "ctyr": 107, "cube": [48, 49], "cubic": [50, 87, 111], "cumul": [34, 36, 40], "cumulated_vari": 34, "current": [3, 4, 9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 30, 33, 38, 39, 42, 43, 44, 45, 48, 49, 50, 53, 55, 57, 63, 67, 70, 72, 79, 81, 84, 87, 88, 89, 96, 100, 102, 103, 104, 106, 111, 112, 114], "curv": [27, 34], "curve_fit": 27, "custom": [18, 50, 66, 98, 99, 105, 109], "customis": 30, "cutoff": [6, 7, 17, 18, 20, 26, 38, 57, 106], "cval": 107, "cvect": 30, "cy": [37, 105, 107], "cyan": 48, "cycl": [3, 30, 44, 104, 108], "cylay": 106, "cylind": 106, "cylindr": 106, "cym": 107, "cys1": 107, "cys2": 107, "cysh": [105, 107], "cystein": 37, "cyt": 107, "cython": [100, 105], "cyx": 107, "cyzon": 106, "c\u03b1": [37, 104], "c\u03b2": [37, 104], "d": [26, 27, 28, 45, 46, 48, 52, 53, 60, 104], "d_a_cutoff": 26, "d_h_a_angle_cutoff": 26, "d_ix": 27, "da": [26, 27, 107], "da3": 107, "da5": 107, "da_dist": 26, "dab": 107, "daili": 100, "dalton": 63, "damag": 89, "damp": 42, "danieljamesevan": 105, "dark": 37, "dashboard": 15, "dask": 3, "data": [7, 15, 19, 20, 27, 32, 33, 34, 37, 39, 42, 43, 44, 46, 53, 55, 56, 58, 59, 61, 81, 82, 83, 84, 85, 89, 94, 95, 97, 98, 99, 103, 105, 109, 110, 111, 112, 113], "data_selector": 57, "databas": 69, "datadryad": 5, "datafil": [1, 5, 9, 10, 11, 12, 13, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 93, 96, 98, 101, 103, 106, 108, 109, 110, 111, 112, 114], "datafram": [13, 16, 18, 19, 20, 21, 26, 33, 34, 53], "datapars": 66, "dataread": 66, "dataset": [5, 14, 15, 114], "datawrit": [66, 105], "date": [3, 4, 102], "daunt": 2, "davi": [37, 104], "david": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 55, 104], "db1": 42, "db2": 42, "dbscan": 42, "dc": [57, 107], "dc3": 107, "dc5": 107, "dcd": [0, 3, 5, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 26, 27, 28, 33, 34, 38, 39, 42, 43, 44, 45, 46, 49, 53, 58, 59, 61, 103, 105, 106, 108, 110, 111], "dcd2": [9, 10, 12, 16, 38, 42, 44, 45, 46], "dcd_namd_gbi": [42, 44, 45, 46], "dcdplugin": 67, "dcdreader": [11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 33, 38, 39, 42, 43, 44, 45, 49, 67, 68], "dcdwriter": [67, 68, 108], "de": [33, 37, 104], "deactiv": 3, "deafult": 105, "deal": 105, "debenedetti": [33, 104], "dec": 78, "decai": [27, 31], "decemb": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 104], "decid": 3, "decim": [34, 94, 108], "decis": 103, "declar": [102, 108], "decomposit": [38, 43, 44], "decor": [15, 108], "decorrel": 31, "decreas": [19, 33, 44], "dedic": 3, "def": [3, 10, 15, 16, 18, 21, 27, 44, 50, 105, 108, 112], "default": [3, 5, 7, 9, 12, 13, 19, 22, 24, 27, 30, 33, 34, 36, 38, 39, 40, 46, 48, 49, 50, 53, 57, 61, 65, 66, 67, 68, 76, 79, 81, 82, 88, 94, 95, 96, 105, 106, 108, 111, 113, 114], "default_timestep": 114, "defin": [0, 3, 4, 15, 20, 22, 24, 26, 30, 31, 36, 37, 40, 42, 44, 46, 50, 53, 55, 57, 61, 67, 82, 86, 95, 96, 98, 105, 106, 108, 109], "definit": [18, 21, 31, 81, 82, 95], "definiton": 95, "degeneraci": 13, "degre": [37, 39, 53, 67, 81, 82, 113], "del": [57, 96], "delai": 15, "delaru": [19, 20, 104], "delet": [3, 102], "delete_angl": 109, "delete_bond": 109, "delete_dihedr": 109, "delete_improp": 109, "delete_temporary_fil": 30, "deliv": 3, "delta": [36, 48], "delta_": 46, "delta_h": 46, "demand": 2, "demonstr": [3, 7, 8, 13, 18, 19, 26, 30], "den": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 104], "dendrogram": 46, "dens": 42, "densiti": [6, 7, 36, 42, 44, 47, 52, 57, 105], "density_analysi": 48, "density_analysis_imag": 48, "density_from_pdb": 105, "density_from_univers": 105, "densityanalysi": [48, 105], "depend": [4, 10, 16, 26, 53, 60, 61, 68, 100, 102, 104, 105, 106, 108, 112], "depict": 103, "deploi": [102, 108], "deploy": 102, "deprec": [3, 4, 108], "deprecated_funct": 108, "deprecationwarn": [11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 33, 38, 39, 40, 42, 43, 44, 45, 49, 108], "depth": [3, 34], "der": [30, 33, 60, 104, 109, 114], "deriv": [2, 3, 84, 87, 98, 105, 109], "desc": 57, "descend": 26, "descr": 5, "describ": [3, 4, 7, 15, 32, 34, 36, 39, 40, 87, 103, 104, 106, 108, 114], "descript": [3, 5, 15, 30, 53, 57, 58, 61, 83, 87, 96, 97, 105, 108, 109], "design": [3, 18, 53, 85], "desir": [108, 109, 112], "desktop": 15, "desmond": 59, "desr": [58, 61, 69, 97], "detail": [3, 15, 30, 45, 53, 61, 80, 81, 98, 105, 108, 112], "details0": [42, 44], "details1": [42, 44], "details2": [42, 44], "detect": [79, 86, 103], "determin": [4, 6, 7, 9, 10, 11, 13, 14, 16, 17, 18, 19, 20, 21, 29, 33, 34, 37, 46, 53, 57, 98, 104], "determinist": 34, "dev": [3, 102], "dev0": [0, 1, 2, 3, 4, 5, 6, 7, 8, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 89, 90, 91, 92, 93, 94, 95, 96, 97, 98, 99, 100, 101, 102, 103, 104, 106, 107, 108, 109, 110, 111, 112, 113, 114], "develop": [2, 15, 52, 72, 101, 108], "deviat": [6, 7, 8, 9, 11, 30, 37, 39, 42, 44, 83, 104], "devic": [10, 103], "df": [13, 16, 26, 33, 34, 46], "df_charg": 13, "df_mass": 13, "dg": 107, "dg3": 107, "dg5": 107, "dha": [26, 27], "dha_angl": 26, "diagnost": 15, "diagon": 12, "diagonalis": 34, "dict_kei": [30, 39, 57], "dictionari": [1, 18, 30, 57, 60, 89, 105, 108, 114], "dicuss": 100, "did": [3, 14, 81, 105], "dielectr": 105, "diff": [3, 108], "differ": [1, 3, 4, 7, 9, 10, 12, 13, 15, 16, 19, 26, 28, 34, 36, 38, 40, 41, 45, 46, 48, 50, 53, 55, 60, 66, 67, 70, 71, 75, 82, 87, 91, 93, 95, 96, 98, 99, 100, 102, 103, 104, 105, 106, 112, 114], "differenti": 30, "difficult": [3, 4, 7, 19, 32, 40, 55], "difficulti": [2, 99], "diffus": [6, 7, 32, 34, 104], "diffusionmap": [12, 33], "digit": 93, "dih": [37, 57], "dihedr": [1, 6, 7, 35, 53, 61, 66, 84, 86, 97, 105, 106, 109, 114], "dihedrals_inc_hydrogen": 86, "dihedrals_without_hydrogen": 86, "dillon": 15, "dim": [44, 49, 55], "dim_red_method": 44, "dimens": [6, 22, 23, 26, 29, 37, 41, 49, 50, 55, 67, 81, 82, 104, 105, 106, 111, 112, 114], "dimension": [7, 12, 32, 33, 41, 44, 45, 104], "dimension_reduction_ensemble_similar": 43, "dimensionality_reduct": [43, 44], "dimensionality_reduction_method": [43, 44], "dimensionalityreductionmethod": [43, 44], "dimitri": [9, 10, 11, 14, 104], "din": 105, "dipol": 109, "dipole_mo": 109, "dipole_vector": 109, "direcli": 96, "direct": [3, 4, 30, 46, 57, 87, 98, 105], "directed_hausdorff": 46, "directli": [0, 1, 4, 16, 18, 19, 20, 23, 30, 37, 38, 44, 48, 52, 53, 99, 102, 103, 106, 109, 111, 112], "directori": [3, 4, 5, 30, 89, 101, 102, 104], "disabl": [57, 100, 105, 108], "disconnect": [7, 32, 33], "discord": 102, "discount": 36, "discrete_frechet": 46, "discuss": [2, 3, 15, 27, 60, 63, 79, 87, 99, 100, 101, 102, 108], "disk": [89, 94], "disper": 57, "displai": [13, 26, 46, 50, 53, 103, 104], "dissimilar": 13, "dist": [21, 22, 102], "dist_arr": 23, "dist_box": 22, "dist_matrix": 12, "distanc": [3, 6, 8, 13, 15, 16, 18, 19, 21, 26, 27, 30, 32, 33, 36, 38, 40, 42, 44, 50, 52, 53, 60, 105, 106, 109], "distance_arrai": [21, 23], "distance_typ": 105, "distancematrix": 12, "distant": 44, "distinguish": [3, 34], "distopia": [3, 105], "distribut": [2, 3, 6, 7, 15, 30, 35, 38, 41, 42, 44, 45, 70, 100, 102], "diverg": [14, 42, 43, 44, 45], "divers": 53, "divid": [15, 26, 33, 43, 50], "divis": 101, "dl": 63, "dl_poli": [58, 59, 61, 97, 105], "dlphhvdw08": [33, 104], "dlpoli": 63, "dlpolypars": 63, "dm": [58, 59, 61, 97, 109], "dmap": 33, "dmitri": 53, "dmonstrat": 34, "dmpc": 106, "dmsparser": 69, "dmsreader": 69, "do": [1, 3, 4, 6, 10, 11, 12, 13, 15, 16, 19, 22, 26, 27, 28, 30, 34, 37, 42, 44, 45, 46, 48, 50, 52, 53, 95, 99, 101, 102, 103, 105, 108, 114], "do_": 87, "doc": [4, 9, 10, 11, 13, 14, 22, 23, 24, 30, 31, 34, 36, 37, 38, 40, 42, 43, 44, 45, 46, 49, 102], "dock": 78, "docstr": 4, "document": [2, 5, 7, 15, 19, 22, 26, 30, 43, 48, 53, 66, 76, 89, 94, 105, 106, 108, 113], "documentation_pag": 3, "docutil": 3, "doe": [3, 4, 10, 13, 14, 15, 16, 19, 27, 30, 34, 40, 48, 52, 53, 55, 57, 63, 66, 71, 72, 80, 81, 82, 84, 87, 88, 92, 100, 101, 102, 105, 106, 108, 109, 110, 111, 112, 114], "does_not_exist": 1, "doesn": [13, 50, 92, 96, 98], "doi": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 104], "domain": [0, 7, 13, 14, 17, 19, 22, 23, 50], "domain_view": 50, "domanski": [45, 52, 53], "doma\u0144ski": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "domin": [33, 38], "don": [3, 10, 11, 18, 24, 26, 30, 40, 42, 53, 55, 100, 105, 111], "done": [3, 4, 14, 16, 30, 109, 114], "doniach": [19, 20, 104], "donor": [26, 27, 28, 84, 105], "donor_index": 26, "donor_ix": 26, "donor_resnam": 26, "donor_sel": 26, "donor_typ": 26, "donors_sel": 26, "dot": 33, "dotson": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "doubl": [64, 105], "dougla": [9, 10, 11, 12, 13, 14, 33, 53, 104], "down": [15, 100, 106], "download": [4, 5, 6, 14, 15, 100, 102, 108], "downsid": 15, "dozen": 57, "dr": 36, "drawn": [30, 44, 107, 111], "drdomenicomarson": 105, "dre": [42, 44], "dres0": 44, "dres1": 44, "dres2": 44, "dres_ax": 43, "dres_ax2": 43, "dres_conv": 43, "dres_conv2": 43, "dres_converg": [42, 43], "dres_fig": 43, "dres_fig2": 43, "driven": 108, "drm": [43, 44], "drop": [19, 43, 100, 105], "dropdown": 4, "dsiplac": 105, "dt": [27, 33, 34, 57, 61, 81, 88, 95, 105, 107, 114], "dt3": 107, "dt5": 107, "dtype": [0, 26, 30, 48, 49, 50, 98, 103, 109], "due": [26, 34, 44, 71, 83, 102, 105], "duecredit": 3, "duecredit_en": 104, "dump": [26, 58, 59, 61, 97, 103, 105], "dumpread": 76, "duplic": [1, 30, 53, 103, 106], "dure": [4, 10, 13, 15, 19, 57, 89, 103], "dx": [26, 27, 28, 46, 48, 104], "dylan": [26, 27, 28], "dynam": [4, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 48, 49, 52, 55, 99, 104, 105, 110, 111, 112, 114], "e": [0, 1, 3, 4, 5, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 60, 67, 80, 82, 99, 100, 101, 102, 103, 104, 105, 106, 108, 109, 112, 113, 114], "e1004415": [42, 43, 44, 45, 104], "e1004568": [46, 104], "e1005659": 52, "e59c36ab66f4": 109, "each": [0, 1, 3, 4, 6, 7, 9, 10, 12, 13, 14, 15, 16, 21, 22, 23, 26, 27, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 42, 44, 45, 46, 47, 48, 50, 53, 55, 57, 60, 61, 66, 96, 98, 99, 101, 102, 103, 105, 108, 109, 111, 112, 113, 114], "earli": 4, "earlier": [12, 16, 105, 108], "eas": 85, "easi": [3, 12, 18, 104, 112], "easier": [3, 4, 13, 26, 33, 34, 44, 55, 105], "easiest": [4, 33, 34, 53], "easili": [13, 15, 16, 24, 30, 34, 39, 43, 53, 55, 99, 101, 109], "eastman": 52, "eaton": [19, 20, 104], "ech": 84, "echo": 5, "edg": [30, 105], "edit": [3, 34, 102, 104], "editconf": 50, "editor": [3, 15, 45, 52, 53, 104], "edr": 105, "edrread": [57, 105], "effect": [3, 7, 10, 32, 43, 100], "effici": [10, 11, 13, 26, 27, 89, 94, 99, 111], "eha": 84, "eigenvalu": [33, 34, 38], "eigenvector": [7, 32, 33, 34, 38], "einsteinmsd": 105, "either": [3, 12, 13, 15, 19, 27, 30, 43, 45, 57, 62, 83, 103, 106, 109], "ej": [45, 50], "elast": [6, 7, 35], "electron": [83, 86, 105], "element": [1, 42, 50, 53, 60, 61, 65, 66, 70, 81, 82, 86, 97, 105, 109, 114], "elementwis": 13, "elena": [26, 27, 28, 42, 43, 44, 45, 104], "elimin": 106, "elizabeth": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "elpi": 3, "els": [3, 37, 83, 101], "elsevi": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 30, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55, 104], "elsewher": 100, "emac": 3, "emb": [4, 7, 32, 33, 55], "embed": [33, 44], "embrac": 108, "emerg": 108, "emphasi": 61, "emphasis": 42, "emploi": 67, "empti": [14, 50, 83, 105, 106, 109, 114], "en": [15, 30, 57, 104], "enabl": [4, 15, 85, 89, 94, 104, 105, 108], "enclos": 3, "encod": [84, 109], "encor": [7, 41, 42, 43, 44, 45, 104, 105], "encount": [61, 79, 100, 105], "encourag": [2, 108], "end": [3, 4, 15, 45, 81, 108, 111], "endbranch": 82, "endian": 90, "endmdl": 81, "endroot": 82, "ener": 57, "energi": [19, 20, 52, 57, 104], "engin": 108, "enhanc": [2, 3], "enough": [11, 12, 14, 37, 57], "ensembl": [6, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 41, 46, 48, 49, 50, 55, 104], "ensemble1_mean": 45, "ensur": [4, 36, 100, 102, 103, 106, 108], "ent": [58, 59, 61, 82, 93, 97, 109], "enter": 96, "enthalpi": 57, "entir": [10, 11, 13, 30, 36, 37, 40, 53, 103, 106, 108, 114], "entireti": 106, "entiti": 3, "entri": [3, 4, 30, 40, 66, 83, 102, 105], "enumer": [12, 30, 42, 44], "env": [3, 4, 11, 12, 13, 15, 16, 18, 20, 21, 28, 33, 37, 38, 40, 42, 43, 44, 45, 49, 108], "environ": [5, 79, 100, 104], "enzym": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 53, 55], "eoss4": 105, "ep": 42, "epot": 57, "epsilon": [33, 109], "epsilon14": 109, "equal": [3, 19, 24, 42, 43, 108], "equat": [3, 13, 14, 108], "equilibrium": [14, 52], "equiv": 46, "equival": [1, 27, 48, 87], "err_msg": 108, "error": [1, 3, 4, 9, 49, 53, 72, 79, 89, 94, 100, 101, 105, 108], "especi": [3, 4, 27, 67, 100, 102], "essenti": [7, 32, 33, 34, 104, 108], "estim": [7, 12, 41, 45], "estimate_error": [42, 44], "et": [12, 26, 27, 28, 53], "etc": [15, 50, 61, 87, 92, 102, 105, 114], "ev": 113, "evalu": [1, 6, 7, 34, 41, 49, 106], "even": [9, 15, 18, 22, 48, 53, 60, 61, 66, 68, 102, 104, 105, 106, 108, 109, 110, 111], "evenli": 15, "eventu": 3, "everi": [1, 3, 4, 10, 14, 15, 16, 24, 27, 30, 31, 34, 37, 39, 42, 44, 48, 50, 52, 53, 57, 60, 61, 98, 103, 105, 106, 108, 109, 111, 114], "everybodi": 99, "everyon": 108, "everyth": [1, 3, 4, 48, 53, 98, 101, 102], "evolv": 2, "ex": 30, "exact": [44, 108], "exactli": [4, 16, 88, 109], "examin": [15, 33, 50], "exampl": [0, 1, 3, 4, 7, 8, 9, 11, 13, 15, 16, 19, 26, 27, 28, 30, 34, 37, 39, 40, 42, 43, 48, 50, 52, 53, 57, 60, 66, 78, 83, 87, 96, 98, 100, 101, 102, 103, 104, 106, 108, 109, 110, 111, 113, 114], "exascal": 15, "except": [11, 15, 37, 43, 44, 81, 82, 101, 103, 109, 113], "exchang": [7, 32, 33], "exclud": [100, 105], "exclude_sam": 105, "exclus": [36, 87, 105], "exclusion_block": 36, "execut": [3, 15, 30, 48, 108, 112], "exemplar": 42, "exist": [3, 15, 19, 37, 53, 60, 103, 108, 109], "exit": [3, 30], "exp": [27, 31], "expand": [3, 4, 44, 84], "expect": [3, 9, 10, 14, 19, 34, 37, 39, 48, 50, 55, 76, 99, 105, 106, 108, 109], "experi": 3, "experienc": 100, "experiment": [3, 30], "explain": [3, 34], "explan": [3, 4, 9, 11, 30, 53], "explicit": [7, 32, 33, 109], "explicitli": [15, 30, 53, 61, 66, 88, 101, 114], "explor": [7, 15, 32], "expon": 33, "exponenti": 31, "export": [3, 5, 48, 53, 104, 106], "expos": 105, "express": [3, 4, 13, 106], "ext": [65, 84], "extend": [3, 23, 24, 50, 58, 59, 61, 65, 84, 97, 106], "extendedpdbpars": 93, "extendedpdbread": 93, "extens": [0, 3, 4, 18, 30, 53, 57, 61, 79, 81, 88, 96, 99, 102, 103, 105], "extern": [3, 5, 7, 48, 100, 101, 105, 106], "externalradiu": 106, "extra": [4, 15, 16, 30, 83, 100], "extra_cflag": 100, "extra_format": 105, "extra_requir": 105, "extract": [7, 26, 32, 53, 57, 98, 104], "extract_": 87, "ey": 102, "f": [3, 4, 11, 15, 26, 27, 28, 30, 34, 37, 39, 40, 46, 53, 57, 60, 98, 104, 105, 113], "fac": [34, 114], "face": 48, "facetgrid": 34, "facil": 57, "fact": 12, "factor": [10, 34, 39, 42, 48, 55, 61, 81, 82, 109, 113], "fail": [3, 71, 83, 88, 89, 94, 100, 102, 105], "failur": [3, 4, 102, 108], "fall": [79, 108, 109], "fals": [1, 4, 9, 11, 14, 19, 20, 26, 27, 30, 40, 44, 46, 48, 50, 53, 57, 78, 103, 105, 106, 108, 109, 110, 114], "fan": [15, 104], "fanci": [1, 53, 110], "faq": 4, "fast": [7, 8, 9, 10, 11, 12, 13, 14, 15, 33, 53, 79, 99, 103, 104], "fasten": [3, 105], "faster": [3, 26, 79, 100], "fault": 3, "favor": 105, "favour": 105, "feasibl": 10, "featur": [2, 3, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 83, 99, 100, 102, 114], "februari": [30, 104], "feedstock": 102, "feel": [2, 3], "femtomet": 113, "femtosecond": [52, 66, 68, 113], "fene": 87, "ferguson": [33, 104], "fetch": 3, "fetch_adk_equilibrium": [5, 14, 15], "few": [13, 15, 34, 48, 100, 108, 112], "fewer": [42, 88], "ff": 83, "ffast": 105, "fhi": [58, 59, 61, 97], "fhiaim": [58, 59, 61, 97, 109], "fhiaimspars": 73, "fhiaimsread": 73, "fhiaimswrit": 73, "field": [26, 30, 53, 60, 66, 82, 83, 87, 93, 106, 107, 109], "fig": [23, 24, 33, 45, 46, 48], "fig0": [42, 44], "fig1": [42, 44], "fig2": [23, 24, 42, 44], "fig_polar": 37, "figshar": [5, 14, 104], "figsiz": [42, 44], "figur": [4, 23, 24, 37, 44, 46, 48, 50, 61], "file": [0, 2, 3, 5, 50, 53, 56, 58, 59, 60, 61, 63, 66, 67, 68, 70, 77, 78, 79, 80, 82, 85, 86, 91, 92, 95, 96, 97, 98, 99, 100, 101, 104, 105, 106, 109, 111], "filenam": [10, 11, 14, 30, 57, 96, 103], "fill_alpha": 30, "fill_valu": 26, "filter": 105, "filterwarn": [9, 10, 14, 22, 23, 24, 27, 30, 34, 46, 50, 52, 53], "final": [3, 4, 10, 13, 15, 19, 39, 40, 48, 87, 102, 106], "finalis": [16, 102], "find": [3, 7, 16, 19, 25, 37, 40, 55, 67, 92], "fine": 105, "finicki": 12, "finish": [3, 16], "firefli": 70, "first": [1, 3, 4, 7, 9, 10, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 24, 26, 27, 30, 31, 32, 33, 34, 36, 37, 38, 40, 42, 44, 45, 46, 48, 49, 50, 53, 55, 57, 61, 69, 72, 81, 83, 89, 94, 98, 100, 101, 105, 106, 108, 110, 111, 114], "first_clust": 42, "first_hbond": 26, "firstli": 108, "fit": [6, 14, 27, 31, 39, 42, 46, 48, 53, 56, 112], "fit_ac": 27, "fit_biexponenti": 27, "fit_rot_tran": [48, 112], "fit_t": 27, "fiter": 110, "five": [33, 34, 53, 93], "fix": [2, 3, 4, 48, 49, 68, 72, 102], "fkdd07": [19, 20, 104], "flag": [3, 4, 84, 86, 103, 105, 108], "flake8": 3, "flaki": 102, "flat": [24, 30, 44, 48], "flatten": [24, 30, 34, 48], "flavour": 84, "flexibl": [14, 15, 16, 23, 30, 59, 63, 85, 99, 104, 105], "flip": 9, "float": [48, 83, 105, 108, 109, 112], "float32": [49, 103], "float64": [26, 109], "florian": [34, 104], "fluctuat": [6, 7, 8, 13, 19, 27, 34], "fluid": [26, 27, 28], "fly": [14, 111, 114], "fm": 113, "fnmatch": 106, "focu": 99, "focus": [15, 99], "fold": [7, 17, 19, 20, 104], "folder": [3, 30, 108], "follow": [3, 4, 13, 16, 18, 23, 26, 27, 30, 34, 38, 46, 48, 53, 57, 60, 61, 63, 65, 67, 79, 81, 83, 87, 88, 91, 95, 100, 101, 102, 103, 105, 106, 108, 109, 114], "follw": 26, "foo": 108, "footnot": 82, "footprint": 57, "forc": [3, 26, 50, 52, 53, 57, 58, 60, 61, 63, 89, 94, 103, 105, 106, 107, 109, 111, 114], "forcefield": 26, "foremost": 98, "forg": [4, 100], "form": [2, 13, 19, 26, 42, 53, 55, 60], "formal": 105, "formalcharg": [105, 109], "format": [10, 13, 14, 19, 21, 22, 23, 30, 31, 33, 34, 36, 37, 40, 42, 43, 44, 45, 48, 52, 53, 58, 60, 62, 64, 65, 66, 67, 69, 70, 71, 72, 73, 76, 78, 80, 83, 84, 85, 86, 88, 89, 91, 92, 93, 94, 95, 97, 98, 99, 102, 104, 105, 106, 111, 113, 114], "formatt": 3, "former": [13, 52, 108], "fortran": 3, "fortran77": 30, "found": [4, 5, 19, 26, 28, 30, 31, 37, 42, 53, 103], "foundat": [9, 10, 11, 12, 13, 14, 33, 104], "four": [4, 26, 39, 44, 45, 103, 109], "fourier": 87, "fourth": [30, 111], "fowler": [30, 104], "fpkd11": [33, 104], "frac": [13, 16, 19, 24, 27, 31, 36, 109, 113], "fraction": [6, 7, 17, 18, 20, 21, 76], "fraction_contacts_between": 18, "fragil": 60, "fragindic": 108, "fragment": [0, 31, 48, 49, 50, 55, 105, 106, 108], "frame": [1, 7, 9, 10, 12, 13, 14, 16, 17, 18, 19, 20, 21, 26, 27, 30, 32, 33, 34, 36, 37, 38, 39, 40, 43, 44, 46, 48, 49, 52, 55, 56, 61, 66, 71, 81, 82, 89, 94, 99, 105, 106, 108, 110, 111, 112, 114], "frame_index": 15, "frame_open": 12, "frame_valu": 15, "frameiter": 110, "framework": [15, 99, 108], "franklin": [19, 20, 104], "free": [2, 3, 101], "freez": 102, "frequenc": [38, 104], "frequent": [13, 14, 26, 57, 100], "friction": 52, "friend": 3, "from": [0, 2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 17, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 55, 56, 57, 58, 60, 61, 63, 64, 65, 66, 67, 68, 69, 72, 75, 76, 78, 79, 81, 82, 83, 84, 87, 91, 92, 93, 94, 95, 96, 98, 99, 100, 101, 102, 103, 104, 105, 106, 107, 108, 110, 111, 112, 113], "from_file_view": 9, "from_smil": 105, "fudge_factor": 60, "full": [3, 4, 26, 30, 44, 57, 66, 85, 89, 100, 102, 112], "fulli": [16, 30, 100, 108], "func": [3, 15], "funcion": 26, "function": [1, 2, 3, 4, 6, 7, 8, 13, 17, 19, 20, 21, 27, 30, 33, 34, 35, 37, 41, 42, 43, 44, 45, 46, 52, 53, 55, 56, 57, 85, 87, 98, 100, 101, 102, 104, 105, 106, 109, 111, 112, 114], "functool": [15, 112], "fundament": [53, 56, 114], "further": [3, 4, 13, 15, 27, 50, 52, 53, 60, 62, 87, 98, 100, 105, 106], "futher": 108, "futur": [3, 15, 101, 105, 108], "fver": 87, "fver_err": 87, "g": [1, 3, 4, 5, 7, 14, 15, 19, 20, 26, 30, 32, 33, 34, 37, 53, 57, 67, 80, 99, 100, 101, 102, 103, 104, 106, 107, 108, 109, 112, 113, 114], "g2707": 105, "g96": 87, "g_": [36, 40], "g_pickl": 103, "gain": 12, "galleri": 53, "gamess": [58, 59, 61, 97], "gamma": [22, 39, 50, 55, 67, 81, 82], "gamma_": 46, "gap": [33, 103], "gasteig": 82, "gate": [30, 104], "gather": [15, 30], "gaussian": [44, 45], "gave": 4, "gazzarrini": [26, 27, 28], "gb": [15, 57], "gbn2": 52, "gbscreen": 109, "gcc": [3, 100], "gecht": [15, 104], "gen_release_not": 102, "gener": [2, 3, 4, 7, 8, 9, 10, 14, 15, 18, 19, 20, 28, 30, 34, 37, 38, 39, 48, 50, 53, 55, 58, 59, 61, 67, 77, 80, 89, 94, 99, 102, 103, 104, 105, 113, 114], "generate_path": 46, "generate_t": 105, "geometr": [1, 6, 7, 26, 41, 52], "geometri": [7, 13, 23, 30, 32, 33, 37, 39, 48, 50, 53, 104, 106, 109, 112], "gerhard": [34, 104], "get": [3, 4, 13, 15, 16, 24, 34, 36, 40, 42, 43, 44, 45, 48, 61, 72, 79, 86, 87, 89, 98, 99, 100, 105, 108, 109], "get_aux_attribut": 57, "get_aux_descript": 57, "get_auxreader_for": 57, "get_cdf": 40, "get_conversion_factor": 113, "get_data": 57, "get_data_hom": 5, "get_descript": 57, "getmonomerinfor": 105, "getnam": 105, "gh": [3, 102], "gia": 104, "gif": [10, 14, 34, 39, 48, 55], "gist": 50, "git": [3, 4, 100, 102], "github": [4, 6, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 33, 38, 39, 43, 44, 49, 99, 100, 101, 102, 105], "give": [3, 4, 7, 16, 17, 19, 21, 23, 24, 31, 37, 40, 44, 49, 53, 67, 98, 100, 108, 110, 112, 114], "given": [3, 4, 12, 15, 19, 20, 22, 24, 28, 34, 37, 39, 40, 44, 48, 53, 57, 60, 102, 103, 105, 106, 109, 112, 113, 114], "gkm342": [19, 20, 104], "gl": 106, "glb": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "glh": 107, "gln": [53, 106, 107], "global": [3, 7, 32, 33, 34, 101, 106], "global_ax": 39, "global_axi": 39, "global_tilt": 39, "glu": [18, 19, 21, 27, 53, 106, 107], "gluh": 107, "glutam": 53, "glx29": 106, "gly": [27, 37, 53, 96, 98, 106, 107], "gm": [58, 59, 61, 97, 109], "gmsparser": 70, "gmsreader": 70, "gmx": [48, 89, 94, 96, 114], "gmxdump": 87, "gmxfio_rw": 87, "gmxfio_xdr": 87, "gmxfiofio": 87, "gmxlib": 87, "gnm": 38, "gnmanalysi": 38, "gnu": [2, 108], "go": [2, 3, 4, 15, 16, 96, 102, 106], "good": [3, 4, 102], "goodfellow": [30, 104], "gov": [30, 104], "gower": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "gp": [34, 104], "gplv2": 105, "gplv3": 105, "gradual": [19, 105], "grai": 50, "grain": [1, 9, 19, 20, 53, 104], "gram": 52, "gramicidin": [30, 104], "grant": 105, "graph": [13, 15], "graphic": [9, 10, 30, 52, 55, 96, 104], "great": [2, 4], "greater": [18, 26, 27, 33, 106], "greatest": 46, "green": [14, 15, 22, 102, 108], "grid": [24, 48, 50], "grid_siz": 50, "griddataformat": [3, 101], "gro": [37, 42, 44, 45, 46, 53, 58, 59, 61, 87, 97, 103, 105, 109, 114], "groamc": 105, "gromac": [0, 16, 48, 50, 57, 58, 59, 61, 85, 96, 97, 98, 103, 105], "gromacs_dir": 87, "gromacswrapp": 96, "gromo": 107, "gromos11": [58, 61, 105], "gropars": 71, "groread": 71, "grossfield": 12, "ground": 99, "group": [0, 13, 22, 30, 31, 34, 40, 42, 43, 49, 50, 83, 84, 96, 103, 105, 106, 108, 109, 112, 114], "group_a": 21, "group_b": 21, "groupbi": [53, 108], "groupselect": [13, 53], "grow": [2, 5, 108], "growrit": 71, "gsd": [3, 58, 59, 61, 97, 105, 109], "gsdparser": 72, "gsdreader": 72, "gsoc": 105, "gt": [9, 10, 12, 13, 14, 15, 16, 18, 22, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 40, 42, 43, 44, 46, 48, 49, 50, 52, 53], "gua": 107, "guarante": [26, 83], "guard": 101, "guess": [13, 28, 50, 53, 57, 61, 65, 67, 81, 92, 97, 103, 105, 109], "guess_bond": [60, 109, 114], "guesser": [60, 105], "gui": 96, "guid": [2, 3, 6, 7, 11, 12, 13, 15, 16, 18, 20, 21, 28, 33, 37, 38, 40, 42, 43, 44, 45, 49, 69, 100, 108], "guidelin": [2, 105], "gyrat": [53, 105, 109], "gyration_mo": 109, "gzip": 105, "h": [1, 3, 27, 31, 36, 39, 45, 50, 52, 53, 78, 87, 96, 98, 103, 106], "h1": [26, 28, 50, 52, 78], "h2": [1, 26, 28, 50, 78], "h2o": 50, "h3": 78, "h4": 78, "h5": 78, "h5md": [58, 61, 105], "h5mdreader": 105, "h5mdwriter": 105, "h5py": 3, "h6": 78, "h_": 27, "h_ix": 27, "h_pickl": 103, "ha": [0, 2, 3, 7, 9, 10, 11, 13, 14, 15, 16, 18, 19, 22, 23, 24, 28, 29, 30, 34, 36, 40, 42, 43, 44, 45, 46, 48, 50, 52, 53, 55, 70, 87, 96, 98, 100, 102, 103, 105, 106, 108, 109, 111, 114], "ha1": 53, "ha2": [30, 53, 98], "ha3": 98, "habit": 108, "had": [43, 102, 105], "hai": [9, 10, 52, 55, 104], "hakarishirenai": 105, "half": [19, 37], "hall": [38, 104], "hand": [87, 108], "handl": [3, 15, 79, 105, 112], "happen": [3, 89, 101, 106], "happi": [3, 22], "hard": [15, 79, 106], "hard_cut": 19, "hard_cut_q": 19, "harmon": [6, 7, 19, 20, 33, 41, 87, 104], "harold": 104, "harrigan": 52, "hasattr": [50, 53, 109], "have": [1, 2, 3, 4, 10, 11, 12, 13, 14, 15, 16, 18, 19, 22, 24, 26, 27, 30, 31, 33, 34, 36, 37, 40, 42, 44, 45, 46, 48, 50, 53, 55, 57, 60, 63, 66, 67, 69, 71, 75, 79, 81, 82, 84, 87, 89, 95, 98, 100, 101, 102, 103, 104, 105, 106, 107, 108, 109, 110, 114], "hb": [26, 36], "hb1": [53, 98], "hb2": [53, 98], "hb3": 98, "hbl": 27, "hbond": [26, 27, 28, 52, 105], "hbond_analysi": [26, 27, 28, 105], "hbond_lifetim": 27, "he": [27, 28, 45], "he1": 53, "he2": 53, "he3": 53, "head": [3, 18, 19, 20, 21, 33, 34, 53], "header": [66, 81, 87, 91, 105], "headgroup_atom": 26, "heat": [12, 46, 48, 52], "heatmap": [12, 24, 46], "heavi": [98, 105], "heetvekariya": 105, "height": 26, "hel": 39, "helan": [39, 104], "helanal_imag": 39, "held": [3, 109], "helic": [39, 104], "helix": [6, 7, 35, 104, 105], "helix_analysi": [39, 105], "help": [1, 2, 3, 4, 13, 16, 22, 96, 99, 100, 106, 108], "helper": [30, 44], "henc": [3, 4], "herbst": [33, 104], "here": [3, 4, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 60, 78, 100, 102, 105, 107, 109], "hereman": [33, 104], "herman": [34, 104], "hes02": [34, 104], "hess": 104, "hetatm": [82, 83, 98, 109], "hg1": [27, 36, 53], "hg2": 53, "hg21": 36, "hg22": 36, "hg23": 36, "hh": 27, "hh11": [27, 28, 83], "hh12": 28, "hh21": 28, "hh22": [27, 28], "hi": [28, 53, 105, 107], "hid": 107, "hidden": [4, 53, 89, 94, 104], "hie": 107, "hierarchi": [46, 98], "high": [3, 4, 7, 14, 15, 32, 34, 42, 45, 52, 85, 106], "higher": [10, 13, 33, 42, 105], "highest": [14, 34, 40, 48, 50], "highli": [3, 26, 61, 85, 100], "highlight": [22, 38, 57, 102, 108], "hip": 107, "hire": 57, "hiromu": 104, "his1": 107, "his2": 107, "hisa": 107, "hisb": 107, "hisd": 107, "hise": 107, "hish": 107, "hist": [26, 38], "hist_bin_edg": [49, 105], "histax": 38, "histfig": 38, "histidin": 53, "histogram": [26, 30, 48, 105], "histogram_radii": 30, "histogramdd": 105, "histor": [3, 4], "histori": [58, 59, 61, 97, 105, 109], "historypars": 63, "historyread": 63, "hit": [3, 4, 108], "hitchhik": 3, "hkp": [38, 104], "hmacdop": 105, "hn": [28, 53], "hnh": 53, "hoc": 60, "hoh": 30, "hold": [37, 53, 99, 111, 114], "hole": [7, 100, 104, 105], "hole000": 30, "hole001": 30, "hole002": 30, "hole003": 30, "hole004": 30, "hole005": 30, "hole006": 30, "hole007": 30, "hole008": 30, "hole009": 30, "hole010": 30, "hole1": 30, "hole2": [3, 6, 7, 29, 105], "holeanalysi": 30, "holoview": 12, "home": [3, 4, 11, 12, 13, 15, 16, 18, 20, 21, 28, 33, 37, 38, 40, 42, 43, 44, 45, 49], "homepag": 4, "homogen": [36, 40], "hoomd": [58, 59, 61, 97], "hoomdxmlpars": 92, "hope": 105, "host": [2, 3, 5], "how": [3, 4, 10, 12, 13, 14, 15, 16, 18, 21, 23, 24, 27, 28, 30, 34, 38, 39, 40, 42, 43, 44, 53, 55, 71, 78, 84, 100, 102, 106, 108, 112, 113, 114], "howev": [0, 1, 3, 4, 7, 9, 10, 13, 14, 15, 16, 19, 26, 27, 30, 31, 32, 34, 39, 44, 48, 50, 52, 53, 55, 57, 67, 69, 71, 72, 84, 87, 89, 96, 98, 100, 101, 102, 103, 105, 108, 109, 114], "hpc": 15, "hri": 104, "hsd": [53, 107], "hse": [53, 107], "hsp": 107, "hstack": 10, "ht": 26, "ht1": 53, "ht2": 53, "ht3": 53, "html": [3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104, 108], "htmlcov": 108, "http": [3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 100, 104, 105], "hue": [33, 34], "hummer": [19, 20, 104], "hupe": 104, "hw16365": 40, "hyaluron": [26, 27, 28], "hydrogen": [50, 84, 98, 105, 106], "hydrogen_bond": [7, 25], "hydrogen_index": 26, "hydrogen_ix": 26, "hydrogen_sel": 28, "hydrogenbond": [26, 27, 28, 105], "hydrogenbondanalysi": [26, 27, 28, 105], "hydrogenbondanaysi": [26, 27, 28], "hydrogenbondlifetim": 105, "hydrogenbondsanalysi": 26, "hydrogens_sel": [26, 27, 28], "hydrogon": 26, "hyp": 107, "hypothesi": 3, "hz1": 28, "hz2": [27, 28], "hz3": [27, 28], "i": [0, 1, 2, 3, 4, 5, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 56, 57, 60, 61, 65, 66, 67, 68, 69, 70, 71, 73, 75, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 89, 91, 93, 94, 95, 96, 98, 99, 100, 101, 102, 103, 104, 105, 106, 108, 109, 110, 111, 112, 114], "i10": 84, "i4": 84, "i8": 84, "iac": 84, "ian": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "ibisco": [58, 59, 61], "icod": [14, 61, 81, 82, 97, 106, 109], "id": [3, 13, 23, 24, 26, 42, 43, 44, 45, 50, 61, 65, 66, 69, 75, 83, 84, 87, 98, 104, 106, 109], "id_var": 34, "idea": [2, 3, 53, 102], "ideal": 108, "ident": [3, 4, 12, 16, 42, 44, 72, 87, 114], "identif": [26, 34, 104], "identifi": [14, 26, 28, 42, 81, 82, 92], "iederhut": 104, "ignor": [4, 9, 10, 14, 22, 23, 24, 27, 30, 33, 34, 37, 46, 50, 52, 53, 81, 82, 84, 95, 105, 106, 114], "ignore_residu": 30, "ii": 84, "ij": [27, 48], "il": [37, 53, 105, 106, 107, 109], "ildn": 107, "illon": 104, "illustr": [15, 28, 33, 48], "im": [23, 24, 45, 48], "im0": [42, 44], "im1": [42, 44], "im2": [23, 24], "imag": [4, 9, 10, 12, 14, 15, 19, 22, 23, 34, 39, 50, 55, 105, 108], "imi": [42, 44], "immedi": [7, 15, 19, 32, 33, 102, 108], "imov": 84, "impact": [105, 114], "implement": [1, 3, 7, 9, 10, 11, 12, 13, 14, 15, 16, 32, 33, 34, 39, 53, 57, 62, 66, 76, 82, 87, 95, 106, 112], "implicitli": 15, "implicitsolv": 52, "import": [1, 3, 5, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 56, 57, 60, 78, 83, 87, 93, 96, 98, 102, 103, 105, 106, 109, 110, 111, 112, 114], "importantli": 108, "importerror": [3, 101, 108], "importorskip": 108, "improp": [53, 61, 66, 84, 86, 97, 109, 114], "improperdihedr": [1, 109], "improv": [2, 27, 99, 108], "imshow": [12, 23, 42, 44, 45, 48], "in1d": 105, "in_memori": [10, 11, 12, 14, 34, 55, 103, 114], "in_memory_step": 114, "inaccur": 53, "inact": 82, "includ": [2, 3, 4, 7, 9, 10, 13, 14, 15, 16, 19, 34, 36, 37, 39, 43, 48, 50, 52, 53, 55, 57, 84, 85, 87, 95, 96, 98, 99, 100, 102, 104, 105, 106, 108, 109, 111, 112, 114], "inclus": [53, 93, 105, 106], "incompat": [102, 105], "inconsist": [4, 105], "incorpor": 13, "incorrect": [105, 114], "incorrectli": [53, 83, 84, 105], "increas": [3, 27, 33, 42, 43, 44, 85, 102, 105, 108], "increasingli": 15, "increment": 83, "inde": [14, 19, 44], "indent": 3, "independ": [11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 33, 38, 39, 42, 43, 44, 45, 49, 57, 101], "index": [3, 4, 11, 13, 15, 16, 19, 26, 27, 30, 31, 33, 34, 40, 48, 53, 56, 75, 83, 84, 87, 96, 103, 105, 108, 109, 110, 111], "indexerror": 108, "indic": [1, 3, 12, 13, 14, 19, 24, 26, 27, 30, 33, 34, 38, 40, 43, 50, 53, 81, 82, 84, 87, 91, 96, 101, 105, 106, 108, 109, 110], "individu": [3, 4, 7, 13, 30, 38, 49, 53, 57, 77, 96], "inertia": [42, 43, 109], "infer": [13, 19, 105], "info": [3, 27], "inform": [1, 3, 4, 7, 10, 12, 14, 15, 16, 19, 22, 26, 28, 30, 32, 33, 34, 37, 40, 42, 43, 44, 46, 50, 52, 56, 57, 60, 62, 63, 66, 69, 70, 71, 72, 80, 81, 82, 84, 87, 88, 94, 95, 98, 101, 103, 105, 106, 108, 111, 112, 114], "informatin": 92, "inh": 82, "inherit": [3, 108], "ini": 4, "init": [42, 43], "initi": [13, 14, 16, 19, 48, 108, 113], "initial_contact": 19, "initial_tim": 57, "initialis": [16, 42, 44, 49, 53, 57], "inlin": [3, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 53], "inner": 106, "innerradiu": 106, "inpcrd": [58, 59, 61], "inplac": [3, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 33, 38, 39, 42, 43, 44, 45, 49], "inpread": 74, "input": [15, 23, 48, 58, 59, 61, 63, 68, 87, 97, 105, 109, 112, 114], "insensit": 106, "insert": [81, 82, 84, 93, 106, 109], "insid": [15, 53, 96, 101, 108], "insight": [7, 9, 10, 11, 12, 13, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 104], "instal": [2, 3, 4, 5, 7, 10, 30, 33, 34, 42, 43, 44, 46, 48, 53, 55, 79, 101, 104, 105, 108], "instanc": [1, 36, 50, 53, 57, 78, 106, 114], "instead": [1, 3, 4, 9, 10, 12, 14, 15, 16, 19, 23, 24, 30, 34, 37, 39, 43, 44, 48, 50, 55, 61, 81, 82, 88, 92, 93, 100, 105, 106, 108, 111, 114], "institut": [34, 104], "instruct": [2, 3, 4, 53, 100], "int": [3, 26, 30, 50, 109, 114], "int64": 109, "int_0": 36, "integ": [26, 66, 72, 81, 82, 83, 102, 105, 108], "integr": [3, 7, 15, 32, 33, 52, 85, 105], "intel": 105, "intend": [98, 100], "intent": [3, 105], "interact": [4, 6, 9, 10, 12, 14, 19, 26, 27, 28, 34, 36, 39, 50, 52, 55, 87, 104, 109], "interest": [1, 19, 30, 48, 53, 100], "interfac": [5, 26, 53], "interface_zpo": 26, "interfer": [3, 100], "intermedi": [30, 104], "intern": [4, 34, 53, 104, 110], "interpol": 48, "interpret": [3, 7, 24, 32, 33, 34, 42, 53, 67, 105], "interrdf": [36, 40, 105], "interrdf_": [40, 105], "intersect": [1, 106], "interv": 34, "intra_angl": 105, "intra_bond": 105, "intra_dihedr": 105, "intramolcular": 28, "intramolecular": 27, "intrins": [7, 32, 33], "introduc": [102, 105], "introduct": [18, 20, 21, 33, 34, 43, 53, 99, 104, 105, 112], "intuit": 34, "invent": 114, "invers": 105, "investig": [13, 34], "invok": 106, "involv": [16, 26, 28, 37, 52, 53, 105, 111], "involve": 26, "io": [4, 15, 79, 98], "ioanni": [15, 33, 104], "ion": [30, 42, 44, 104, 105], "ippa": 104, "ipygani": 48, "ipynb": [4, 43, 114], "ipython": [3, 4, 50, 109], "iqmol": 50, "irdf": 36, "irdf2": 36, "irdf3": 36, "irdf4": 36, "is_anchor": 114, "is_guess": 109, "is_in_contact": 18, "is_strict_subset": 1, "is_strict_superset": 1, "isbn": [34, 104], "isdesnat": 108, "isdisjoint": 1, "isin": 105, "isn": [13, 50], "isnat": 108, "iso": 48, "iso_v": 48, "isol": [3, 4], "isolay": 105, "isolevel": 48, "isolevel_typ": 48, "isscalar": 108, "issu": [2, 3, 4, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 33, 38, 39, 43, 44, 49, 50, 57, 61, 63, 67, 79, 84, 87, 89, 94, 99, 100, 101, 102, 106, 108], "issubset": 1, "issuperset": 1, "isus": 105, "item": [30, 39, 52, 108], "iter": [1, 12, 14, 15, 16, 30, 44, 49, 53, 103, 105, 108, 109, 110, 111], "iter_as_aux": 57, "iter_auxiliari": 57, "itp": [59, 61, 87], "itppars": [75, 105], "its": [1, 2, 3, 4, 7, 9, 13, 15, 18, 19, 20, 22, 30, 32, 33, 44, 46, 49, 52, 53, 98, 99, 100, 101, 103, 106, 108, 109, 111, 112], "itself": [3, 4, 5, 6, 7, 8, 9, 10, 16, 19, 30, 34, 39, 68, 79, 96, 106], "iucr": [9, 10, 11, 12, 13, 14, 33, 104], "j": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 104, 113], "ja071797i": [38, 104], "jaclark5": 105, "jain": [34, 104], "jan": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "jandom": 105, "jane": [37, 104], "janin": [104, 105], "januari": [37, 104], "jason": 52, "jcc": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 52, 53, 55, 104], "jennaswa": 105, "jensen": [42, 43, 44], "jfennick": 105, "jmb": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 30, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 104], "jmol": 96, "job": [15, 42, 44], "job_list": 15, "joblib": [3, 15, 26], "joel": [19, 20, 104], "john": 52, "join": [3, 10, 36, 99, 108], "jol02": [34, 104], "jolliff": [34, 104], "jonathan": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "jone": [66, 68, 76], "josto": 105, "journal": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "jo\u00ebl": [37, 104], "jr": [45, 50], "json": 102, "juan": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55, 104], "juli": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 55, 104], "jump": [103, 105], "june": [14, 27, 33, 104], "jupyt": [6, 9, 10, 13, 26, 52, 55, 100, 104], "jupyter_backend": 48, "jupyterlab": 100, "just": [3, 4, 23, 30, 48, 55, 57, 82, 98, 102, 106, 108, 112], "justifi": 81, "jvermaa": 105, "jwlm78": [37, 104], "k": [9, 10, 11, 14, 24, 30, 33, 40, 42, 43, 48, 52, 53, 57, 104], "k_count": 40, "k_max": 40, "k_valu": 40, "kay": [38, 104], "kcal": 113, "keep": [1, 2, 3, 10, 14, 30, 34, 39, 43, 44, 48, 55, 72, 96, 99, 101, 102, 108], "keep_fil": 30, "kei": [1, 2, 30, 38, 39, 49, 53, 57, 98, 99, 114], "kelvin": 52, "kennei": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "kept": [3, 34, 79], "kernel": [44, 87], "kevrekidi": [33, 104], "keysview": 49, "keyword": [13, 16, 18, 19, 22, 23, 28, 30, 36, 37, 42, 43, 44, 53, 61, 62, 68, 81, 89, 93, 94, 96, 103, 105, 107, 114], "kg": 113, "kilocalori": 52, "kinas": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 53, 55, 104], "kind": [3, 4, 13, 99, 114], "kinet": [33, 52, 57], "kineticenergi": 52, "kirchhoff": 38, "kj": [63, 113], "km1": [42, 43], "km2": [42, 43], "km3": 43, "kmean": [42, 43], "know": [4, 15, 16, 50, 53, 102, 108], "knowledg": [98, 105], "known": [14, 102], "koehl": [19, 20, 104], "kresten": [42, 43, 44, 45, 104], "kullback": 45, "kumar": [39, 46, 104], "kwarg": [15, 18, 19, 57, 105], "kyle": 52, "l": [3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 96, 104], "l_b": 31, "l_p": 31, "la": [33, 104], "label": [12, 13, 14, 15, 16, 22, 23, 24, 27, 37, 38, 42, 43, 44, 45, 46, 50, 99, 102], "labextens": 100, "laci": [30, 104], "lack": [105, 108], "lafon": [33, 104], "lamb": 57, "lambda": [19, 89], "lambda_const": 19, "lammp": [58, 59, 61, 97, 103, 105, 108], "lammpsdata": 66, "lammpsdump": [58, 59, 61, 97, 109], "lammpsdumppars": 76, "lammpsdumpread": 105, "lammpspars": [66, 76, 105], "landscap": [19, 20, 104], "langevin": 52, "langevinintegr": 52, "langl": [14, 27, 31, 36], "languag": [4, 53, 107], "laptop": 15, "larg": [3, 4, 7, 10, 13, 15, 17, 19, 20, 33, 36, 40, 50, 53, 55, 56, 83, 101, 102, 104, 105, 107, 108], "largest": [7, 32, 34, 46, 108], "larsen": [42, 43, 44, 45, 104], "last": [0, 3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 89, 99, 108, 109], "last_fiv": 53, "lat09": [7, 8, 9, 10, 11, 14, 104], "later": [2, 4, 13, 15, 102, 105, 106], "latest": [2, 3, 15, 100, 108], "latex": 3, "latter": [13, 45, 108], "layer": [58, 61, 106], "layout": 105, "lazili": 106, "lb": 31, "lda": [37, 104], "lead": [3, 4, 105, 114], "leaf_siz": 42, "leaflet": 26, "learn": [2, 3, 7, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 33, 38, 39, 42, 43, 44, 49, 99], "least": [3, 16, 31, 39, 42, 46, 67, 83, 98, 108], "leav": [3, 4, 55, 108], "led": 105, "lee": 52, "left": [13, 14, 31, 44, 106, 108], "legaci": [105, 108], "legend": [14, 15, 16, 19, 20, 22, 27, 30, 37, 38, 43, 44], "leibler": 45, "len": [1, 12, 23, 24, 30, 33, 34, 36, 37, 38, 40, 42, 44, 45, 46, 48, 50, 53, 57, 98, 103, 108, 109, 111], "length": [1, 6, 7, 12, 13, 22, 24, 27, 29, 39, 40, 42, 44, 45, 46, 48, 50, 52, 53, 63, 66, 67, 68, 71, 79, 88, 99, 104, 105, 110, 111], "lengthunit": [66, 68, 103], "lennard": [66, 68, 76], "less": [7, 18, 19, 26, 32, 34, 57, 68, 100], "let": [3, 4, 16, 26, 27, 40, 102], "letter": [3, 33, 83, 104], "leu": [37, 53, 107], "level": [1, 3, 4, 15, 48, 85, 98, 101, 108, 114], "leverag": [3, 15], "levitt": [37, 104], "lewin": 48, "lgplv2": 105, "li": 44, "lib": [3, 11, 12, 13, 15, 16, 18, 20, 21, 28, 33, 37, 38, 40, 42, 43, 44, 45, 49, 105, 108], "libmdanalysi": 105, "librari": [3, 9, 10, 14, 15, 19, 33, 34, 39, 46, 48, 50, 55, 58, 61, 62, 79, 80, 85, 99, 101, 102, 104, 105, 108], "licenc": 108, "licens": [2, 15, 105, 108], "licoric": 48, "lid": [13, 14, 22, 23, 50], "lid_atom": 50, "lid_ca": 23, "lid_com": 23, "lid_seg": 50, "lifetim": [7, 25, 26, 28, 89], "ligand": 114, "light": 108, "lighter": [37, 108], "lightweight": [3, 15, 101], "like": [1, 3, 4, 5, 13, 16, 19, 26, 30, 34, 39, 40, 43, 48, 53, 55, 57, 60, 83, 100, 106, 108], "likelihood": [19, 20, 45, 104], "likewis": [60, 87, 106], "lili": [19, 26, 39], "limit": [3, 15, 16, 30, 34, 36, 40, 55, 57, 88], "lin": 49, "lindorff": [42, 43, 44, 45, 104], "line": [0, 3, 4, 12, 13, 26, 27, 30, 33, 43, 48, 49, 57, 81, 83, 91, 95, 96, 98, 100, 105, 108, 114], "line2d": [33, 49, 57], "linear": [6, 7, 31, 32, 34], "lineardens": [48, 49, 105], "lineax": 38, "linefig": 38, "lineplot": 34, "linewidth": 26, "link": [3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 102, 104], "linkag": 46, "linkinghub": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55, 104], "linspac": [26, 27, 49], "linssen": [34, 104], "lint": 3, "linux": [3, 4, 102, 105], "lipid": [26, 27, 28, 106], "lippa": 15, "list": [1, 3, 4, 5, 13, 15, 16, 19, 26, 30, 38, 39, 40, 42, 43, 44, 46, 48, 50, 53, 57, 61, 65, 67, 82, 87, 96, 99, 100, 102, 104, 105, 106, 107, 108, 109, 111, 112, 113, 114], "listen": 99, "literatur": 48, "littl": [44, 90], "liu": [9, 10, 11, 14, 53, 104], "live": 12, "liwo": 104, "lj": 57, "ljwoods2": 105, "ll": [3, 4, 27], "ln": [42, 44], "load": [3, 4, 30, 50, 61, 78, 89, 99, 103, 105, 109, 111, 112], "load_fil": 52, "load_new": [10, 19, 34, 103, 114], "loc": 27, "local": [2, 3, 4, 7, 15, 16, 19, 20, 32, 33, 39, 48, 101, 102, 104, 108], "local_ax": 39, "local_bend": 39, "local_height": 39, "local_helix_direct": 39, "local_nres_per_turn": 39, "local_origin": 39, "local_rotation_vector": 39, "local_screw": 39, "local_screw_angl": 39, "local_twist": 39, "localhost": 4, "locat": [4, 5, 9, 81, 82, 102, 106, 109], "log": [30, 42, 44, 101, 105], "logic": 1, "login": 100, "long": [3, 12, 30, 33, 37, 42, 44, 85, 102, 114], "longer": [3, 12, 27, 57, 71, 105, 106, 108], "look": [2, 3, 4, 10, 12, 13, 15, 19, 23, 24, 26, 28, 36, 37, 39, 48, 55, 61, 83, 86, 92, 96, 98, 108, 111], "lookup": [19, 20, 104], "loop": [15, 16, 55, 108, 111], "loos": 95, "lorenz": [26, 27, 28], "lossless": [59, 85, 94], "lot": [3, 66, 108], "lovel": [37, 104], "low": [3, 7, 12, 14, 32, 42], "lower": [3, 7, 19, 24, 30, 32, 33, 34, 38, 40, 42, 43, 44, 57], "lowest": [38, 46, 50, 105], "lp": 31, "lre": 84, "lresid": 84, "lsegid": 84, "lstring": [81, 82], "lt": [9, 10, 12, 13, 14, 15, 16, 18, 22, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 40, 42, 43, 44, 46, 48, 49, 50, 52, 53], "luckili": 55, "luka": [30, 104], "lw": [26, 27, 48], "lx": [22, 55], "ly": [18, 19, 21, 22, 27, 28, 37, 53, 55, 106, 107], "lyn": 107, "lysh": [98, 107], "lysin": 106, "lysozym": 98, "lz": [22, 55], "m": [3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 102, 104, 113], "m2_view": 10, "m9": [14, 104], "m_i": [16, 109], "machin": [3, 4, 15, 48, 100, 105, 108], "maco": [3, 105], "macosx": 105, "macro": [4, 53, 96], "macromolecular": [9, 10, 11, 14, 46, 53, 59, 104], "made": [2, 3, 4, 26, 48, 71, 103, 105, 106, 109], "madwb11": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "maggioni": [33, 104], "magnitud": 44, "mai": [1, 3, 4, 7, 9, 12, 14, 15, 16, 18, 19, 26, 27, 28, 30, 32, 33, 34, 36, 38, 42, 43, 44, 48, 50, 53, 57, 93, 100, 101, 102, 103, 105, 111], "maigret": [37, 104], "mail": 99, "main": [2, 4, 100], "mainli": 44, "maintain": [3, 4, 6, 99, 108], "maisuradz": 104, "major": [3, 53, 102], "majora": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "make": [2, 3, 4, 7, 8, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 24, 26, 28, 33, 34, 38, 39, 40, 42, 43, 44, 45, 49, 53, 55, 56, 98, 100, 102, 103, 106, 108, 109, 111, 112, 114], "make_ndx": 96, "mamba": [4, 100], "mambaforg": [11, 12, 13, 15, 16, 18, 20, 21, 28, 33, 37, 38, 40, 42, 43, 44, 45, 49], "manag": [3, 15, 30, 53, 96, 100, 104, 108], "mani": [1, 2, 3, 4, 13, 15, 16, 21, 26, 30, 34, 39, 40, 42, 43, 44, 53, 99, 100, 108, 109, 111, 114], "manifold": [7, 32, 33], "manipul": [1, 53, 80, 99], "manner": [3, 102], "manual": [3, 4, 12, 50, 53, 87, 108], "manuel": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "map": [3, 4, 6, 7, 12, 15, 30, 32, 34, 44, 46, 48, 57, 104, 108], "marc": [19, 20, 104], "march": [33, 48, 100, 104], "marching_cub": 48, "margin": 37, "mari": [33, 104], "marinegor": 105, "mark": [3, 30, 103, 104, 108], "marker": [33, 34, 37], "markup": [3, 4], "mask": 36, "mass": [1, 6, 7, 9, 10, 15, 16, 23, 24, 28, 30, 36, 40, 45, 46, 47, 48, 53, 55, 61, 63, 65, 66, 86, 87, 92, 97, 106, 109, 112, 113, 114], "mass_dens": [49, 105], "mass_density_stddev": 49, "master": [1, 3, 109, 114], "match": [4, 6, 7, 9, 10, 13, 17, 37, 44, 100, 102, 105, 106, 108], "match_atom": [9, 10], "math": [3, 105, 109], "mathbf": [3, 13, 14, 16, 31, 34, 36], "mathjax": 3, "mathsf": [3, 13], "matplotlib": [3, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 53, 57, 101], "matric": [19, 24, 45], "matrix": [3, 7, 8, 9, 10, 11, 12, 13, 14, 24, 34, 38, 39, 42, 44, 45, 46, 53, 104], "matteo": [42, 43, 44, 45, 104], "matter": [53, 84, 87, 106, 109], "matthew": [2, 52], "mauro": [33, 104], "max": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 55, 66, 104, 105], "max_": 46, "max_it": 42, "max_lam": 44, "maxdepth": 4, "maximum": [19, 20, 27, 30, 45, 66, 104], "maxiter": 52, "maxium": 27, "mb": [57, 100], "mcgibbon": 52, "mcpu": 100, "md": [15, 53, 102, 105, 110, 113], "mda": [0, 1, 3, 4, 5, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 66, 93, 96, 98, 102, 103, 105, 106, 108, 109, 110, 111, 112, 114], "mda_xdrlib": 105, "mdahole2": [3, 30], "mdakit": [2, 105], "mdanalysi": [0, 1, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 48, 49, 50, 51, 53, 55, 56, 57, 60, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 88, 89, 90, 91, 92, 93, 94, 95, 96, 98, 100, 102, 103, 104, 106, 109, 110, 111, 112, 114], "mdanalysis001": 96, "mdanalysis002": 96, "mdanalysis_data": 5, "mdanalysisdata": [14, 15, 100], "mdanalysistest": [2, 3, 9, 10, 11, 12, 13, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 55, 57, 100, 101, 102, 103, 105, 108], "mdcrd": [58, 59, 61], "mdcrdreport": 52, "mdnalysi": 99, "me": 98, "mean": [4, 6, 7, 8, 9, 11, 16, 19, 24, 26, 27, 30, 32, 33, 34, 39, 42, 43, 45, 48, 69, 75, 80, 84, 87, 98, 99, 100, 103, 105, 106, 108, 114], "mean_count": 26, "mean_xy_area": 26, "meanin": 48, "meaning": [7, 32, 33, 53, 98, 114], "meaningfulli": 103, "meaningless": 34, "meant": [3, 4], "meanwhil": 42, "measur": [7, 12, 13, 16, 30, 31, 41, 48, 66, 108], "mechan": [19, 20, 104], "meet": 110, "meetb7": 105, "melo": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "melt": [31, 34], "member": 2, "membran": [6, 26, 27, 28, 30], "memori": [4, 10, 11, 12, 14, 15, 26, 45, 53, 55, 56, 98, 99, 105, 108, 111, 112, 114], "memory_limit": 57, "memoryread": [10, 50, 103, 105, 114], "mention": 3, "merg": [3, 4, 9, 10, 19, 34, 102, 103, 105, 108, 114], "merged1": 10, "merged1_view": 10, "merged2": 10, "merged2_view": 10, "merged3": 10, "merged_coord": 10, "merged_view": [9, 10], "mesh": 48, "meshgrid": 48, "mess": [3, 15], "messag": [3, 42, 53, 89, 100, 101, 102], "met": [1, 53, 83, 107, 109], "meta": 102, "metadata": 102, "metast": [34, 104], "meter": 16, "method": [0, 3, 6, 7, 14, 15, 17, 19, 20, 21, 25, 26, 27, 28, 30, 31, 32, 33, 34, 37, 39, 45, 48, 50, 57, 60, 96, 98, 99, 101, 103, 104, 105, 106, 108], "metric": [12, 13, 18, 19, 33, 42, 43, 44, 45, 46], "mglagolev": 105, "michael": [15, 37, 104], "michaud": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 52, 53, 55, 104], "micromamba": [4, 108], "microsecond": 113, "microsoft": 100, "middl": 39, "midpoint": [30, 48], "might": [4, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 26, 33, 38, 39, 43, 44, 49, 52, 67, 79, 100, 106], "millilit": 52, "millisecond": 113, "mimic": 15, "min": [30, 50], "min_": [13, 46], "min_lam": 44, "min_radii": 30, "min_radiu": [18, 30], "min_sampl": 42, "minactionpath": [19, 20, 104], "mind": [3, 30], "miniconda": [3, 4], "miniforg": 3, "minim": [3, 7, 8, 108], "minimis": [9, 10, 11, 12, 13, 14, 42, 43, 52], "minimize_vector": 105, "minimizeenergi": 52, "minimum": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 55, 61, 102, 105, 108], "minor": [3, 102, 105], "minorli": 11, "mislead": 12, "miss": [4, 27, 50, 57, 81, 82, 84, 101, 103, 105, 108], "misspelt": 105, "mistak": [99, 114], "mix": [46, 103], "miyazawa": [39, 104], "mkdir": 3, "mkvirtualenv": 3, "ml": 45, "mls09": [34, 104], "mm": 52, "mmtf": [3, 58, 59, 61, 97, 101, 106, 109], "mmtfparser": 77, "mmtfreader": 77, "mobil": [9, 11, 13, 14], "mobile_ca": 11, "mode": [3, 33, 34, 38, 96, 104], "mode2": 33, "mode3": 33, "mode4": 33, "mode5": 33, "mode6": 33, "model": [26, 27, 30, 31, 53, 61, 77, 80, 81, 82, 97, 104, 109], "modern": 105, "modernis": 2, "modif": [3, 78, 89], "modifi": [3, 4, 6, 11, 28, 37, 78, 102, 105, 112, 114], "modul": [0, 1, 7, 8, 9, 10, 11, 12, 13, 14, 15, 17, 25, 30, 38, 39, 41, 42, 43, 44, 45, 46, 53, 55, 79, 100, 105, 109, 112], "module_nam": 108, "mohitkumar020291": 105, "mol": [45, 50, 63, 78, 87, 105, 113], "mol2": [58, 59, 61, 97, 105, 109], "mol2pars": 78, "mol2read": 78, "mol2writ": 78, "molar": 113, "molblock": [87, 105], "mole": 52, "molecul": [1, 4, 10, 13, 26, 31, 38, 50, 55, 58, 61, 66, 78, 87, 92, 95, 98, 105, 106, 108, 109, 112], "molecular": [1, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 58, 59, 61, 66, 80, 85, 97, 99, 104, 114], "molecular_dynamics_trajectory_for_benchmarking_mdanalysi": [14, 104], "molecule_tag": 105, "moleculetyp": [0, 109], "molfrompdbfil": 78, "molnum": [0, 61, 87, 97, 108, 109], "moltomolfil": 78, "moltyp": [0, 61, 87, 97, 106, 109], "moment": [95, 105, 106, 109], "moment_of_inertia": 109, "monatom": 105, "monatomic_cation_charg": 105, "monitor": 57, "monoton": 102, "month": 105, "more": [1, 2, 3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 24, 26, 27, 30, 33, 34, 38, 39, 40, 42, 43, 44, 46, 48, 49, 50, 53, 56, 57, 60, 61, 65, 69, 87, 98, 101, 103, 105, 106, 108, 109, 112, 114], "moreov": 19, "mors": 87, "moschaeffl": 105, "most": [0, 1, 3, 7, 10, 14, 15, 16, 26, 27, 32, 34, 39, 40, 41, 53, 60, 68, 69, 83, 87, 99, 100, 103, 105, 106, 108, 109, 114], "most_common": 26, "mostli": [2, 15], "motion": [7, 32, 34, 38], "move": [13, 14, 22, 40, 48, 53, 55, 101, 105, 108, 111, 112], "move_bi": 50, "movement": [7, 13, 17, 19, 34, 57], "movi": [10, 14, 34, 39, 48, 55], "moviemak": [10, 14, 34, 39, 48, 55], "moviepi": 10, "mpl_toolkit": [44, 48], "mplot3d": [44, 48], "mprm": 52, "mprm_convert": 52, "mprm_from_parm": 52, "mse": 107, "msg": 108, "mtune": 100, "mu": 45, "much": [2, 3, 10, 11, 12, 13, 14, 16, 19, 30, 34, 42, 43, 48, 50, 60, 105, 108], "multi": [53, 71, 81, 82], "multicor": 15, "multifram": 16, "multimachin": 15, "multipdb_hol": 30, "multipl": [1, 3, 27, 39, 48, 53, 57, 62, 89, 94, 98, 100, 105, 106, 112, 114], "multipli": [19, 26, 86, 113], "multiprocss": 15, "multiscal": 27, "must": [1, 2, 3, 4, 11, 12, 13, 16, 18, 22, 23, 26, 27, 30, 31, 34, 42, 43, 46, 48, 50, 53, 60, 66, 79, 83, 84, 100, 101, 108, 109, 112, 114], "mvc": 105, "mw6365": 40, "mx": 48, "my": [3, 4, 5, 18, 48], "my_branch": 4, "my_pdb_fil": 53, "my_script": 53, "my_user_nam": 4, "myproject": 3, "mz": 48, "n": [1, 3, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 83, 95, 96, 98, 104, 105, 106, 107, 113], "n0a": 105, "n1": [98, 107], "n2": 107, "n3": [52, 107], "n4": 107, "n6": 107, "n7": 107, "n9": 107, "n_": [26, 34, 36], "n_a": 36, "n_atom": [3, 10, 15, 26, 50, 53, 103, 105, 108, 109, 111, 114], "n_atomgroup": 37, "n_b": 36, "n_bb": 34, "n_block": 15, "n_ca": 24, "n_color": [33, 34], "n_compon": [34, 43, 44], "n_contact": [19, 21], "n_db": 42, "n_donor": 26, "n_frame": [12, 15, 16, 26, 30, 34, 37, 39, 53, 105], "n_frames_per_block": 15, "n_job": 15, "n_lid": 23, "n_nmp": 23, "n_re": 24, "n_ref": 19, "n_residu": [3, 37, 39, 50, 53, 109], "n_segment": 50, "n_select": 53, "n_std": 30, "n_worker": 15, "n_x": 50, "n_y": 50, "n_z": 50, "na": [0, 1, 30, 105], "nala": 107, "nalysi": 104, "nambdin": 59, "namd": [42, 44, 45, 46, 58, 59, 61, 97, 103], "namdbin": [58, 61, 64], "namdbinread": 64, "namdbinwrit": 64, "name": [0, 3, 4, 9, 10, 11, 12, 13, 14, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 36, 37, 38, 39, 40, 42, 43, 44, 46, 48, 50, 53, 57, 60, 61, 65, 67, 70, 78, 81, 82, 83, 86, 87, 92, 95, 96, 97, 98, 100, 102, 103, 105, 106, 107, 108, 109, 114], "nan": [57, 108], "nanomet": [66, 113], "nanosecond": 113, "napoleon": 3, "nar": [19, 20, 104], "narg": 107, "nasn": 107, "nasp": 107, "nation": [19, 20, 104], "nativ": [6, 7, 15, 17, 20, 21, 63, 100, 104], "natom": 50, "natur": 44, "naveen": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 55, 104], "navig": [3, 4], "nbextens": 4, "nbin": [36, 40, 49], "nbindex": 109, "nbindic": 109, "nbsphinx": 4, "nc": [52, 58, 59, 61], "ncbi": [30, 104], "ncdf": [58, 59, 61], "ncdfreader": 79, "ncdfwriter": 79, "ncol": 27, "ncore": [42, 44], "ncr18": [9, 10, 55, 104], "ncy": 107, "ncycl": 44, "ncyx": 107, "ndarrai": [1, 53, 110], "ndx": 96, "ne": [27, 28], "near_met": 53, "nearest": [46, 57], "neat": [1, 4], "necessari": [13, 14, 16, 21, 26, 30, 50, 57, 102, 105, 106], "necessarili": [12, 18, 44, 69], "neduvelil": [30, 104], "need": [2, 3, 7, 8, 9, 14, 15, 16, 19, 24, 30, 33, 34, 42, 43, 44, 46, 48, 50, 52, 53, 55, 67, 98, 99, 100, 101, 102, 103, 105, 108, 111, 112], "neg": 106, "neighbor": 105, "neighbour": [36, 42, 46], "neighour": [7, 32, 33], "nep29": 105, "netcdf": [58, 59, 61, 88, 105], "netcdf4": [3, 79, 108], "network": [6, 7, 35], "networkx": [3, 105], "never": [19, 101, 108, 109], "nevertheless": 89, "new": [0, 1, 2, 9, 15, 16, 18, 19, 30, 34, 48, 53, 57, 66, 67, 87, 100, 101, 102, 103, 104, 109, 110, 111, 112, 114], "new_box": 50, "new_nam": 109, "new_rmsd": 9, "new_univers": 50, "newer": [3, 86], "newli": [3, 102, 105], "newseg": 0, "newton": 113, "next": [3, 13, 19, 26, 44, 46, 53, 55, 58, 59, 61, 89, 105, 106, 111], "next_as_aux": 57, "ngln": 107, "nglu": 107, "nglview": [4, 9, 10, 14, 19, 34, 39, 50, 52, 55, 104], "nglviewer": 48, "ngly": 107, "nguyen": [9, 10, 52, 55, 104], "nh": [18, 19, 21], "nh1": [27, 28, 83], "nh2": [27, 28], "nhh": 53, "nhid": 107, "nhie": 107, "nhip": 107, "nice": 3, "nicer": 55, "niederhut": 15, "nih": [30, 104], "nile": 107, "nitrogen": [31, 98, 105, 106], "nleu": 107, "nlm": [30, 104], "nly": 107, "nm": [48, 57, 66, 113], "nma1": 38, "nma2": 38, "nma_clos": 38, "nme": 107, "nmet": 107, "nmp": [13, 14, 22, 23, 50], "nmp_atom": 50, "nmp_ca": 23, "nmp_com": 23, "nmp_segment": 50, "no_charg": 78, "no_overlap": 50, "no_overlap_view": 50, "nocutoff": 52, "node": [92, 100], "nodej": 100, "noimplicit": 105, "nois": 42, "nojump": 105, "non": [6, 7, 13, 19, 32, 36, 57, 60, 88, 105, 106], "nonbondedmethod": 52, "none": [13, 15, 16, 26, 28, 30, 34, 37, 46, 50, 52, 57, 92, 98, 105, 109, 114], "nonlinear": [33, 104], "nonstandard": 101, "nonzero": 40, "norm": [40, 105], "normal": [1, 3, 15, 30, 38, 39, 43, 44, 84, 91, 96, 102, 104, 105, 108], "normalis": [36, 40, 48], "nose": 108, "not_protein": 55, "not_protein2": 55, "notat": 82, "note": [3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 19, 20, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 53, 55, 83, 84, 98, 102, 104, 106, 108, 111, 113], "notebook": [6, 9, 10, 11, 26, 27, 34, 48, 52, 53, 55, 104, 114], "notic": [3, 4, 16], "notifi": 101, "notimplementederror": [79, 109], "notimplementederrortraceback": 109, "notwithin_coordinates_factori": 105, "noun": 3, "nov": 99, "novemb": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55, 104], "now": [3, 4, 11, 14, 16, 19, 27, 40, 43, 46, 48, 50, 52, 55, 81, 102, 105], "np": [10, 12, 15, 16, 18, 19, 20, 21, 23, 24, 26, 27, 28, 30, 33, 34, 37, 40, 42, 43, 44, 45, 46, 48, 49, 50, 55, 57, 101, 103, 105, 108, 112, 114], "nphe": 107, "npro": 107, "npt": 105, "npy": 26, "npz": [89, 94], "nr": 96, "nrow": 38, "nsampl": 44, "nsc7810": 82, "nser": 107, "nstep": 44, "nth": 114, "nthr": 107, "ntrp": 107, "ntyr": 107, "nucleic": [19, 20, 104, 105, 106], "nucleicacid": 105, "nucleicbackbon": 106, "nucleicbas": 106, "nucleicsugar": 106, "nucleobas": 106, "nucpairdist": 105, "null": 1, "num_cor": 15, "number": [1, 3, 4, 6, 7, 13, 14, 15, 16, 17, 18, 19, 20, 22, 24, 26, 27, 30, 33, 34, 36, 37, 38, 39, 40, 41, 42, 43, 44, 48, 50, 52, 53, 57, 60, 65, 69, 71, 72, 75, 81, 82, 83, 84, 85, 87, 89, 91, 92, 93, 96, 103, 105, 106, 108, 109, 114], "number_of_clustering_method": 43, "number_of_window": 43, "numer": [42, 44, 53, 66, 106], "numpi": [2, 3, 10, 12, 15, 16, 18, 19, 20, 21, 23, 24, 26, 27, 28, 30, 33, 34, 37, 40, 42, 43, 44, 45, 46, 48, 49, 50, 53, 55, 100, 101, 102, 103, 105, 108, 109, 112], "numprocess": [100, 108], "nv": [9, 10, 14, 19, 34, 39, 48, 50, 55], "nval": 107, "nvt": 49, "nz": [18, 19, 21, 27], "o": [28, 30, 31, 36, 45, 50, 52, 53, 98, 104, 106, 107, 108], "o1": 82, "o2": [82, 106, 107], "o3": [82, 106, 107], "o4": [82, 106, 107], "o5": [106, 107], "o6": 107, "oa": 82, "object": [0, 1, 3, 16, 20, 26, 37, 48, 50, 52, 53, 57, 58, 61, 62, 98, 105, 106, 108, 114], "observ": 26, "obtain": [27, 48, 50, 57, 83, 104, 105, 113], "obviou": [9, 10], "occasion": [1, 89, 94], "occlud": [30, 104], "occup": [12, 14, 61, 66, 81, 82, 97, 105, 109], "occur": [4, 19, 105], "octob": [19, 20, 34, 42, 43, 44, 45, 46, 104], "od": [18, 19, 21], "od1": 27, "od2": 27, "odd": 48, "oe": [18, 19, 21], "oe1": 27, "oe2": 53, "off": [3, 4, 12, 16, 46, 50, 89, 106, 108], "offer": [5, 48, 105], "offici": 105, "offset": [22, 89, 94, 105], "often": [3, 4, 7, 12, 13, 19, 32, 48, 50, 52, 53, 61, 68, 80, 88, 100, 103, 106, 108, 112], "og": 105, "og1": [27, 36, 105], "oh": 27, "oh2": [26, 28], "ok": [3, 100, 101, 102, 108], "okai": 3, "old": [3, 15, 53, 67, 96, 103, 108], "old_rmsd": 9, "oldest": 105, "olecular": 104, "oliv": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "oliver_beckstein": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "omega": 37, "omega_select": 37, "omit": [37, 57, 83], "onc": [3, 16, 39, 53, 55, 102, 104, 105, 108, 111, 112], "one": [1, 2, 3, 4, 10, 11, 12, 13, 15, 19, 27, 28, 30, 31, 39, 46, 50, 53, 56, 57, 83, 87, 88, 91, 92, 96, 98, 99, 100, 103, 104, 105, 106, 108, 109, 114], "ones": [3, 33, 87, 106], "onfer": 104, "ongo": [3, 105], "onli": [0, 2, 3, 4, 10, 12, 13, 15, 16, 26, 27, 28, 30, 31, 34, 36, 37, 48, 49, 50, 53, 55, 56, 57, 66, 70, 72, 78, 79, 83, 84, 87, 88, 91, 94, 95, 98, 99, 100, 101, 102, 103, 105, 106, 108, 109, 110, 111, 112, 114], "onlin": [3, 6, 10], "onlinelibrari": [34, 104], "onto": [3, 7, 30, 32, 33, 34, 37, 43, 44, 48, 111], "onward": [55, 105], "ooprathamm": 105, "op_profil": 30, "opac": [30, 48], "opaqu": 48, "open": [2, 3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 53, 55, 87, 89, 94, 104, 108], "openmm": [3, 51, 58, 61, 105], "openmmapp": [58, 61], "openmmsimul": [58, 61], "openmmtopologi": 61, "openmmtopologypars": 105, "openmp": 100, "oper": [3, 9, 15, 16, 30, 39, 53, 103, 105, 106], "opl": 107, "oppos": 19, "optim": [9, 10, 11, 13, 14, 27, 53, 104], "optimis": 16, "option": [2, 9, 10, 14, 16, 19, 22, 23, 24, 30, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 53, 55, 57, 61, 66, 67, 82, 83, 95, 100, 103, 104, 105, 108, 109, 114], "orang": [14, 22], "oranges_d": [33, 34], "order": [0, 3, 4, 7, 12, 13, 15, 16, 19, 26, 31, 32, 33, 34, 37, 42, 43, 44, 48, 52, 53, 57, 61, 66, 67, 82, 90, 98, 100, 101, 102, 103, 105, 109, 110, 111, 112, 114], "order_paramet": 30, "org": [3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 99, 104], "organ": 105, "organis": [3, 108], "origin": [1, 3, 4, 7, 9, 13, 14, 23, 27, 32, 33, 34, 39, 50, 53, 55, 57, 67, 98, 102, 106, 108, 110, 113], "original_and_copi": 108, "orn": 107, "orthogon": [3, 7, 32, 34, 52, 81, 82], "orthorhomb": 88, "oscil": [42, 44], "osx": [102, 105], "ot": 26, "ot1": 53, "ot2": [27, 53], "otf": 55, "other": [3, 4, 6, 7, 9, 10, 11, 12, 13, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 37, 38, 39, 42, 43, 44, 45, 46, 49, 53, 60, 61, 66, 67, 68, 69, 71, 72, 76, 78, 79, 80, 81, 86, 87, 95, 96, 98, 99, 100, 105, 106, 108, 109, 112, 113], "otherwis": [3, 4, 11, 34, 44, 55, 83, 89, 108], "otim": 34, "oup": [9, 10, 19, 20, 55, 104], "our": [3, 4, 10, 11, 12, 14, 16, 18, 22, 24, 27, 31, 44, 46, 48, 50, 52, 53, 55, 105, 108], "ourselv": [10, 16, 50], "out": [1, 3, 4, 9, 10, 11, 12, 14, 19, 30, 34, 39, 48, 50, 52, 55, 57, 61, 70, 78, 93, 98, 102, 103, 105, 106, 109, 110, 111, 113, 114], "outcom": [1, 105], "outdat": 3, "outer": 34, "outfil": [30, 108], "outlier": 42, "outlin": [48, 53], "output": [4, 10, 14, 16, 30, 34, 38, 39, 40, 42, 43, 44, 48, 53, 55, 63, 70, 72, 83, 105, 108, 112], "outreachi": 105, "outsid": [3, 31, 49, 55, 57, 98, 101, 105], "over": [1, 6, 7, 8, 12, 15, 16, 17, 18, 20, 21, 22, 26, 27, 30, 32, 34, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 48, 53, 55, 72, 102, 103, 105, 108, 110, 111, 112], "over_order_paramet": 30, "overal": [4, 13, 16, 19, 27, 108], "overflow": [14, 105], "overhead": 15, "overlap": [30, 36, 50, 103], "overli": 21, "overlin": 34, "overrid": 105, "overview": 3, "overwhelm": 99, "overwrit": [3, 30, 96], "overwritten": 3, "ow": [48, 106], "owen": [26, 27, 28], "own": [2, 3, 4, 6, 7, 13, 15, 17, 19, 20, 21, 30, 42, 52, 53, 66, 99, 101, 108, 112], "oxygen": [26, 48, 50, 106], "p": [3, 14, 16, 26, 27, 30, 33, 34, 38, 46, 48, 52, 53, 57, 61, 63, 67, 79, 81, 88, 95, 104, 105, 106, 107, 113, 114], "p_": 46, "p_compon": 34, "p_re": 98, "p_seg": 98, "pablo": [33, 104], "pack_into_box": 109, "packag": [2, 4, 5, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 61, 79, 86, 96, 100, 101, 104, 105, 106, 108], "package_data": 108, "pad": 48, "page": [2, 3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 61, 102, 104, 106, 108], "pair": [7, 26, 28, 30, 36, 40, 41, 44, 46, 105], "pair_dist": 105, "pairgrid": [33, 34], "pairij": 105, "pairwis": [6, 7, 8, 13, 14, 19, 39, 40], "pairwise2": 105, "pairwisealign": 105, "palett": [33, 34], "panagiotopoulo": [33, 104], "pand": 52, "panda": [2, 13, 15, 16, 18, 19, 20, 21, 26, 33, 34, 49, 53, 108], "pang": [38, 104], "paola": 27, "papaleo": [42, 43, 44, 45, 104], "paper": [9, 10, 11, 12, 13, 14, 33, 34, 53, 104], "paragraph": 3, "parallel": [7, 100, 105], "parallelis": 15, "paralleliz": 7, "param": 27, "paramet": [3, 16, 43, 52, 53, 86, 104, 105, 108, 109], "parameter": 52, "parametr": [52, 108], "params_covari": 27, "paraskevako": [15, 104], "parenthes": 106, "parm": [3, 51, 58, 59, 61, 86, 105], "parm7": [59, 61, 97, 109], "parmar": 105, "parmedconvert": 80, "parmedpars": 80, "parmedread": 80, "pars": [71, 81, 83, 84, 105, 106, 114], "parser": [3, 4, 63, 65, 66, 69, 70, 71, 72, 73, 75, 76, 77, 78, 80, 81, 82, 83, 84, 86, 87, 91, 92, 93, 95, 99, 105, 106, 114], "part": [1, 2, 3, 4, 15, 30, 48, 57, 101, 103, 105, 106, 108, 111], "part01": 103, "part02": 103, "part03": 103, "part04": 103, "partial": [3, 15, 28, 61, 82, 108, 109, 112], "partialchrg": 82, "particl": [1, 9, 13, 14, 34, 36, 40, 50, 52, 53, 72, 105], "particular": [3, 4, 22, 30, 40, 46, 48, 67, 91, 98, 100, 108, 110, 111], "particularli": [57, 83, 85], "partit": [42, 43, 44, 49], "pass": [1, 3, 4, 13, 16, 18, 19, 22, 23, 24, 26, 28, 30, 31, 34, 36, 37, 39, 42, 43, 44, 45, 49, 50, 53, 55, 60, 61, 62, 66, 80, 81, 93, 95, 96, 100, 102, 103, 105, 106, 108, 110, 112, 114], "patch": 102, "path": [3, 5, 7, 19, 30, 32, 41, 53, 57, 104, 105, 108], "path_select": 46, "pathlib": 105, "pathsimanalysi": 3, "pathwai": [33, 46, 104], "patric": [19, 20, 104], "pattern": [33, 104, 106, 108], "paul": [26, 27, 28, 37, 104], "pave": 105, "pbarletta": [11, 12, 13, 15, 16, 18, 20, 21, 28, 33, 37, 38, 40, 42, 43, 44, 45, 49], "pbc": [48, 52, 105, 108], "pc": [15, 34, 44, 70], "pc1": [34, 43, 44], "pc2": [34, 43, 44], "pc3": [34, 43, 44], "pc4": 44, "pca": [7, 32, 34, 43, 44, 105], "pcbi": [42, 43, 44, 45, 46, 104], "pcolor": 24, "pd": [13, 15, 16, 18, 19, 20, 21, 26, 33, 34, 49, 53], "pdb": [1, 9, 10, 13, 14, 22, 23, 24, 34, 37, 46, 50, 52, 53, 57, 58, 59, 61, 77, 78, 83, 96, 97, 98, 103, 105, 108, 109, 114], "pdb2pqr": 59, "pdb_close": 22, "pdb_hole": 30, "pdb_name": 30, "pdb_small": [22, 23, 24, 45, 46, 50, 108], "pdb_xvf": 57, "pdbfile": 114, "pdbparser": [81, 105], "pdbqt": [58, 59, 61, 97, 105, 109], "pdbqtparser": 82, "pdbqtreader": 82, "pdbqtwriter": 82, "pdbreader": [81, 105], "pdbwriter": [81, 105], "pdf": [34, 57, 104], "peak": 38, "peoe": 82, "peopl": [2, 3, 102], "per": [19, 26, 66, 83, 105, 108], "percentag": 34, "perera": [38, 104], "perfect": 34, "perfectli": 57, "perform": [4, 13, 15, 26, 43, 44, 48, 52, 85, 100, 108, 111, 112], "perilla": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 104], "period": [27, 48, 87, 88, 105, 106, 112], "perm": 78, "perman": [5, 111], "permiss": 105, "persist": [6, 7, 10, 15, 26, 29, 53, 55, 111], "persistencelength": 31, "person": 4, "perspect": [34, 104], "peter": 52, "pgbarletta": 105, "pglu": 107, "phe": 107, "phi": 37, "phi_select": 37, "philip": [30, 38, 104], "phosopho": 15, "phosophotransferas": [9, 10, 11, 12, 13, 14, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55], "phosphor": 26, "phosphoru": 105, "phosphotransferas": 50, "phrase": 106, "phy": [26, 27, 28], "physic": [7, 32, 33, 34, 104], "physrev": 104, "pi": [3, 36, 113], "pick": [99, 102, 108], "pickl": [15, 26, 105], "picomet": 113, "picosecond": [38, 52, 53, 79, 113], "pictur": 50, "pie": [15, 114], "pii": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55, 104], "pile": 3, "pillos": 105, "pin": 102, "ping": 52, "pip": [4, 7, 53, 101, 104, 105, 108], "pipelin": [15, 105, 108], "pipx": 102, "pivot": 15, "pkl": 26, "place": [3, 4, 10, 34, 94, 99, 102], "placehold": [16, 50, 92], "placement": 48, "plai": 15, "plain": [4, 108], "plan": [100, 105], "plane": [30, 39, 48, 60], "platform": [4, 100], "pleas": [2, 3, 4, 7, 8, 9, 10, 11, 12, 13, 14, 16, 18, 19, 20, 21, 26, 27, 28, 30, 33, 34, 38, 39, 42, 43, 44, 45, 46, 53, 61, 87, 99, 100, 102, 104, 105, 112], "plen": 31, "plo": [42, 43, 44, 45, 46, 52, 104], "plor": 67, "ploscompbiol": [42, 43, 44, 45, 104], "plot": [12, 15, 16, 26, 27, 31, 33, 34, 36, 38, 39, 40, 43, 49, 53, 57, 105], "plot3d": 30, "plot3d_order_paramet": 30, "plot_annotated_heatmap": 46, "plot_mean_profil": 30, "plot_order_paramet": 30, "plot_trisurf": 48, "plotli": 12, "plotter": 48, "plt": [12, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 30, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 53, 57], "plugin": [4, 95, 100, 101, 108], "plural": 109, "pm": 113, "pmc": [30, 104], "pmc1225986": [30, 104], "pmc2652707": 104, "pmc3144279": [45, 52], "pmcid": [45, 52], "pmd": 52, "pmda": [15, 104], "pml": 96, "pna": [19, 20, 104], "png": [48, 57], "po": 105, "point": [3, 4, 7, 13, 15, 30, 31, 32, 33, 37, 42, 44, 46, 48, 53, 55, 57, 102, 105, 106, 108, 110, 111], "polar": 37, "poli": 63, "polici": 3, "polyamid": [27, 31], "polym": [6, 104], "polymers_and_membran": 4, "polynomi": [9, 10, 11, 12, 13, 14, 33, 53, 104], "pool": 15, "poor": [27, 34], "pope": 3, "popul": [12, 16, 42, 105], "popular": [3, 61, 93, 99], "pore": [6, 7, 29, 104], "pore_length": 30, "port": [33, 104], "portabl": [59, 61, 87], "portion": 101, "posit": [9, 10, 11, 13, 14, 15, 16, 19, 20, 21, 23, 24, 26, 34, 38, 45, 48, 52, 66, 67, 76, 103, 105, 106, 108, 109, 110, 111, 112], "possibl": [4, 28, 30, 46, 57, 60, 82, 99, 103, 104, 105, 106, 108], "possibli": 61, "post": [18, 26, 48, 55, 100, 105, 112], "potenti": [13, 19, 52, 57, 79, 87, 102, 105], "potentialenergi": 52, "power": [15, 53, 98], "powerpc": 100, "ppc64le": 105, "pprm": 52, "pqr": [58, 59, 61, 97, 105, 109], "pqrparser": 83, "pqrreader": 83, "pqrwriter": 83, "pr": [3, 4, 102, 103, 105], "practic": [3, 12, 48, 105], "pre": [3, 18, 48, 57, 102], "preced": 106, "precis": [64, 85, 94, 105, 108], "precomput": [48, 113], "predict": 108, "prefer": [30, 42, 100, 108], "prefix": [3, 4, 106], "preliminari": 105, "prepar": [3, 16], "prepart": 105, "presenc": 27, "presens": 102, "present": [1, 3, 19, 21, 26, 27, 40, 52, 65, 68, 81, 92, 95, 98, 105], "preserv": [1, 19, 66, 105], "pressur": 57, "presum": 14, "pretti": [24, 98], "preval": 27, "prevent": [4, 105], "preview": 3, "previou": [4, 13, 19, 30, 105], "previous": [78, 81, 105], "primari": [3, 53, 98, 109], "primarili": 5, "primer": 4, "princip": [6, 7, 32, 33, 43, 44, 104, 109], "principal_ax": 109, "principalcomponentanalysi": [43, 44], "principl": 101, "print": [1, 5, 9, 10, 11, 13, 14, 15, 19, 23, 26, 27, 28, 30, 31, 34, 36, 37, 39, 40, 42, 43, 44, 45, 46, 49, 50, 53, 57, 101, 103, 108, 109, 110, 111, 114], "print_funct": 101, "prior": [3, 28, 71, 87, 105, 109], "prisant": [37, 104], "privat": 99, "prm": 114, "prm7_ala2": 52, "prm_protein_shel": 52, "prmsd": 12, "prmtop": [26, 59, 61, 88, 97, 105, 109], "pro": [37, 96, 107], "probabl": [1, 4, 7, 15, 38, 41, 42, 44, 53, 88], "problem": [2, 3, 4, 13, 61, 68, 87, 99], "proce": 30, "procedur": [11, 39, 102], "proceed": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 100, 104], "process": [2, 3, 7, 15, 17, 18, 19, 23, 24, 26, 27, 48, 67, 102, 105, 108, 114], "prod": 26, "produc": [1, 23, 27, 34, 53, 57, 67, 105, 108], "product": [3, 14, 34, 104], "profil": 3, "profiles1": 30, "prograg": 42, "program": [3, 4, 7, 14, 30, 34, 39, 50, 53, 93, 96, 99, 100, 104], "progress": [3, 15, 16, 100, 103, 105], "progressbar": 105, "progressbar_kwarg": 105, "proj1": 34, "project": [2, 3, 4, 7, 32, 37, 39, 43, 44, 48, 99, 105], "promot": 3, "prop": 106, "proper": [57, 60, 87, 108], "properli": [3, 4, 102, 105], "properti": [1, 16, 30, 39, 53, 60, 98, 105, 106, 109, 111, 112], "proportion": 40, "prot": [34, 37, 104], "protect": [3, 102], "protein": [0, 6, 7, 9, 10, 13, 14, 15, 16, 17, 19, 20, 21, 22, 24, 26, 27, 28, 29, 30, 34, 35, 38, 39, 42, 44, 45, 47, 52, 53, 57, 59, 98, 104, 106, 110, 111, 112, 114], "protein2": 55, "protein_a": 106, "protein_acceptors_sel": 28, "protein_cent": 55, "protein_chain_a": 87, "protein_chain_b": 87, "protein_chain_xxx": 87, "protein_forc": 57, "protein_hydrogens_sel": 28, "protein_shel": 52, "protein_view": 50, "proton": 53, "protoread": 57, "provid": [1, 3, 4, 7, 12, 13, 15, 16, 17, 25, 26, 30, 31, 34, 37, 38, 43, 44, 46, 52, 53, 55, 57, 60, 61, 62, 65, 71, 81, 82, 83, 88, 94, 96, 99, 100, 103, 105, 106, 108, 109, 114], "proxim": 44, "psa": 46, "psanalysi": 46, "pseudo": 19, "psf": [0, 5, 9, 10, 11, 12, 13, 14, 16, 18, 19, 20, 21, 26, 27, 28, 33, 34, 38, 39, 42, 43, 44, 45, 46, 53, 59, 61, 82, 97, 103, 105, 106, 108, 109, 110, 111], "psf_namd_gbi": [42, 44, 45, 46], "psffre": 84, "psfparser": 84, "psfplugin": 84, "psi": 37, "psi_select": 37, "pu": [9, 10, 11, 14, 53, 104], "public": [2, 3, 16, 30, 99, 102, 104, 108], "publicli": [3, 73], "publish": [4, 9, 10, 11, 12, 13, 14, 16, 21, 26, 27, 28, 30, 33, 34, 38, 39, 42, 43, 44, 45, 46, 53, 61, 102, 104], "pull": [4, 10, 45, 70, 82, 101, 102, 105, 108, 111], "pure": [30, 31, 87, 104], "purpl": 14, "purpos": [3, 19, 28], "push": [2, 4, 15, 102, 108], "put": [3, 4, 16, 50], "pv": [48, 57], "pxd": 105, "py": [0, 3, 4, 5, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 33, 37, 38, 39, 40, 42, 43, 44, 45, 49, 53, 101, 102, 104, 105, 108], "pyarg": 100, "pycharm": 3, "pydagogu": 2, "pydev": [19, 26, 39], "pyedr": 3, "pymol": [53, 96], "pypi": [3, 102, 105], "pyplot": [12, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 30, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 53, 57], "pyproject": 3, "pytest": [3, 100, 102, 105, 108], "python": [4, 5, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 87, 98, 99, 100, 101, 102, 104, 105], "python3": [11, 12, 13, 15, 16, 18, 20, 21, 28, 33, 37, 38, 40, 42, 43, 44, 45, 49, 108], "pytng": [3, 105], "pyx": 3, "q": [19, 46, 82, 83, 96], "q1": [6, 7, 17, 18, 19, 21], "q1q2": 20, "q1q2_df": 20, "q2": [6, 7, 17, 18, 19, 21], "q_": 46, "q_i": 109, "qcp": [7, 8, 9, 10, 11, 12, 13, 14, 33], "qcprot": 105, "qln": 107, "quadrupol": 109, "quadrupole_mo": 109, "quadrupole_tensor": 109, "qualiti": [10, 12, 14, 34, 39, 48, 55, 85], "quantif": 12, "quantifi": [13, 14, 21, 23, 46, 104], "quantit": [42, 43, 44, 45, 104], "quantiti": [7, 8, 19, 53, 98, 105, 113], "quartic": 87, "quaternion": [9, 10, 11, 12, 13, 14, 33, 53, 104], "queri": [53, 111], "question": [2, 3, 99], "queue": 15, "quick": [6, 12, 16], "quicker": 77, "quickest": [33, 34], "quickli": [3, 26, 83, 99], "quickstart": 4, "quiet": 4, "quit": [3, 15, 34, 44, 96, 100, 114], "r": [3, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 52, 53, 55, 96, 102, 104, 105, 109], "r0": [18, 19], "r_": [16, 26], "r_0": 19, "r_1": 60, "r_2": 60, "r_charg": 13, "r_g": 16, "r_i": 109, "r_mass": 13, "r_max": 30, "r_valu": 14, "ra": 107, "ra3": 107, "ra5": 107, "rad": [30, 111, 113], "radgyr": [15, 16, 111], "radgyr_per_fram": 15, "radial": [6, 7, 35], "radii": [16, 30, 60, 61, 83, 97, 109, 114], "radiu": [18, 20, 21, 30, 36, 40, 53, 83, 87, 106, 109, 114], "radius_cut": 19, "radius_cut_q": [19, 20], "radius_of_gyr": [53, 109, 111], "radiusofgyr": 16, "radiusofgyration2": 16, "rafael": [38, 104], "rafal": 52, "rainbow": 14, "rais": [1, 3, 33, 49, 53, 65, 79, 81, 82, 83, 99, 100, 101, 105, 108], "rama": 37, "rand": 103, "random": [34, 89, 94, 103], "random_se": 30, "rang": [7, 15, 16, 30, 33, 34, 36, 40, 44, 50, 53, 57, 101, 106, 109], "rangl": [14, 27, 31, 36], "rapid": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "rapidli": [7, 17, 37], "rate": [43, 44], "rather": [3, 16, 19, 26, 36, 40, 53, 83, 99, 105, 108], "ratio": 108, "rational": 3, "ravel": [42, 44, 48], "raw": [3, 103], "rb": 26, "rc": 107, "rc3": 107, "rc5": 107, "rd": 98, "rd_dcd": 44, "rd_dcd2": 44, "rd_namd": 44, "rd_p1": 44, "rd_p1_ax": 44, "rd_p1_fig": 44, "rd_p2": 44, "rd_p2_ax": 44, "rd_p2_fig": 44, "rd_p3": 44, "rd_p3_ax": 44, "rd_p3_fig": 44, "rdax0": 44, "rdax1": 44, "rdf": [6, 7, 35, 36, 105], "rdfig0": 44, "rdfig1": 44, "rdkit": [3, 58, 61, 78, 105], "rdkitconvert": 105, "re": [3, 4, 10, 14, 16, 19, 24, 37, 53, 55, 78, 96, 102, 106, 108], "reachabl": 98, "reaction": [33, 104, 105], "read": [2, 3, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 30, 33, 38, 39, 43, 44, 49, 50, 52, 60, 62, 63, 64, 74, 80, 90, 91, 92, 99, 105, 106, 109, 110, 111, 113, 114], "read_": 87, "read_tpxhead": 87, "readabl": [30, 87], "reader": [4, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 33, 38, 39, 42, 43, 44, 45, 49, 53, 56, 57, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 76, 77, 78, 79, 80, 81, 82, 83, 85, 86, 87, 88, 89, 90, 91, 93, 94, 95, 99, 105, 108, 114], "readerbas": 105, "readm": 4, "readthedoc": [4, 15], "real": [18, 21, 66, 68, 76, 81, 82, 83], "realist": 15, "realli": [1, 13, 15, 108], "reappli": 3, "rearrang": [19, 21], "reason": [3, 38, 52, 88, 108], "rebas": 108, "rebuild": [3, 4], "rebuilt": [89, 102], "recalcul": [53, 89], "recarrai": 30, "receiv": 108, "recent": [0, 3, 67, 87, 102, 108, 109], "recip": 57, "recogn": [66, 76], "recognis": [79, 105, 107], "recognit": [33, 104], "recommend": [2, 3, 21, 26, 45, 61, 100, 101, 102, 108], "recomput": 16, "record": [67, 68, 81, 82, 98, 102, 105, 106, 109], "record_typ": [61, 97, 98, 109], "recordnam": 83, "rectangular": 24, "red": [14, 108], "reddi": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "reduc": [7, 11, 30, 33, 41, 42, 43, 44, 85, 94, 100], "reduced1": 44, "reduced_coordin": 44, "reduct": [6, 34, 41, 104], "redund": 106, "ref": [11, 13, 14, 19, 30, 37, 46, 108], "ref_axi": 39, "ref_ca": 11, "ref_filenam": 108, "ref_fram": [12, 13, 14], "refactor": 105, "refer": [3, 6, 7, 8, 17, 82, 89, 98, 103, 105, 112], "refgroup": [18, 19], "reflect": [3, 4, 105, 106], "reformat": 3, "refresh": 4, "refresh_offset": [89, 94], "regardless": [1, 3, 53, 113], "regener": [89, 94], "regex": 4, "region": [7, 14, 32, 33, 37, 43], "regist": [2, 44], "registri": 2, "regress": 108, "regular": [4, 57, 87], "rel": [3, 4, 9, 10, 15, 16, 27, 48, 60, 101, 108, 109], "relat": [21, 30, 100, 105], "relationship": 99, "releas": [3, 84, 87, 100, 108], "relev": [0, 4, 7, 26, 32, 50, 102], "reli": [3, 53, 60, 83, 100, 108], "reload": [11, 57], "remain": [7, 13, 16, 19, 24, 27, 32, 49, 53, 57, 104, 105, 108, 111], "remaind": 53, "remark": [57, 81, 82], "remot": [3, 4], "remov": [3, 4, 28, 30, 37, 40, 53, 102, 105, 108], "removeh": 78, "renam": [10, 57], "rename_aux": 57, "render": [3, 4, 10, 48, 55, 102], "render_param": [10, 14, 34, 39, 48, 55], "renumb": 83, "repeat": [30, 50], "repetit": 108, "replac": [4, 53, 100, 103, 105, 109], "replai": 3, "replic": 57, "replica": [7, 32, 33], "repo": 3, "report": [2, 52, 99, 108], "repositori": [2, 3, 4, 5, 99, 102], "repres": [7, 12, 13, 15, 20, 27, 32, 33, 34, 38, 39, 40, 42, 43, 44, 48, 50, 53, 57, 60, 67, 103, 109], "represent": [7, 32, 48, 67, 76, 96, 105, 112, 114], "represent_ts_a": 57, "reproduc": 30, "req": 52, "request": [2, 4, 101, 102, 108], "requir": [1, 3, 4, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 65, 66, 79, 81, 82, 83, 95, 96, 98, 100, 103, 105, 106, 108, 109], "res1": 109, "res2": 109, "res3": 109, "res60": 36, "res_com": 24, "res_dist": [23, 24], "resampl": 43, "research": [7, 15, 19, 20, 104], "resembl": 34, "reserv": 93, "reset": [53, 105], "reset_view": 9, "reshap": [34, 44], "resid": [1, 13, 14, 23, 24, 26, 27, 36, 40, 46, 50, 53, 61, 65, 66, 69, 72, 75, 81, 82, 87, 89, 98, 105, 106, 109], "resids1": 22, "resids1_box": 22, "resids2": 22, "resids2_box": 22, "residu": [1, 3, 7, 13, 14, 17, 19, 21, 22, 26, 28, 30, 36, 37, 38, 39, 40, 48, 49, 50, 52, 53, 55, 61, 65, 69, 70, 71, 72, 75, 81, 82, 83, 86, 87, 92, 93, 95, 96, 99, 105, 106, 109, 112, 114], "residue_label": 86, "residue_point": 86, "residue_segindex": 50, "residuegroup": [1, 53, 98, 105, 109], "residuenam": 83, "residuenumb": 83, "residues_by_seg": 98, "residues_per_turn": 39, "resindex": [50, 109], "resindic": [50, 87, 109], "resnam": [1, 18, 19, 21, 26, 27, 28, 36, 37, 40, 48, 50, 53, 55, 61, 65, 72, 81, 82, 86, 87, 96, 97, 98, 105, 106, 109, 112], "resno": 65, "resnum": [39, 61, 72, 87, 106, 109], "resolut": [30, 106], "resolv": [3, 48, 99], "resourc": [2, 3, 15, 42, 44, 55, 99, 108], "respect": [18, 26, 30, 37, 46, 53, 109], "responsibl": 103, "resseq": [81, 82], "rest": [3, 4, 14, 19, 26], "restart": [3, 53, 58, 59, 61, 102], "restraint": 87, "restrict": [1, 13, 14, 87], "restrt": [52, 58, 59, 61], "restructur": 3, "result": [1, 10, 11, 12, 13, 14, 16, 18, 19, 20, 21, 24, 30, 31, 36, 37, 38, 39, 40, 42, 43, 44, 48, 49, 52, 53, 61, 89, 94, 105, 106, 108, 110], "result_1": 15, "results_ensembl": 15, "retain": [7, 17, 19, 21, 85], "retri": 3, "retriev": [3, 9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55, 104], "return": [1, 3, 4, 9, 10, 13, 15, 16, 18, 19, 20, 21, 22, 24, 27, 30, 33, 34, 37, 40, 42, 44, 50, 53, 57, 98, 102, 105, 106, 108, 110, 111, 112], "return_count": 40, "reus": [16, 108], "reveal": 14, "revert": 105, "review": [3, 4, 104], "reviewnb": 4, "revis": 3, "revisit": 12, "rewind": [105, 110], "rg": [98, 107], "rg3": 107, "rg5": 107, "rgba": 48, "rgyr": 53, "rgyr_df": 53, "rho": 36, "rho_i": 14, "ri": 96, "ri_sq": [15, 16], "richard": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "richardjgow": 50, "richardson": [37, 104], "right": [4, 13, 14, 31, 40, 81, 106], "rightarrow": 3, "rise": [19, 39], "rm": [6, 11, 12, 13, 14, 26, 27, 30, 53, 110], "rmin": 109, "rmin14": 109, "rmsd": [6, 7, 8, 9, 10, 11, 14, 30, 33, 41, 46, 57, 104, 105, 110], "rmsd_analysi": 53, "rmsd_df": 53, "rmsd_valu": 30, "rmsf": [7, 8, 12, 13], "rmsf_tempfactor": 14, "robert": [26, 27, 28, 52], "robust": [38, 105], "roceed": 104, "rog": 16, "rog_1": 15, "rog_10": 16, "rog_2": 15, "rog_3": 15, "rog_4": 15, "rog_bas": 16, "rog_base_10": 16, "rog_sq": [15, 16], "rog_u1": 16, "rog_u2": 16, "rohrdanz": [33, 104], "role": 15, "ronald": [33, 104], "root": [3, 6, 7, 8, 9, 11, 15, 16, 38, 78, 82], "rose": [9, 10, 52, 55, 104], "rostrup": [45, 52, 53], "rot": 48, "rotat": [3, 7, 8, 9, 10, 11, 13, 14, 38, 48, 53, 104, 109, 112], "rotate_bi": 109, "roughli": 50, "round": [102, 108], "row": [13, 16, 26, 43, 45, 53], "rsmf": 14, "rst": 4, "rst7_ala2": 52, "ru": 107, "ru3": 107, "ru5": 107, "rule": [3, 4, 44, 99, 102, 106, 108], "run": [3, 4, 5, 6, 7, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 40, 42, 44, 46, 48, 49, 52, 53, 55, 59, 61, 97, 100, 101, 102, 105, 110], "run_analysi": 15, "run_anlaysi": 15, "run_per_fram": 15, "rundown": 53, "runreactantinplac": 105, "runtim": 105, "rxn_coord": 30, "rxncoord": 30, "ryckaert": [57, 87], "rzmc11": [33, 104], "s0006": [30, 104], "s0022283609011164": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 55, 104], "s0108767305015266": [9, 10, 11, 12, 13, 14, 33, 104], "s0263": [30, 104], "sagan": 114, "sai": 3, "salah00": 105, "salt": [19, 21], "samantha": [38, 104], "same": [1, 3, 4, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 24, 26, 28, 30, 31, 33, 34, 36, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 53, 55, 60, 67, 93, 95, 96, 98, 102, 103, 105, 106, 109, 110, 114], "sampl": [7, 9, 10, 11, 12, 13, 18, 19, 20, 21, 30, 32, 33, 34, 39, 42, 43, 44, 53, 104], "sample_sd": 39, "sanitizationerror": 105, "sanitize_output": 4, "sansom": [30, 104], "save": [4, 9, 10, 13, 14, 15, 16, 19, 26, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 88, 96, 105, 108], "saw": 28, "sb17": [14, 104], "scalar": 108, "scale": [13, 15, 19, 20, 33, 76, 104], "scale_factor": 79, "scan": 4, "scatter": [3, 33, 34, 37, 44, 48], "scenario": [61, 79], "schedul": [15, 105], "schema": 72, "scheme": [14, 15, 42, 44, 102], "scheraga": 104, "schlaicha": 105, "scienc": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "sciencedirect": [37, 104], "scientif": [2, 3, 15, 85, 104, 105], "scikit": [3, 7, 42, 43, 44], "scipi": [3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 79, 101, 104, 105], "scipy2016": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "scitat": [34, 104], "scope": [3, 108], "scott": 44, "scratch": 50, "screenshot": 48, "script": [3, 4, 7, 9, 10, 11, 12, 13, 14, 15, 33, 53, 83, 102, 104], "scroll": 100, "sd": 53, "sdist": 102, "se": 19, "seaborn": [3, 12, 18, 19, 33, 34, 46], "seamlessli": [2, 67], "sean": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "search": [3, 4, 30, 106], "sebastian": [19, 20, 104], "sec": 113, "second": [1, 10, 12, 18, 19, 21, 40, 44, 53, 105, 113], "secondari": [19, 21], "section": [0, 3, 4, 9, 10, 11, 12, 13, 14, 19, 33, 53, 55, 57, 66, 81, 84, 100, 104, 105, 108], "see": [1, 2, 3, 4, 5, 7, 9, 10, 11, 12, 13, 14, 18, 19, 20, 21, 22, 26, 27, 28, 30, 32, 33, 34, 37, 38, 40, 42, 43, 44, 46, 48, 50, 52, 53, 55, 56, 57, 60, 61, 63, 66, 67, 69, 76, 81, 84, 87, 94, 96, 98, 99, 100, 101, 102, 103, 105, 106, 108, 109, 112, 114], "seem": [13, 44], "seen": [27, 34, 42, 44, 45, 46, 53, 105], "seg": [98, 106], "seg_": 87, "seg_0_protein_a": 98, "seg_0_protein_chain_a": 87, "seg_1_protein_chain_b": 87, "seg_2_sol": 87, "segid": [0, 1, 10, 26, 50, 53, 61, 65, 81, 82, 83, 105, 106, 109], "segindex": 109, "segindic": [50, 109], "segment": [1, 10, 49, 53, 61, 65, 70, 81, 87, 95, 99, 103, 105, 106, 109, 114], "segment_index": 87, "segmentgroup": [0, 1, 53, 98, 105, 109], "sel": 96, "sel_a": 40, "sel_acid": [18, 19, 21], "sel_bas": [18, 19, 21], "select": [3, 4, 6, 7, 9, 10, 11, 12, 14, 16, 17, 18, 19, 22, 25, 26, 27, 30, 31, 33, 34, 36, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 51, 66, 98, 99, 105, 110, 114], "select_atom": [1, 9, 11, 13, 14, 15, 16, 18, 19, 21, 22, 23, 24, 26, 31, 34, 36, 37, 40, 48, 50, 52, 53, 55, 96, 98, 103, 105, 106, 110, 111, 112, 114], "select_remov": 37, "selected_atom": 98, "selected_fram": 57, "selectionwrit": 96, "selector": 106, "self": [0, 3, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 33, 38, 39, 42, 43, 44, 45, 49, 108], "self_dist": 24, "self_distance_arrai": 24, "semant": 102, "send": 3, "sens": [7, 8, 84, 108, 109], "sensit": [96, 106], "sent": 3, "sentenc": 3, "separ": [1, 5, 7, 15, 16, 19, 30, 31, 36, 40, 42, 43, 81, 83, 84, 100, 102, 106, 108, 114], "septemb": [38, 104], "seq": 106, "sequenc": [46, 81, 82, 93, 103, 109], "sequence_alig": 105, "sequence_align": 105, "sequenti": [83, 106], "ser": [37, 105, 107], "seri": [30, 34, 57, 104, 105], "serial": [81, 82, 83, 100, 103, 105, 108, 109], "serious": 3, "serv": 105, "servic": 108, "session": [3, 5], "set": [2, 3, 4, 5, 7, 8, 9, 10, 11, 12, 14, 15, 16, 19, 23, 26, 27, 30, 31, 34, 37, 46, 48, 50, 52, 53, 57, 61, 66, 67, 68, 81, 83, 87, 88, 89, 92, 96, 101, 102, 103, 104, 105, 106, 108, 109, 111, 114], "set_aspect": 24, "set_aux_attribut": 57, "set_box": 112, "set_label": [42, 44, 48], "set_plot_them": 48, "set_printopt": 26, "set_titl": [42, 44], "set_xlabel": [38, 43, 44], "set_xtick": [23, 42, 44], "set_xticklabel": [23, 42, 44], "set_ylabel": [13, 16, 23, 24, 38, 43, 44], "set_ytick": 23, "set_yticklabel": 23, "set_zlabel": 44, "setposit": 52, "settabl": 57, "settl": 87, "setup": [3, 100, 101, 102, 105, 108], "sever": [1, 3, 7, 16, 29, 30, 33, 34, 53, 82, 101, 105, 108, 114], "seyler": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 104], "sfpg": [15, 104], "sfsb14": [30, 104], "sg": 105, "sgw93": [30, 104], "sh": 3, "shannon": [42, 43, 44], "shape": [10, 12, 13, 16, 19, 21, 23, 24, 26, 27, 30, 31, 33, 34, 37, 39, 40, 43, 44, 45, 48, 50, 53, 109], "shape_paramet": [105, 109], "share": [1, 3, 105], "sharei": [38, 42, 44], "shares_memori": 108, "sharex": 38, "shell": [36, 40, 106], "shift": [110, 111], "shifted_aligned_view": 9, "shini": 3, "short": [3, 27, 30, 33, 34, 108], "shortcut": [1, 106], "shorten": 30, "shorter": 83, "shortli": 105, "shoshanna": [37, 104], "should": [3, 4, 5, 12, 13, 14, 15, 22, 26, 27, 30, 31, 34, 36, 42, 44, 53, 57, 68, 72, 77, 78, 83, 87, 92, 100, 101, 102, 105, 108, 109, 114], "show": [3, 9, 10, 13, 14, 15, 19, 23, 24, 26, 27, 34, 37, 39, 44, 48, 50, 52, 53, 55, 57, 98, 106, 108, 112], "show_mdanalysi": [9, 10, 14, 19, 34, 39, 48, 50, 55], "showextrema": 44, "shown": [13, 16, 30, 34, 37, 48, 50, 53, 89, 113], "shrinkag": 45, "shubx10": 105, "shuji": [15, 104], "shupe": 15, "si": 113, "side": [13, 14, 37, 104, 108], "sidechain": 98, "sigma": [45, 48], "sign": [2, 34], "signific": [15, 22, 83, 100, 105, 114], "significantli": [5, 13, 100, 105], "silent": 112, "sim": [43, 52], "similar": [1, 3, 4, 6, 12, 15, 19, 23, 24, 30, 32, 33, 34, 37, 38, 53, 73, 82, 83, 87, 92, 93, 98, 104], "similarli": [30, 36, 37, 48, 50, 98, 109], "similiar": 15, "simmonett": 52, "simon": [37, 104], "simpl": [53, 83, 95, 98, 104, 112], "simple2": 30, "simplest": [27, 28], "simpli": [1, 3, 12, 13, 15, 21, 24, 26, 34, 40, 50, 52, 53, 60, 79, 84, 88, 101, 104, 105, 106, 109, 113], "simplifi": 98, "simplist": 21, "simul": [7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 51, 53, 55, 57, 58, 61, 67, 68, 85, 104], "simultan": [3, 19, 85], "sinc": [3, 4, 15, 45, 57, 67, 87, 102, 106], "singl": [3, 13, 15, 26, 27, 38, 46, 57, 61, 81, 105, 106, 108, 114], "singlefram": 105, "singleword": 96, "singular": [30, 38, 43, 44, 109], "site": [4, 11, 12, 13, 15, 16, 18, 20, 21, 28, 33, 36, 37, 38, 42, 43, 44, 45, 49, 108], "site_url": 4, "sitemap": 3, "sittel": [34, 104], "situat": [96, 100], "six": 101, "size": [18, 26, 36, 38, 43, 46, 49, 50, 53, 55, 71, 89, 99, 102, 111], "sjs14": [34, 104], "skimag": 48, "skip": [1, 3, 16, 46, 57, 100], "skipif": 108, "sklearn": [43, 44], "sktb15": [46, 104], "slice": [16, 53, 57, 103, 106, 111], "slice_volum": 49, "slide": 39, "slightli": 28, "slow": [15, 79, 102], "sm67": [39, 104], "small": [3, 4, 5, 26, 27, 57, 78, 101, 108], "smaller": [33, 50, 98], "smart": [30, 104, 105], "smarts_kwarg": 105, "smith": [26, 27, 28], "smooth": 48, "smoother": 48, "smoothli": 27, "sn": [33, 34], "snapshot": [3, 102], "snippet": 48, "snw": [30, 104], "so": [3, 4, 5, 10, 11, 13, 14, 15, 16, 19, 22, 23, 24, 30, 34, 36, 37, 40, 42, 45, 48, 50, 55, 57, 60, 83, 87, 88, 92, 96, 102, 103, 105, 106, 108, 109, 114], "societi": [38, 104], "soft_cut": 19, "soft_cut_q": 19, "softwar": [4, 15, 42, 43, 44, 45, 100, 104, 106, 108], "sol": [1, 30, 36, 37, 40, 48, 50, 55, 87, 112], "sol_view": 50, "sole": 105, "solut": [15, 34, 79], "solv": [2, 87], "solvat": [36, 48], "solvent": [6, 7, 40, 47, 50, 114], "solventradii": 109, "solventradiu": 109, "some": [0, 2, 3, 9, 10, 14, 15, 22, 23, 24, 26, 27, 30, 34, 45, 46, 50, 52, 53, 55, 60, 66, 100, 102, 103, 105, 108], "someon": 3, "someth": [3, 52, 53, 112], "sometim": [3, 15, 50, 57, 60, 61, 71, 89, 105, 111, 114], "somewhat": [9, 34], "soon": [30, 102], "sophiaruan": 105, "sophist": 52, "sort": [1, 26, 27, 30, 34, 53, 105, 106], "sort_backbon": 31, "sorted_bb": 31, "sourc": [2, 3, 4, 16, 30, 53, 57, 84, 96, 100, 102, 105, 108], "south": [33, 104], "space": [3, 7, 32, 33, 41, 42, 43, 44, 48, 50, 83, 84, 100, 106, 108], "spatial": [31, 46], "spc": [106, 113], "spec": 82, "special": [3, 4, 53, 108], "specif": [2, 3, 4, 7, 14, 16, 26, 27, 29, 30, 36, 53, 56, 60, 66, 73, 98, 100, 101, 103, 104, 105, 108, 110, 114], "specifi": [3, 16, 19, 26, 27, 30, 42, 43, 44, 49, 53, 57, 60, 61, 66, 83, 93, 103, 106, 108, 114], "spectral": 33, "sped": 103, "speed": [2, 105, 108], "spelt": 105, "sph": 30, "sph_6": 106, "sph_process": 30, "sphere": [30, 53, 106], "spheric": [36, 40, 106], "sphinx": [3, 4], "sphinx_autobuild": 4, "sphinxcontrib": 3, "sphlayer": 106, "sphpdb": 30, "sphpdb_file": 30, "sphzone": [40, 106], "split": [3, 5, 26, 36, 89, 94, 98, 103, 105], "split_data": 44, "splitat": 96, "splitch": 96, "splitr": 96, "spring": 38, "springer": [34, 104], "spt": 96, "spuriou": 4, "sq": [15, 16], "sq_dist_arr": 24, "sq_dist_r": 24, "sq_r": [15, 16], "sq_x": [15, 16], "sq_y": [15, 16], "sq_z": [15, 16], "sqlite": 69, "sqrt": [13, 14, 15, 16], "squar": [6, 7, 8, 9, 11, 12, 15, 16, 24, 38, 104, 105], "sr": 57, "src": [3, 84, 87], "ss18": [34, 104], "ss_rdf": 40, "ss_rdf_nodens": 40, "ssh": 2, "stabil": [3, 102], "stabl": [3, 13, 14, 22, 100], "stack": [10, 108], "stackoverflow": [3, 48], "stage": 114, "stai": 38, "stand": 57, "standalon": [2, 16, 108], "standard": [3, 7, 30, 37, 39, 42, 44, 53, 58, 59, 61, 65, 82, 84, 93, 97, 101, 105, 106], "standardization_react": 105, "star": 108, "starlark": 108, "start": [3, 4, 6, 12, 13, 15, 16, 26, 30, 50, 57, 61, 69, 83, 87, 91, 101, 105, 106, 108], "stash": 3, "state": [4, 7, 12, 13, 14, 15, 19, 32, 33, 34, 38, 53, 102, 103, 104, 111], "statedatareport": 52, "statement": [53, 105, 108], "static": [1, 10, 15, 53, 106, 109, 111, 114], "static_ag": 106, "statist": [27, 34, 104, 108], "statu": [3, 15, 82], "std": [42, 44, 105], "stddev": 105, "stdin": 0, "stdout": 52, "stelzl": [30, 104], "step": [2, 3, 10, 13, 14, 15, 16, 26, 34, 37, 39, 44, 48, 52, 53, 55, 57, 68, 72, 88, 105, 112, 114], "stern": 52, "stick": [2, 50], "still": [4, 10, 15, 27, 60, 101, 102, 103, 105, 108], "stitch": 103, "stochast": 44, "stochasticproximityembeddingn": 44, "stock": [34, 104], "stop": [15, 16, 26, 33, 42, 53, 105, 111], "storag": 85, "store": [3, 5, 12, 30, 34, 39, 48, 53, 57, 69, 85, 88, 89, 94, 105, 113], "str": [3, 96, 108], "straightforward": [2, 53, 103, 106], "strategi": 105, "stream": 15, "streamlin": 105, "streamlines_3d": 105, "strength": 108, "string": [3, 4, 19, 28, 39, 81, 83, 96, 105, 106, 108, 109], "stringio": 98, "strive": [3, 101, 108], "strongli": [3, 100, 108], "structur": [6, 8, 10, 11, 12, 16, 17, 19, 20, 21, 30, 34, 37, 38, 39, 41, 46, 52, 56, 58, 59, 61, 96, 97, 103, 104, 106, 108, 111, 114], "structure_onli": 53, "structuredgrid": 48, "studi": 19, "studio": 100, "style": [3, 66, 67, 85, 89, 94, 105, 106], "st\u00e9phane": [33, 104], "sub": [53, 66], "subclass": [16, 42, 44, 108], "subject": 3, "subkeyword": 106, "submiss": 15, "submit": [3, 108], "subplot": [23, 24, 33, 38, 42, 43, 44, 45, 48], "subscrib": [2, 99], "subselect": 106, "subsequ": 103, "subset": [16, 28, 52, 82, 111], "subspac": [7, 32, 34, 43], "subst_id": 105, "subst_nam": 105, "substanti": [103, 108], "substitut": [82, 112], "substructur": 78, "subtract": [1, 13, 84], "succe": 108, "success": [7, 32, 34, 46], "successfulli": 102, "suffer": 13, "suffici": [103, 108], "suffix": [74, 88, 102], "sugar": 106, "sugeta": [39, 104], "suggest": [3, 12, 16, 19], "suit": [3, 53, 100, 114], "suitabl": [7, 16, 32, 33, 49], "sulfur": 105, "sum": [13, 14, 15, 16, 18, 19, 21, 27, 55, 104, 108, 109], "sum_": [13, 36], "sum_i": [16, 109], "sumit112192": 105, "summar": [3, 102], "summari": [3, 39, 53, 104, 108], "summaris": 39, "super": 16, "supercomput": 100, "superfl": 40, "superimpos": 13, "superpos": 10, "superposit": [9, 10, 11, 13, 14, 53, 104], "suppl_2": [19, 20, 104], "suppli": [15, 61, 68], "support": [1, 3, 13, 19, 30, 46, 53, 66, 71, 72, 82, 84, 85, 88, 100, 103, 105, 106, 109, 111, 114], "suppress": [9, 10, 14, 22, 23, 24, 27, 30, 34, 46, 50, 52, 53], "sure": [2, 3, 4, 18, 100, 102, 106, 108], "surf": 57, "surfac": 105, "surften": 57, "surpris": 61, "survivalprob": 105, "svd_solver": [43, 44], "swail": 52, "switch": [3, 9, 19, 79, 102], "sy": [4, 52], "symbol": [44, 81], "symlink": [30, 105], "symmetr": 48, "symmetric_differ": 1, "symmetris": 45, "symposium": [33, 104], "sync": 89, "synchron": 15, "synovi": [26, 27, 28], "syntax": [4, 15, 52, 98, 108], "syrupi": 102, "system": [1, 2, 3, 4, 14, 15, 22, 26, 30, 36, 40, 50, 53, 57, 61, 80, 81, 83, 105, 108, 114], "s\u00e9bastien": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "t": [1, 3, 4, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 24, 26, 27, 28, 30, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 48, 49, 50, 52, 53, 55, 56, 57, 66, 82, 92, 96, 98, 100, 103, 104, 105, 106, 107, 108, 110, 111, 112, 114], "t_0": 27, "tab": [3, 83], "tabl": [4, 48, 105, 109, 113], "tabul": 87, "tag": [3, 100, 102, 105], "take": [2, 3, 4, 7, 14, 15, 16, 17, 23, 26, 30, 33, 42, 44, 48, 93, 96, 99, 100, 103, 106, 108, 109, 112, 114], "take_this_fram": 66, "taken": [3, 27, 40, 42, 83, 95, 106, 108], "tandfonlin": [14, 104], "tarbal": 102, "target": [9, 13, 23, 100, 105], "task": [15, 48, 53, 99, 108, 111], "tatsuo": 104, "tau": 27, "tau1": 27, "tau2": 27, "tau_1": 27, "tau_2": 27, "tau_fram": 27, "tau_max": 27, "tau_tim": 27, "tau_timeseri": 27, "tb": [45, 50], "tcl": 96, "tcount": 27, "tcp": 15, "team": 2, "technic": [2, 3, 4, 88], "techniqu": [7, 32, 33, 34], "technometr": [14, 104], "tediou": [3, 4], "tell": [3, 4, 19, 53, 84, 93, 108], "temp": 57, "temp_fil": 108, "temperatur": [14, 26, 52, 57, 81, 82], "tempfactor": [14, 61, 65, 81, 82, 97, 105, 109], "templat": 16, "temporari": [30, 105], "temporarili": 9, "tend": 4, "tensor": 109, "ter": 98, "term": [19, 57, 80, 85, 87, 99, 106], "term_dict": 57, "termin": [3, 5], "tertiari": [19, 21], "test": [1, 2, 5, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 70, 93, 96, 98, 102, 103, 106, 109, 110, 111, 112, 114], "test_": 108, "test_align": 108, "test_analysi": 108, "test_aug": 105, "test_center_of_mass_compounds_speci": 108, "test_equal_arrai": 108, "test_equal_coordin": 108, "test_foo_is_length_3": 108, "test_for_error": 108, "test_for_warn": 108, "test_open": 108, "test_pdb_writ": 108, "test_positions_share_memori": 108, "test_spars": 108, "test_write_no_arg": 108, "test_write_trajectory_netcdf4": 108, "testcontactmatrix": 108, "tested_expected_failur": 108, "testpypi": 102, "testsuit": [3, 5, 100, 102, 108], "text": [3, 4, 13, 15, 16, 20, 21, 23, 24, 30, 36, 38, 40, 43, 44, 57], "textrm": 26, "th": [34, 40], "than": [3, 13, 14, 15, 18, 19, 26, 28, 30, 36, 40, 42, 50, 53, 57, 60, 65, 71, 75, 83, 88, 99, 105, 106, 108], "thank": 104, "the05": [7, 8, 9, 10, 11, 12, 13, 14, 33, 104], "thei": [0, 3, 4, 7, 10, 12, 15, 16, 19, 20, 27, 32, 34, 37, 38, 42, 46, 48, 50, 57, 60, 61, 66, 79, 89, 92, 98, 100, 101, 102, 103, 105, 107, 108, 109, 111], "them": [1, 3, 4, 7, 9, 10, 13, 15, 18, 19, 22, 34, 38, 39, 42, 43, 44, 45, 46, 50, 52, 53, 55, 60, 61, 66, 68, 79, 81, 82, 89, 95, 101, 102, 103, 104, 105, 106, 108, 109, 112], "theme": 3, "themselv": [36, 108], "theobald": [9, 10, 11, 12, 13, 14, 33, 53, 104], "therebi": 34, "therefor": [3, 4, 13, 14, 15, 19, 33, 37, 42, 43, 50, 52, 53, 72, 79, 92, 95, 98, 108], "theta": 39, "theta_": [26, 31], "thi": [0, 1, 2, 3, 4, 5, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 24, 26, 27, 28, 30, 31, 32, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 56, 57, 60, 61, 62, 66, 68, 69, 71, 75, 79, 81, 82, 83, 84, 85, 87, 88, 89, 93, 94, 95, 96, 98, 99, 100, 101, 102, 103, 104, 105, 106, 108, 109, 111, 114], "thing": [3, 4], "think": [12, 16, 26, 53, 56], "third": [13, 53], "thoma": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "thorp": [46, 104], "those": [16, 19, 26, 30, 53, 57, 67, 87, 98, 102, 108], "though": [15, 18, 48, 68], "thought": [53, 99, 105, 111], "thousand": 15, "thr": [27, 36, 37, 53, 105, 107], "thr_c": 36, "thr_c1": 36, "thr_other": 36, "thr_other1": 36, "thread": 15, "threadpoolctl": 3, "three": [4, 13, 14, 16, 19, 22, 23, 26, 34, 42, 44, 49, 50, 83, 105, 108, 109, 114], "threonin": 36, "threshold": 57, "through": [1, 2, 3, 4, 7, 12, 14, 15, 32, 41, 49, 53, 57, 98, 103, 105, 106, 109, 111, 114], "throughout": [3, 4, 9, 10, 14, 19, 26, 27, 30, 34, 39, 48, 50, 53, 55, 98, 105], "throw": 105, "thu": [4, 53, 87], "thumb": 108, "thy": 107, "ti": 114, "tiberti": [42, 43, 44, 45, 104], "tick_interv": 23, "tidi": 34, "tidynam": 3, "tile_univers": 50, "tiled_view": 50, "tim": 3, "time": [3, 4, 12, 13, 14, 15, 16, 18, 19, 20, 26, 30, 33, 34, 36, 37, 38, 40, 52, 53, 55, 56, 57, 61, 63, 67, 68, 72, 78, 79, 88, 89, 94, 99, 102, 103, 105, 106, 108, 111, 112, 114], "time_const": 27, "time_offset": 61, "time_selector": 57, "timeout": 3, "times3": 34, "times_tim": 27, "timescal": 27, "timeseri": [10, 15, 16, 18, 19, 20, 21, 53, 57, 105], "timestamp": 15, "timestep": [9, 11, 12, 13, 15, 16, 18, 19, 20, 21, 26, 28, 33, 38, 39, 42, 43, 44, 45, 49, 53, 55, 57, 61, 81, 89, 95, 105, 106, 108, 110, 111, 112, 114], "timeunit": [66, 68, 103], "tinker": [3, 58, 59, 61, 97], "tip": 30, "tip3": [26, 28], "tip3p": [26, 113], "tip4p": [48, 113], "titl": [23, 24, 26, 27, 40, 42, 44, 45, 53, 81], "tk": 30, "tmp": 30, "tmp_file": 30, "tmp_hbond": 27, "tmpdir": 108, "tng": [58, 59, 61, 105], "tngreader": 85, "to_csv": 26, "toc": 3, "toctre": 4, "togeth": [2, 53, 99, 103, 112], "toggl": 53, "toler": 19, "tolist": [42, 44], "tom": 78, "toml": 3, "tone": [42, 43, 44, 45, 104], "too": [1, 16, 42, 44, 48, 53, 55, 56, 99, 108], "tool": [3, 4, 7, 15, 19, 30, 33, 34, 48, 53, 67, 78, 80, 96, 99, 100, 103], "toolkit": [2, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 52, 53, 55, 99, 104], "top": [3, 4, 44, 59, 61, 87, 88, 96, 97, 101, 108, 109], "topic": [3, 4], "topologi": [1, 4, 5, 14, 15, 26, 28, 52, 53, 59, 63, 65, 66, 69, 70, 71, 72, 73, 76, 77, 78, 80, 81, 82, 83, 84, 91, 92, 93, 95, 98, 99, 103, 105, 106, 108, 111], "topology_format": [61, 93, 114], "topologyattr": [50, 105], "topologygroup": [50, 109], "topologyobject": [109, 114], "toppars": 86, "torsdof": 82, "torsion": [82, 87, 105], "total": [16, 26, 34, 36, 52, 57, 109], "total_charg": [53, 109], "total_mass": [15, 16, 53, 109], "touch": [3, 61], "toward": [27, 40, 110], "tpb": [7, 41, 42, 43, 44, 45, 104], "tpr": [0, 26, 36, 40, 48, 55, 59, 61, 71, 75, 97, 98, 103, 105, 106, 109, 112, 114], "tpr2021": 98, "tpr_resid_from_on": 105, "tprparser": 105, "tprreaderdevelop": 87, "tpx": 87, "tpxio": 87, "tqdm": [3, 27, 105], "traceback": [0, 108], "traceless": 109, "track": [3, 30, 34, 105], "tracker": [2, 87, 99, 108], "tradition": 60, "traj": 88, "traj1": 114, "traj2": 114, "trajectori": [1, 5, 6, 8, 9, 17, 18, 20, 21, 26, 27, 32, 33, 36, 37, 38, 40, 42, 43, 44, 45, 48, 49, 50, 52, 54, 58, 59, 61, 66, 71, 72, 81, 82, 91, 93, 99, 104, 105, 106, 108, 112, 113, 114], "trajectory1": 103, "trajectory2": 103, "trajectory_slic": 57, "tran": [48, 55, 112], "tranform": 34, "trans1": 34, "transfer": 105, "transfer_to_memori": 103, "transferas": 15, "transform": [3, 6, 7, 13, 15, 32, 33, 34, 105, 109, 111, 114], "transit": [7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 32, 33, 34, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 48, 50, 53, 55, 104], "translat": [13, 38, 48, 50, 55, 105, 109, 112], "transmiss": 59, "transport": [30, 104], "transpos": 48, "travers": 98, "travi": [3, 108], "trc": [58, 61], "treat": [3, 42, 45, 48, 53, 72, 82, 89, 114], "tree": 3, "tri": [3, 61, 67, 79, 86, 109, 114], "triangular": 24, "triclin": [50, 67, 105], "triclinic_dimens": 55, "trigger": [3, 102, 108], "triplet": 40, "tripo": [58, 59, 61, 97], "triu": 24, "triu_indices_from": 24, "trivial": 48, "trj": [52, 58, 59, 61, 68, 79, 114], "trjcat": [89, 94, 114], "trjconv": 48, "trjreader": [52, 88], "troubl": [2, 40], "trp": 107, "trr": [53, 57, 58, 59, 61, 94, 103, 111, 114], "trr_xvf": 57, "trrreader": 89, "trrwriter": 89, "true": [1, 3, 9, 10, 11, 12, 13, 14, 16, 26, 27, 28, 30, 34, 37, 38, 40, 42, 44, 45, 46, 48, 50, 52, 53, 55, 66, 68, 89, 94, 103, 105, 106, 108, 110, 114], "truncat": [30, 89], "truth": 105, "try": [3, 4, 43, 55, 78, 87, 92, 99, 100, 101, 103, 108], "trz": [31, 58, 59, 61, 105], "trz_psf": 31, "trzreader": [90, 105], "trzwriter": 90, "tune": [100, 105], "tupl": [19, 30, 50, 98, 103, 105, 109], "turn": [13, 16, 18, 33, 34, 39, 46, 53, 57, 106, 108], "tutori": [3, 4, 5, 6, 7, 9, 10, 12, 14, 15, 19, 30, 32, 34, 39, 40, 48, 50, 53, 55, 100, 112, 114], "twice": 44, "twine": 102, "twist": 39, "twitter": 102, "two": [3, 4, 5, 6, 7, 8, 10, 15, 17, 19, 26, 27, 31, 32, 38, 42, 44, 46, 50, 53, 60, 98, 99, 103, 105, 106, 109, 114], "tx": [45, 52, 53], "txt": 4, "txyz": [58, 59, 61, 97, 109], "txyzpars": 91, "txyzread": 91, "tyler": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "type": [1, 3, 26, 42, 50, 52, 53, 58, 61, 65, 66, 72, 80, 81, 82, 83, 84, 85, 86, 87, 91, 92, 96, 97, 98, 104, 105, 106, 109, 113], "type_index": 109, "type_indic": [61, 86, 97, 109], "typeerror": 105, "typic": [1, 3, 7, 8, 13, 14, 26, 50, 52, 53, 96, 98, 99, 108, 109, 111, 112, 114], "typo": [2, 3], "tyr": [27, 107], "tyr_thr": 96, "u": [0, 1, 5, 13, 14, 15, 16, 18, 19, 20, 21, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 39, 40, 43, 48, 49, 50, 52, 53, 55, 57, 61, 66, 70, 88, 96, 98, 103, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114], "u1": [22, 38, 42, 44, 45, 46, 109, 114], "u2": [16, 22, 38, 42, 44, 45, 46, 55, 57, 114], "u21": 26, "u3": [42, 44, 45, 46, 114], "u4": [45, 46], "u5": 46, "u_": 50, "u_long": 57, "u_pickl": 103, "u_short": 57, "u_with_box": 111, "uk": 70, "ulimit": 3, "ultim": 103, "umak": 105, "un": 108, "unalign": 11, "unaligned_rmsd": 11, "uncertainti": 12, "unchang": [19, 57, 105], "uncom": [11, 14, 48], "uncommit": 3, "uncompress": [94, 105], "uncorrel": [7, 27, 32, 34], "undefin": 105, "under": [2, 3, 15, 19, 53, 87, 101, 105, 108, 110], "underestim": 101, "underflow": 14, "underli": 60, "underscor": 3, "underscore_method": 3, "understand": 99, "understood": 106, "unexpect": [3, 16], "unfamiliar": 4, "unfold": 19, "unfortun": [48, 50, 102], "unifi": 3, "uninstal": 4, "union": [1, 106], "uniqu": [7, 26, 34, 40, 57, 105, 108], "unit": [1, 5, 26, 48, 49, 50, 52, 53, 63, 66, 67, 68, 76, 79, 81, 82, 88, 101, 103, 105, 106, 108, 112], "unit_dict": 57, "unitcel": [22, 67], "unitless": 92, "univers": [1, 3, 5, 6, 7, 9, 11, 12, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 56, 60, 61, 62, 66, 68, 71, 77, 80, 81, 82, 88, 89, 93, 94, 95, 96, 98, 99, 103, 105, 106, 108, 110, 111, 112], "universe2": 103, "universe_from_origin": 39, "unix": [30, 106], "unk": [81, 82], "unknown": 105, "unless": [4, 42, 61, 87, 100, 106, 114], "unlik": [0, 1, 3, 7, 10, 19, 30, 32, 33, 38, 68, 69, 72, 75, 82, 106], "unload": 79, "unmaintain": 108, "unnecessari": 4, "unoffici": 81, "unpair": 105, "unpickl": [103, 114], "unsupport": 103, "unter": 57, "until": [16, 42, 53, 111], "unus": [44, 105], "unweight": [13, 15, 16], "unwrap": [48, 105, 109, 112], "unzip": [9, 10, 11, 12, 13, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 104], "up": [2, 3, 4, 12, 15, 16, 27, 31, 42, 44, 46, 52, 53, 57, 66, 93, 96, 99, 100, 103, 105, 106, 108, 112], "up_by_2": 112, "up_by_5": 112, "up_by_x": 112, "upcom": 105, "updat": [3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 72, 99, 100, 105, 106, 108, 110, 114], "update_represent": 14, "update_select": [26, 27], "updatingatomgroup": [53, 105, 106], "upgrad": [53, 100, 105, 108], "upload": 3, "upon": [5, 102], "upper": [23, 24, 26, 30, 42, 44, 45], "upstream": [3, 4], "ura": 107, "urei": 87, "ureybradlei": [80, 109], "url": [4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 104], "us": [0, 1, 3, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 26, 27, 31, 33, 34, 36, 37, 39, 40, 41, 42, 44, 45, 46, 48, 50, 51, 53, 55, 58, 60, 61, 67, 72, 78, 79, 80, 81, 82, 83, 85, 86, 89, 92, 93, 94, 95, 96, 99, 100, 101, 102, 103, 105, 106, 109, 110, 111, 112, 113, 114], "usabl": 100, "usag": [3, 4, 26, 34, 53, 99], "useabl": 52, "user": [1, 2, 3, 6, 7, 15, 19, 26, 28, 33, 39, 42, 43, 44, 45, 49, 53, 60, 61, 66, 68, 69, 72, 78, 79, 87, 88, 100, 101, 102, 103, 105, 106, 108, 109, 114], "user_timestep": 114, "usernam": 3, "userwarn": [28, 37], "usr": 3, "usual": [4, 13, 34, 53, 56, 82], "util": [15, 93, 105, 108], "v": [3, 6, 7, 17, 18, 19, 21, 34, 36, 104, 105], "v1": [14, 104], "v2": [105, 108], "v3": 105, "val": [37, 39, 105, 107], "valid": [37, 81, 89, 104, 105, 106], "valu": [1, 3, 7, 8, 11, 12, 13, 14, 15, 19, 24, 26, 27, 30, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 53, 57, 60, 65, 66, 67, 76, 81, 82, 83, 89, 92, 105, 106, 108, 110, 114], "valuabl": 15, "value_nam": 34, "valueerror": [83, 109], "valueerrortraceback": 109, "van": [30, 33, 60, 104, 109, 114], "var_nam": 34, "vari": [4, 37, 38, 44], "variabl": [3, 4, 5, 30, 34, 49, 100, 104, 105], "varianc": [7, 32, 34, 42, 43], "variat": [34, 38], "varieti": 61, "variou": [7, 26, 85, 105], "vdw": 60, "vdwradii": 114, "vdwradii_fil": 30, "ve": [3, 108], "vector": [3, 7, 13, 24, 31, 32, 33, 34, 39, 48, 50, 67, 105, 109], "vel": 57, "velavan": [39, 104], "veloc": [50, 58, 61, 63, 66, 71, 88, 89, 94, 105, 111, 114], "verbos": [3, 16, 26, 27, 28, 53, 102, 103, 108], "veri": [2, 3, 4, 12, 13, 15, 19, 23, 24, 27, 44, 45, 48, 79, 93, 103, 108], "verifi": 49, "verlag": [34, 104], "versa": 109, "version": [3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 67, 70, 71, 85, 99, 105, 109], "version_numb": 102, "versionad": 3, "versionchang": 3, "vert": [48, 109], "via": [3, 4, 26, 27, 28, 33, 43, 77, 98, 100, 102, 104, 105, 107], "vice": 109, "view": [4, 6, 14, 19, 30, 34, 39, 48, 50, 55, 108, 109, 114], "view1": 48, "view2": 48, "view3": 48, "viewer": 4, "viewpoint": 99, "vijai": 52, "vim": 3, "violin": 44, "violinplot": 44, "vir": 57, "viridi": 12, "virtual": [1, 3, 4, 93, 98], "virtualenvwrapp": 3, "visibl": [3, 14, 19], "visit": 104, "visual": [3, 4, 14, 15, 48, 96, 100, 105], "visualis": [7, 9, 10, 19, 22, 23, 24, 32, 33, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 50, 55, 99], "visualstudio": 100, "vlue": 30, "vmax": [42, 44], "vmd": [14, 34, 39, 53, 60, 67, 81, 84, 93, 95, 96, 105], "vmin": [42, 44], "volum": [15, 36, 40, 49, 52, 57], "volumetr": 6, "w": [10, 19, 20, 30, 33, 34, 37, 53, 66, 96, 103, 104, 111], "w477": [19, 20, 104], "w482": [19, 20, 104], "w568": 40, "w570": 40, "w_i": 13, "wa": [3, 4, 26, 50, 57, 71, 72, 83, 95, 102, 105, 106, 108, 109], "waal": [30, 60, 109, 114], "wai": [1, 3, 4, 7, 10, 12, 13, 14, 15, 16, 18, 19, 26, 27, 30, 33, 34, 48, 52, 53, 79, 98, 99, 103, 105, 106, 108, 109, 111, 114], "wait": [15, 102], "wall": 48, "wallac": [30, 104], "walt": [33, 104], "wang": [30, 52, 104], "want": [3, 4, 7, 9, 10, 15, 16, 18, 19, 21, 22, 23, 26, 30, 31, 36, 42, 43, 44, 48, 50, 52, 55, 96, 100, 108, 111], "ward": 46, "warn": [3, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 50, 52, 53, 57, 61, 65, 81, 82, 89, 100, 101], "wat": [26, 30], "watch": 67, "water": [28, 36, 40, 49, 52, 55, 98, 105, 106, 112, 113], "water_acceptors_sel": 28, "water_for_ca60": 40, "water_hydrogens_sel": 28, "waterbridgeanalysi": 105, "waterdcd": [26, 49], "waterdynam": [3, 105], "waterpsf": [26, 49], "watson": 105, "watsoncrickdist": 105, "wb": 26, "we": [2, 3, 4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 68, 82, 88, 96, 98, 99, 100, 101, 102, 105, 108, 109], "webserv": 4, "websit": [4, 15], "wed": 78, "weigh": 3, "weight": [15, 16, 26, 27, 30, 34, 38, 45, 46, 48, 65, 112], "weights_groupselect": 13, "weird": 108, "wel62": [14, 104], "welcom": [2, 3], "welford": [14, 104], "well": [1, 2, 4, 7, 15, 32, 33, 44, 48, 61, 67, 99, 101, 105, 108], "wenwei": [33, 104], "were": [4, 19, 28, 34, 67, 98, 102, 104, 105, 106, 108], "what": [3, 6, 30, 50, 53, 98, 101, 108, 109], "wheel": 105, "when": [3, 4, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 19, 22, 23, 24, 26, 27, 28, 30, 33, 34, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 57, 60, 61, 63, 66, 67, 79, 83, 87, 89, 99, 100, 101, 102, 103, 104, 105, 106, 108, 109, 111, 113, 114], "whenc": 95, "whenev": [4, 102, 108], "where": [1, 4, 5, 7, 9, 14, 15, 16, 19, 20, 21, 22, 27, 31, 32, 33, 36, 37, 38, 40, 43, 44, 46, 48, 50, 53, 57, 60, 61, 66, 71, 89, 98, 100, 102, 105, 106, 108, 109], "wherea": [13, 14, 33, 38, 39, 53, 103], "wherev": [87, 99], "whether": [1, 3, 9, 10, 14, 16, 34, 50, 114], "which": [1, 3, 4, 10, 12, 13, 14, 15, 16, 19, 20, 21, 26, 27, 28, 30, 31, 33, 34, 37, 38, 39, 40, 42, 43, 44, 46, 48, 50, 53, 55, 57, 60, 61, 67, 68, 83, 87, 89, 91, 94, 96, 98, 99, 100, 102, 103, 105, 106, 108, 109, 112, 114], "while": [3, 4, 5, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 26, 28, 30, 33, 34, 37, 38, 39, 42, 43, 44, 45, 46, 49, 52, 53, 80, 83, 84, 87, 98, 100, 102, 103, 106, 108, 111], "whilst": [15, 102, 105], "white": [48, 83], "whitespac": [4, 83], "whl": 102, "who": [3, 4, 7, 16, 101], "whole": [3, 42, 53, 55, 105, 108, 112], "wide": [3, 61], "widget": [4, 9, 10, 14, 19, 34, 39, 48, 50, 55, 100], "width": 83, "wiewiora": 52, "wiki": [67, 100], "wildcard": [30, 53, 106], "wildli": 83, "wilei": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 49, 55, 104], "window": [3, 39, 43, 96, 100, 105], "window_s": 43, "window_step": 27, "wirefram": 48, "wise": [6, 7, 17, 23, 53], "wish": [26, 28, 52, 55, 79, 111, 114], "with_box": 111, "within": [1, 6, 7, 16, 17, 18, 19, 20, 22, 26, 28, 30, 36, 38, 40, 42, 43, 44, 45, 50, 53, 57, 60, 67, 77, 105, 106, 111, 112], "without": [3, 4, 13, 15, 28, 30, 34, 37, 50, 53, 61, 87, 99, 103, 104, 105, 106, 108, 109, 114], "wodak": [37, 104], "won": 4, "wonder": 14, "woolf": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 104], "word": [4, 37, 104], "work": [1, 2, 4, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 55, 56, 57, 62, 67, 79, 96, 99, 100, 102, 104, 105, 106, 108, 111], "workaround": [89, 94], "worker": [15, 105], "worker_pool": 15, "workflow": [3, 4, 48, 108], "workon": 3, "workon_hom": 3, "workshop": 5, "worth": 108, "would": [3, 13, 15, 16, 19, 39, 43, 100, 101, 105, 106, 109], "wouter": [42, 43, 44, 45, 104], "wrap": [15, 48, 105, 109, 112], "wrapper": [30, 112], "wrapperclass": 16, "writabl": 89, "write": [4, 6, 7, 9, 11, 12, 14, 15, 17, 19, 20, 21, 22, 23, 24, 30, 34, 46, 48, 50, 52, 61, 62, 64, 68, 78, 90, 99, 105, 111, 113, 114], "write_next_timestep": 105, "writer": [4, 10, 53, 62, 64, 65, 66, 67, 68, 71, 73, 78, 79, 81, 82, 83, 89, 90, 94, 95, 96, 103, 105, 108, 111], "written": [3, 10, 53, 66, 71, 76, 79, 81, 83, 84, 87, 89, 93, 96, 103, 105], "wrong": [67, 105, 114], "www": [3, 4, 19, 20, 30, 34, 37, 99, 104], "x": [0, 3, 4, 12, 13, 14, 15, 16, 18, 19, 20, 21, 30, 31, 34, 44, 48, 49, 50, 53, 56, 57, 66, 67, 81, 82, 83, 87, 95, 104, 105, 106, 112], "x3dna": 105, "x86_64": [3, 100, 105], "xdist": [3, 100, 105, 108], "xdr": [89, 94], "xdrlib": [3, 105], "xfail": [100, 108], "xhgchen": 105, "xlabel": [12, 14, 15, 16, 18, 23, 24, 26, 27, 30, 31, 34, 36, 37, 38, 39, 40, 48, 53, 57], "xml": [59, 61, 97, 109], "xpdb": [58, 59, 61, 97, 109], "xplor": [59, 61, 97], "xtc": [36, 37, 40, 42, 44, 45, 46, 48, 53, 55, 58, 59, 61, 98, 103, 105, 112, 114], "xtcreader": 94, "xtcwriter": 94, "xtick": [42, 44, 45], "xvg_bz2": 57, "xvgfileread": 57, "xvgreader": 57, "xx": 57, "xxx": 87, "xy": [26, 48, 57], "xyz": [10, 50, 53, 58, 59, 61, 73, 91, 97, 98, 103, 109], "xyzpars": 95, "xyzplugin": 95, "xyzread": 95, "xyzwrit": 95, "xz": 57, "y": [3, 12, 13, 15, 16, 19, 20, 34, 48, 49, 50, 57, 66, 81, 82, 83, 95, 106], "yaml": [102, 108], "yank": 102, "yasp": [58, 59, 61], "ye": [87, 104], "yellow": 50, "yet": [3, 108], "yield": [31, 34, 105], "ylabel": [12, 14, 15, 16, 19, 20, 21, 22, 23, 24, 26, 27, 30, 31, 34, 36, 37, 38, 39, 40, 48, 57], "yml": [4, 108], "yn": 106, "ynamic": 104, "york": [34, 104], "you": [1, 2, 3, 4, 5, 6, 7, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 26, 27, 30, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 57, 60, 61, 62, 64, 67, 78, 79, 80, 89, 96, 98, 99, 100, 101, 102, 103, 104, 106, 108, 109, 110, 111, 112, 114], "your": [2, 4, 5, 6, 7, 10, 13, 15, 17, 19, 20, 21, 22, 26, 27, 30, 32, 34, 36, 37, 40, 42, 43, 44, 45, 46, 48, 49, 50, 53, 55, 60, 61, 67, 75, 84, 87, 99, 100, 103, 104, 105, 108, 111, 112], "yourmodul": 104, "yourscript": 104, "yourself": [4, 7, 30, 37, 45, 48], "ython": 104, "ytick": [42, 44, 45], "yutong": 52, "yx": 57, "yy": 57, "yz": 57, "z": [3, 15, 16, 26, 33, 39, 48, 50, 57, 66, 81, 82, 83, 95, 104, 106, 112], "zenodo": 5, "zero": [12, 16, 24, 30, 50, 60, 92], "zeta": 30, "zhao": 52, "zheng": [33, 104], "ziolek": [26, 27, 28], "zip": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 27, 28, 33, 34, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 50, 55, 104], "zip_data_with_label": 44, "zlabel": 30, "zmax": 106, "zmin": 106, "zone": 106, "zorder": [14, 22], "zpo": 26, "ztimol": 105, "zx": 57, "zy": 57, "zz": 57, "\u00e5": [15, 16, 19, 26, 28, 38, 48, 53, 67, 83, 113], "\u00e5ngstr\u00f6m": [19, 38, 53, 68, 79, 113], "\u03bc": 113, "\u03c8": [37, 104], "\u03d5": [37, 104]}, "titles": ["Advanced topology concepts", "AtomGroup", "Contributing to MDAnalysis", "Contributing to the main codebase", "Contributing to the user guide", "Example data", "Examples", "Analysis", "Alignments and RMS fitting", "Aligning a structure to another", "Aligning a trajectory to a reference", "Aligning a trajectory to itself", "Calculating the pairwise RMSD of a trajectory", "Calculating the root mean square deviation of atomic structures", "Calculating the root mean square fluctuation over a trajectory", "Parallelizing analysis", "Writing your own trajectory analysis", "Distances and contacts", "Write your own native contacts analysis method", "Fraction of native contacts over a trajectory", "Q1 vs Q2 contact analysis", "Contact analysis: number of contacts within a cutoff", "Atom-wise distances between matching AtomGroups", "All distances between two selections", "All distances within a selection", "Hydrogen Bond Analysis", "Calculating hydrogen bonds: the basics", "Calculating hydrogen bond lifetimes", "Calculating hydrogen bonds: advanced selections", "Polymers and membranes", "Analysing pore dimensions with HOLE2", "Determining the persistence length of a polymer", "Dimension reduction", "Non-linear dimension reduction to diffusion maps", "Principal component analysis of a trajectory", "Structure", "Average radial distribution functions", "Protein dihedral angle analysis", "Elastic network analysis", "Helix analysis", "Calculating the RDF atom-to-atom", "Trajectory similarity", "Calculating the Clustering Ensemble Similarity between ensembles", "Evaluating convergence", "Calculating the Dimension Reduction Ensemble Similarity between ensembles", "Calculating the Harmonic Ensemble Similarity between ensembles", "Comparing the geometric similarity of trajectories", "Volumetric analyses", "Calculating the solvent density around a protein", "Computing mass and charge density on each axis", "Constructing, modifying, and adding to a Universe", "Other", "Using ParmEd with MDAnalysis and OpenMM to simulate a selection of atoms", "Quick start guide", "Transformations", "Centering a trajectory in the box", "Frequently asked questions", "Auxiliary files", "Coordinates", "Format reference", "Guessing", "Format overview", "chemfiles (chemfiles Trajectory or file)", "CONFIG (DL_Poly Config)", "COOR, NAMBDIN (NAMD binary restart files)", "CRD (CHARMM CARD files)", "DATA (LAMMPS)", "DCD (CHARMM, NAMD, or LAMMPS trajectory)", "DCD (Flexible LAMMPS trajectory)", "DMS (Desmond Molecular Structure files)", "GMS (Gamess trajectory)", "GRO (GROMACS structure file)", "GSD (HOOMD GSD file)", "IN, FHIAIMS (FHI-aims input files)", "INPCRD, RESTRT (AMBER restart files)", "ITP (GROMACS portable topology files)", "LAMMPSDUMP (LAMMPS ascii dump file)", "MMTF (Macromolecular Transmission Format)", "MOL2 (Tripos structure)", "NCDF, NC (AMBER NetCDF trajectory)", "ParmEd (ParmEd Structure)", "PDB, ENT (Standard PDB file)", "PDBQT (Autodock structure)", "PQR file (PDB2PQR / APBS)", "PSF (CHARMM, NAMD, or XPLOR protein structure file)", "TNG (Trajectory Next Generation)", "TOP, PRMTOP, PARM7 (AMBER topology)", "TPR (GROMACS run topology files)", "TRJ, MDCRD, CRDBOX (AMBER ASCII trajectory)", "TRR (GROMACS lossless trajectory file)", "TRZ (IBIsCO and YASP trajectory)", "TXYZ, ARC (Tinker)", "XML (HOOMD)", "XPDB (Extended PDB file)", "XTC (GROMACS compressed trajectory file)", "XYZ trajectory", "Selection exporters", "Topology", "Groups of atoms", "Welcome to MDAnalysis User Guide\u2019s documentation!", "Installation", "Module imports in MDAnalysis", "Preparing a release", "Reading and writing files", "References", "MDAnalysis Release Notes", "Atom selection language", "Standard residues in MDAnalysis selections", "Tests in MDAnalysis", "The topology system", "Slicing trajectories", "Trajectories", "On-the-fly transformations", "Units and constants", "Universe"], "titleterms": {"": 99, "0": 105, "1": [16, 105], "2": [16, 105], "2d": 48, "3": 105, "3d": 48, "4": 105, "5": 105, "6": 105, "7": 105, "IN": 73, "In": 103, "On": [3, 4, 112], "The": [40, 109], "With": 3, "__init__": 16, "_single_fram": 16, "abstract": 3, "access": [26, 57], "acid": 107, "acknowledg": 50, "action": 108, "ad": [0, 3, 4, 50, 109], "addit": 100, "advanc": [0, 4, 28], "aim": 73, "align": [7, 8, 9, 10, 11, 14, 46, 48], "alignto": 9, "aligntraj": 10, "all": [23, 24, 27, 28, 55, 61], "also": 15, "amber": [74, 79, 86, 88], "an": [1, 13, 14, 16, 30, 103, 109], "analys": [7, 15, 30, 47, 48], "analysi": [6, 7, 15, 16, 18, 19, 20, 21, 25, 26, 34, 37, 38, 39, 42, 44, 53, 101, 108], "angl": [37, 60, 87], "anoth": 9, "apb": 83, "appli": 15, "approach": 15, "arc": 91, "argument": [43, 57], "around": 48, "arrai": 23, "ascii": [76, 88], "ask": 56, "assert": 108, "atom": [1, 13, 22, 23, 24, 28, 31, 36, 37, 40, 52, 53, 56, 81, 98, 103, 106], "atomgroup": [1, 13, 22, 53, 96, 109, 114], "attribut": [50, 57, 61, 86, 97, 109, 114], "autodock": 82, "automat": [4, 53], "auxiliari": 57, "averag": [14, 36, 48], "axi": 49, "azur": 108, "b": 14, "back": 55, "backbon": [31, 107], "background": [12, 13, 14, 15, 18, 19, 20, 21, 30], "base": [3, 57, 113], "basic": 26, "befor": 55, "between": [12, 13, 22, 23, 28, 42, 44, 45, 52], "binari": 64, "blank": 50, "block": 15, "blog": 102, "bond": [7, 25, 26, 27, 28, 50, 60, 87], "boolean": 106, "boundari": 22, "box": 55, "branch": [3, 102], "bridg": 18, "bug": 105, "build": [3, 4, 102, 103], "ca": 22, "calcul": [12, 13, 14, 20, 21, 22, 23, 24, 26, 27, 28, 31, 36, 37, 40, 42, 44, 45, 48], "canon": 109, "card": 65, "case": 98, "center": [48, 55], "chain": 31, "chainid": 87, "chang": [3, 4, 56, 105], "charg": [49, 113], "charmm": [65, 67, 84], "chemfil": 62, "choos": 31, "ci": [102, 108], "cirru": [102, 108], "citat": [53, 104], "class": [3, 16], "clean": 102, "clone": 4, "close": 38, "cluster": [42, 43], "code": [3, 101], "codebas": 3, "codecov": 108, "combin": 15, "commit": [3, 4], "commun": 99, "compar": [43, 46], "compil": 100, "complet": 102, "complianc": 3, "compon": 34, "compress": 94, "comput": 49, "concept": 0, "conda": [3, 100, 102], "condit": 22, "config": 63, "connect": [106, 109], "constant": [27, 113], "construct": [1, 50, 114], "contact": [7, 17, 18, 19, 20, 21, 38], "content": 34, "continu": 108, "contribut": [2, 3, 4, 16], "contributor": 105, "control": 2, "convent": 108, "converg": [34, 43], "convers": 113, "coor": 64, "coordin": [10, 13, 23, 53, 58, 61], "copi": 10, "core": 101, "cosin": 34, "coverag": 108, "crd": 65, "crdbox": 88, "creat": [1, 3, 4, 14, 16, 28, 50, 52, 87, 102, 109, 114], "cryst1": 81, "custom": [0, 13, 100, 112], "cutoff": [19, 21], "cython": 3, "czi": 105, "darker": 3, "dask": 15, "data": [5, 13, 26, 30, 57, 66, 108], "dataset": 100, "dcd": [67, 68], "default": [42, 43, 44, 109], "defin": [16, 18, 19, 21], "delet": [30, 109], "densiti": [40, 48, 49, 113], "depend": [3, 7, 101], "deprec": 105, "desmond": 69, "determin": 31, "develop": [3, 4, 86, 87, 89, 91, 100, 102], "deviat": 13, "differ": [42, 43, 44, 52, 108], "diffus": 33, "dihedr": [37, 60, 87], "dimens": [7, 30, 32, 33, 43, 44], "dimension": [34, 43], "directli": 57, "directori": 108, "discret": 46, "distanc": [7, 17, 22, 23, 24, 46], "distribut": [36, 40], "dl_poli": 63, "dm": 69, "do": [55, 56], "doc": 3, "docstr": 3, "document": [3, 4, 99, 102], "duecredit": [53, 104], "dump": 76, "dynam": [1, 53, 106], "each": [24, 49], "edit": 4, "edr": 57, "elast": 38, "empti": 1, "enchanc": 105, "energi": 113, "enhanc": 105, "ensembl": [42, 43, 44, 45], "ensur": 3, "ent": 81, "entri": 87, "environ": [3, 4], "eoss": 105, "error": [42, 44], "estim": [42, 44], "evalu": 43, "exampl": [5, 6, 112], "except": 108, "export": 96, "extend": 93, "extens": 82, "factor": 14, "fail": 108, "failur": 105, "fashion": 15, "fhi": 73, "fhiaim": 73, "field": 81, "file": [4, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 55, 57, 62, 64, 65, 69, 71, 72, 73, 74, 75, 76, 81, 83, 84, 87, 89, 93, 94, 102, 103, 108, 114], "find": [26, 27, 28], "first": 11, "fit": [7, 8], "fix": 105, "fixtur": 108, "flag": 100, "flexibl": 68, "fluctuat": 14, "fly": [48, 55, 112], "forc": 113, "forg": [3, 102], "fork": [3, 4], "form": 15, "format": [3, 57, 59, 61, 77, 82, 87, 103, 109], "fraction": 19, "fragment": 98, "frame": [11, 15, 53, 57, 103], "frequent": 56, "from": [1, 16, 53, 86, 109, 114], "fr\u00e9chet": 46, "function": [15, 16, 18, 26, 36, 40, 108], "further": 26, "gamess": 70, "gaussian": 38, "gener": [6, 46, 85, 87, 101, 108], "geometr": [46, 106], "get": [2, 53, 102], "gh": 4, "git": 2, "github": [2, 3, 108], "gm": 70, "gro": 71, "gromac": [71, 75, 87, 89, 94], "group": [1, 19, 21, 28, 36, 37, 53, 98], "groupbi": 1, "gsd": 72, "guess": [60, 114], "guess_acceptor": 28, "guess_hydrogen": 28, "guid": [4, 53, 99], "guidelin": 3, "gyrat": [15, 16], "handl": 57, "hard": 19, "harmon": 45, "hausdorff": 46, "heatmap": 23, "helix": 39, "helper": 26, "hetatm": 81, "histori": 63, "hole": 30, "hole2": [4, 30], "hook": 4, "hoomd": [72, 92], "hydrogen": [7, 25, 26, 27, 28], "ibisco": 90, "imag": 48, "import": [7, 101, 108], "improp": [60, 87], "improv": 105, "increment": 102, "index": [1, 106], "individu": 27, "inform": [53, 58, 61, 109], "inpcrd": 74, "input": [73, 103, 108], "instal": 100, "integr": 108, "interact": [3, 48], "intermitt": 27, "issu": 105, "iter": 57, "itp": 75, "itself": [11, 12, 36], "janin": 37, "jupyt": 4, "keyword": [86, 106], "known": 105, "lammp": [66, 67, 68, 76], "lammpsdump": 76, "languag": [1, 106], "larger": 50, "length": [31, 113], "level": 109, "lifetim": 27, "linear": 33, "list": [98, 101], "load": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 52, 53, 55, 57, 114], "lossless": 89, "mac": 3, "macromolecular": 77, "main": 3, "major": 105, "make": 48, "mamba": 3, "mandatori": 3, "manual": 102, "map": 33, "mass": [13, 49, 60], "match": [22, 23], "matplotlib": 48, "mdanalysi": [2, 3, 16, 52, 61, 87, 99, 101, 105, 107, 108, 113], "mdanalysisdata": 5, "mdanalysistest": 5, "mdcrd": 88, "mean": [13, 14], "measur": [34, 43], "membran": [7, 29], "memori": [57, 103], "merg": 50, "method": [1, 16, 18, 42, 43, 44, 46, 53, 109, 114], "mmtf": 77, "model": 38, "modifi": [50, 106, 109], "modul": [3, 101, 108], "mol2": 78, "molecul": [0, 48], "molecular": 69, "more": 28, "multipl": [13, 15, 19, 42, 44, 96, 103], "multiprocess": 15, "nambdin": 64, "namd": [64, 67, 84], "nativ": [18, 19], "nbval": 4, "nc": 79, "ncdf": 79, "netcdf": 79, "network": 38, "new": [3, 4, 10, 50, 105, 108], "next": [85, 102], "nglview": 48, "non": [23, 33], "note": [86, 87, 89, 91, 95, 105], "notebook": 4, "nucleic": 107, "nucleobas": 107, "number": [21, 102], "object": 109, "old": 102, "one": [42, 44], "onli": 38, "openmm": 52, "oper": 1, "optimis": 100, "option": [3, 4, 101], "order": [1, 30, 106], "other": [15, 16, 51], "out": [42, 44, 53, 65, 66, 67, 71, 79, 81, 82, 83, 89], "outlin": 102, "output": 103, "over": [14, 19, 56, 57], "overview": [4, 53, 61], "own": [16, 18], "packag": [3, 102], "page": 4, "pairwis": 12, "parallel": [15, 108], "paramet": [30, 42, 44], "parm": [52, 80], "parm7": 86, "pars": [86, 87], "parser": [61, 97], "particip": 99, "pass": 57, "path": 46, "pdb": [30, 81, 82, 93], "pdb2pqr": 83, "pdbqt": 82, "pep8": 3, "per": 15, "perform": 105, "period": 22, "persist": 31, "pickl": 103, "pip": [3, 100], "plot": [13, 14, 18, 19, 20, 21, 22, 23, 24, 30, 37, 42, 44, 45, 46, 48], "polici": 102, "polym": [7, 29, 31], "popul": 50, "pore": 30, "portabl": 75, "posit": [50, 53, 56], "possibl": 15, "post": 102, "pqr": 83, "pre": 4, "preexist": 106, "prepar": 102, "preview": 4, "princip": 34, "prmtop": 86, "profil": 30, "project": 34, "properti": 114, "protein": [37, 48, 50, 55, 84, 107], "psf": 84, "pull": 3, "push": 3, "pytest": 4, "python": 3, "pyvista": 48, "q1": 20, "q2": 20, "question": 56, "quick": 53, "radial": [36, 40], "radiu": [15, 16, 19], "ramachandran": 37, "rdf": 40, "read": [57, 58, 61, 65, 66, 67, 70, 71, 72, 76, 79, 81, 82, 83, 84, 85, 87, 88, 89, 94, 95, 96, 97, 103], "reader": [58, 61], "readi": 102, "rebas": 3, "recreat": 57, "reduc": 34, "reduct": [7, 32, 33, 43, 44], "refer": [9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 26, 27, 28, 30, 31, 33, 34, 36, 37, 38, 39, 40, 42, 43, 44, 45, 46, 48, 49, 50, 52, 53, 55, 59, 104], "releas": [102, 105], "request": 3, "residu": [0, 23, 24, 98, 107], "restart": [64, 74], "restrt": 74, "restructuredtext": 4, "result": [15, 26], "rm": [7, 8], "rmsd": [12, 13, 53], "rmsf": 14, "root": [13, 14], "rule": 101, "run": [39, 87, 108], "salt": 18, "same": 108, "sanit": 4, "scikit": 48, "scratch": 114, "see": 15, "segid": 87, "segment": [0, 50, 98], "select": [1, 13, 23, 24, 28, 37, 52, 53, 57, 96, 103, 106, 107], "sequenc": 98, "serial": 15, "set": [1, 13, 42, 44], "similar": [7, 41, 42, 43, 44, 45, 46, 106], "simpl": [15, 106], "simul": 52, "singl": [19, 53, 96], "site": 40, "skip": 108, "slice": [1, 110], "soft": 19, "solvent": [48, 55], "space": 34, "specif": [28, 40, 78, 81, 82, 83, 84, 86, 87, 95, 109], "speed": 113, "split": [1, 15], "squar": [13, 14], "standalon": 57, "standard": [81, 107], "start": [2, 53], "static": 48, "step": 4, "store": 26, "structur": [7, 9, 13, 14, 35, 53, 69, 71, 78, 80, 82, 84], "sugar": 107, "suit": [101, 108], "summari": 102, "support": [57, 58, 61, 87, 96, 97], "surfac": [30, 48], "system": [52, 109], "tabl": [58, 61, 97], "task": 102, "temporari": [102, 108], "test": [3, 4, 100, 101, 105, 108], "thi": 55, "third": 11, "tile": 50, "time": [27, 113], "tinker": 91, "tip": 4, "tng": 85, "tool": 108, "top": 86, "topologi": [0, 50, 61, 75, 86, 87, 97, 109, 114], "topologyattr": [0, 109], "tpr": 87, "tprparser": 87, "trajectori": [7, 10, 11, 12, 13, 14, 15, 16, 19, 30, 34, 41, 46, 53, 55, 56, 57, 62, 67, 68, 70, 79, 85, 88, 89, 90, 94, 95, 103, 110, 111], "transfer": 103, "transform": [16, 48, 54, 55, 112], "transmiss": 77, "triangul": 48, "tripo": 78, "trj": 88, "trr": 89, "try": [42, 44], "trz": 90, "two": [12, 13, 23, 36], "txyz": 91, "type": 60, "typic": 102, "uniqu": 1, "unit": [57, 113], "univers": [0, 10, 13, 50, 57, 109, 114], "unwrap": 55, "up": 102, "updat": [1, 102], "upload": 102, "us": [4, 28, 30, 38, 43, 52, 57, 87, 98, 104, 108], "usag": 57, "user": [4, 99], "userguid": [4, 102], "v": 20, "valu": 109, "version": [2, 87, 100, 102], "view": 3, "virtualenv": 3, "visual": [101, 108], "visualis": [14, 30, 34, 48], "vmd": 30, "volumetr": [7, 47], "warn": 108, "water": [26, 48, 50], "weight": 13, "welcom": 99, "what": 4, "wheel": 102, "where": [2, 3], "whole": 48, "why": [56, 99], "wise": [15, 22, 24], "within": [21, 24], "without": 40, "work": [3, 30, 53], "workflow": [102, 112], "wrap": 55, "write": [3, 10, 16, 18, 53, 65, 66, 67, 71, 79, 81, 82, 83, 89, 96, 103, 108], "xml": 92, "xpdb": 93, "xplor": 84, "xtc": 94, "xvg": 57, "xyz": 95, "yasp": 90, "your": [3, 16, 18]}})
\ No newline at end of file
diff --git a/dev/standard_selections.html b/dev/standard_selections.html
index 3636adee..497b485c 100644
--- a/dev/standard_selections.html
+++ b/dev/standard_selections.html
@@ -332,10 +332,10 @@ Protein backbone
-C
-N
-CA
+CA
O
+C
+N
@@ -347,44 +347,44 @@ Protein backbone
-THY
-RG
+RC5
+A
+DC3
+THY
+DA5
+DT3
+RU5
+ADE
+
+DG3
RU3
-DA3
G
-RC5
-DT3
+DC
+RA5
RC
+DA3
+U
-RU
-RA
+DA
DC5
-URA
-RG3
-RG5
-RA5
-DG5
-
-T
+RC3
+RA
C
-A
-RA3
-DC3
-RU5
-DT5
-DT
+RG
+URA
+DG
-GUA
-U
-RC3
+RA3
CYT
-DA
-DG3
-DC
-ADE
+DG5
+DT
+GUA
+RU
+RG3
+DT5
-DG
-DA5
+RG5
+T
@@ -399,11 +399,11 @@ Nucleic backbone
-O3’
+O5’
+P
+O3’
C3’
C5’
-P
-O5’
@@ -413,22 +413,22 @@ Nucleic backbone
-O2
-N4
-C2
-N9
-N2
-O4
-O6
+C5
+C4
+O2
N1
-
-N3
-N7
-C5
+C2
C6
-C4
N6
+N7
+
+N3
C8
+N2
+N9
+O6
+N4
+O4
C5M
@@ -439,11 +439,11 @@ Nucleic sugars
-C3’
+C1’
+O4’
C2’
+C3’
C4’
-C1’
-O4’
diff --git a/dev/testing.html b/dev/testing.html
index 04043c75..ecf34d3a 100644
--- a/dev/testing.html
+++ b/dev/testing.html
@@ -433,13 +433,13 @@ Testing exceptions and warnings
Failing tests
-To mark an expected failure, use pytest.mark.xfail()
decorator:
+To mark an expected failure, use pytest.mark.xfail()
decorator:
@pytest.mark.xfail
def tested_expected_failure():
assert 1 == 2
-To manually fail a test, make a call to pytest.fail()
:
+To manually fail a test, make a call to pytest.fail()
:
def test_open(self, tmpdir):
outfile = str(tmpdir.join('lammps-writer-test.dcd'))
try:
@@ -452,7 +452,7 @@ Failing tests
Skipping tests
-To skip tests based on a condition, use pytest.mark.skipif(condition)
decorator:
+To skip tests based on a condition, use pytest.mark.skipif(condition)
decorator:
import numpy as np
try:
from numpy import shares_memory
@@ -467,7 +467,7 @@ Skipping testsassert not np.shares_memory(original.ts.positions, copy.ts.positions)
-To skip a test if a module is not available for importing, use pytest.importorskip('module_name')
+To skip a test if a module is not available for importing, use pytest.importorskip('module_name')
def test_write_trajectory_netCDF4(self, universe, outfile):
pytest.importorskip("netCDF4")
return self._test_write_trajectory(universe, outfile)
@@ -477,7 +477,7 @@ Skipping tests
Fixtures
-Use fixtures as much as possible to reuse “resources” between test methods/functions. Pytest fixtures are functions that run before each test function that uses that fixture. A fixture is typically set up with the pytest.fixture()
decorator, over a function that returns the object you need:
+Use fixtures as much as possible to reuse “resources” between test methods/functions. Pytest fixtures are functions that run before each test function that uses that fixture. A fixture is typically set up with the pytest.fixture()
decorator, over a function that returns the object you need:
@pytest.fixture
def universe(self):
return mda.Universe(self.ref_filename)