diff --git a/doc/html/_sources/buildsystem.txt b/doc/html/_sources/buildsystem.txt
index ac23b70c3bd51d49509b710ab096fce7266829df..2ec26dc0ee6fef295ef194dba1d795681478d920 100644
--- a/doc/html/_sources/buildsystem.txt
+++ b/doc/html/_sources/buildsystem.txt
@@ -24,21 +24,21 @@ Dependencies
 --------------------------------------------------------------------------------
 
 |project| is build on top of |ost_l|_ (|ost_s|), requiring at least version 
-|ost_version|. |ost_s| must be configured and compiled with ``ENABLE_MM=1`` to
-use |openmm|_. To create the build system, |cmake|_ is required. The same
-versions of |python|_ and |boost|_ are needed as used in |ost_s|. For |eigen3|_
-we need at least version 3.3.0. To build the documentation, |sphinx|_ is
-required.
+|ost_version|. A C++11 compatible compiler is required. |ost_s| must be
+configured and compiled with ``ENABLE_MM=1`` to use |openmm|_. To create the
+build system, |cmake|_ is required. The same versions of |python|_ and |boost|_
+are needed as used in |ost_s|. For |eigen3|_ we need at least version 3.3.0. To
+build the documentation, |sphinx|_ is required.
 
 The currently preferred versions are:
 
 * |ost_s|_ |ost_version|
 * |openmm|_ 7.1.1
 * |cmake|_ 2.8.12
-* |python|_ 2.7.5
+* |python|_ 2.7.11
 * |boost|_ 1.53.0
-* |eigen3|_ 3.3.0
-* |sphinx|_ 1.3.1
+* |eigen3|_ 3.3.1
+* |sphinx|_ 1.4.1
 
 --------------------------------------------------------------------------------
  Using |cmake|
diff --git a/doc/html/_sources/changelog.txt b/doc/html/_sources/changelog.txt
index 67c6449a8c77ba6a9eae9b7aa2af68ec4d2c97c6..0e9ceb554298f192f7dea1e1b082a380fff4a766 100644
--- a/doc/html/_sources/changelog.txt
+++ b/doc/html/_sources/changelog.txt
@@ -5,6 +5,19 @@
 Changelog
 ================================================================================
 
+Release 2.1.0
+--------------------------------------------------------------------------------
+
+* This is expected to be the last release supporting Python 2.
+* This project now requires a C++11 compatible compiler.
+* Introduced VINA scoring function in the sidechain module. A scoring function 
+  specific RotamerConstructor is provided that comes with extensive heuristics 
+  to parametrize arbitrary compounds. 
+* Motif finding algorithm to identify objects in 3D space, e.g. binding sites.
+  The algorithm is based on principles of geometric hashing.
+* Several minor bug fixes, improvements, and speed-ups  
+
+
 Release 2.0.0
 --------------------------------------------------------------------------------
 
diff --git a/doc/html/_sources/loop/backbone.txt b/doc/html/_sources/loop/backbone.txt
index 3acc2f8e1a2b74a97e559c050e71eb97c777802e..e5e2d9964cfb6cd7cce133bd1cd5869c3bd19d19 100644
--- a/doc/html/_sources/loop/backbone.txt
+++ b/doc/html/_sources/loop/backbone.txt
@@ -79,6 +79,22 @@ The BackboneList class
              code which is not one of the 20 default amino acids or if
              *sequence* and *dihedral_angles* are inconsistent in size.
 
+  .. method:: BackboneList(residues)
+
+    Creates a BackboneList with positions and sequence extracted from
+    *residues*.
+
+    :param residues:    List of :class:`ost.mol.ResidueHandle` objects from
+                        which the backbone positions and one letter codes
+                        are extracted.
+
+    :type residues:     :class:`list`
+
+    :raises: :exc:`~exceptions.RuntimeError` if a residue in *residues*
+              contains a one letter code which is not one of the 20 default
+              amino acids or when there is a residue not providing all
+              required positions.
+
   .. method:: BackboneList(sequence, residues)
 
     Creates a BackboneList from given *sequence* and positions extracted from
diff --git a/doc/html/_sources/loop/structure_db.txt b/doc/html/_sources/loop/structure_db.txt
index b3089c7248bc40d5f4bd292125795b2edde82204..756afe78cd46954025953926e787eb618c2f5f58 100644
--- a/doc/html/_sources/loop/structure_db.txt
+++ b/doc/html/_sources/loop/structure_db.txt
@@ -141,6 +141,7 @@ database, you might want to consider two things:
   The StructureDBDataType enum has to be passed at initialization of a 
   StructureDB in order to define what data you want to store additionally
   to backbone coordinates and sequence.
+  For the bare minimum (only backbone coordinates and sequence), use Minimal.
   If you want to store all data possible, use All. If you only want a subset,
   you can combine some of the datatypes with a bitwise or operation 
   (see example script for :class:`StructureDB`). One important note:
@@ -148,8 +149,8 @@ database, you might want to consider two things:
   assigned. Only the according memory is allocated and set to zero, the actual 
   information must be assigned manually (see example script again...).
 
-  All, Dihedrals, SolventAccessibilities, ResidueDepths, DSSP, AAFrequencies,
-  AAFrequenciesStruct
+  Minimal, All, Dihedrals, SolventAccessibilities, ResidueDepths, DSSP, 
+  AAFrequencies, AAFrequenciesStruct
   
 
 .. class:: StructureDB(data_to_store)
@@ -249,7 +250,8 @@ database, you might want to consider two things:
 
     :type id:           :class:`str`
     :type chain_name:   :class:`str`
-    :type ent:          :class:`ost.mol.EntityView`
+    :type ent:          :class:`ost.mol.EntityHandle` / 
+                        :class:`ost.mol.EntityView`
     :type seqres:       :class:`ost.seq.SequenceHandle`
     :type prof:         :class:`ost.seq.ProfileHandle`
     :type only_longest_strech: :class:`bool`
@@ -314,14 +316,22 @@ database, you might want to consider two things:
 
 
   .. method:: GetBackboneList(fragment, sequence)
-              GetBackboneList(n_stem, c_stem, fragment, sequence)
+              GetBackboneList(n_stem, c_stem, fragment, sequence="")
+              GetBackboneList(coord_idx, sequence="")
+              GetBackboneList(n_stem, c_stem, coord_idx, sequence="")
 
-    :returns: Backbone list with positions extracted from *fragment*.
+
+    :returns: Backbone list with positions extracted from *fragment* or
+              full entry at *coord_idx*
     :rtype:   :class:`BackboneList`
 
     :param fragment: Fragment definition from which to extract positions.
     :type fragment:  :class:`FragmentInfo`
-    :param sequence: Sequence to set for the returned backbone list.
+    :param coord_idx:   Idx of entry from which to extract positions.
+    :type coord_idx:    :class:`int`
+    :param sequence: Sequence of the returned backbone list. If not
+                     set, the original sequence at specified location in the 
+                     database is used.
     :type sequence:  :class:`str`
     :param n_stem: Positions on which the backbone list's N-terminus should be
                    superposed onto.
@@ -330,89 +340,116 @@ database, you might want to consider two things:
                    superposed onto.
     :type c_stem:  :class:`ost.mol.ResidueHandle`
 
-    :raises:  :exc:`~exceptions.RuntimeError` if fragment is invalid (happens
-              if the fragment does not fully fit into one of the connected 
-              stretches in the database) or if *sequence* contains a one letter 
-              code which is not one of the 20 default amino acids.
-
+    :raises:  :exc:`~exceptions.RuntimeError` if the length of *sequence* does
+              not match with the desired backbone list, if *sequence* contains 
+              a character which does not belong to the 20 proteinogenic amino 
+              acids or if *fragment* or *coord_idx* is invalid. Fragment can 
+              be invalid when it does not fully fit into one of the connected 
+              stretches of residues in the database. 
 
   .. method:: GetSequence(fragment)
+              GetSequence(coord_idx)
 
-    :returns: The sequence of *fragment*
+    :returns: The sequence of *fragment* or full entry at *coord_idx*
     :rtype:   :class:`str`
 
     :param fragment:    Fragment definition from which to extract the sequence.
     :type fragment:     :class:`FragmentInfo`
 
-    :raises:  :exc:`~exceptions.RuntimeError` if fragment is invalid. This is
-              the case when the fragment does not fully fit into one of the
-              connected stretches of residues in the database.
+    :param coord_idx:   Idx of entry from which to extract the sequence
+    :type coord_idx:    :class:`int`
+
+    :raises:  :exc:`~exceptions.RuntimeError` if fragment or coord_idx is 
+              invalid. Fragment can be invalid when it does not fully fit into 
+              one of the connected stretches of residues in the database.
 
 
   .. method:: GetDSSPStates(fragment)
+              GetDSSPStates(coord_idx)
 
-    :returns: The dssp states of *fragment*
+    :returns: The dssp states of *fragment* or full entry at *coord_idx*
     :rtype:   :class:`str`
 
     :param fragment: Fragment definition from which to extract the states.
     :type fragment:  :class:`FragmentInfo`
 
+    :param coord_idx:   Idx of entry from which to extract the dssp states
+    :type coord_idx:    :class:`int`
+
     :raises:  :exc:`~exceptions.RuntimeError` if database does not contain dssp 
-              data or if fragment is invalid. This is
-              the case when the fragment does not fully fit into one of the
-              connected stretches of residues in the database.
+              data or if fragment/ coord_idx is invalid. Fragment can be invalid 
+              when it does not fully fit into one of the connected stretches of 
+              residues in the database.
 
 
   .. method:: GetDihedralAngles(fragment)
+              GetDihedralAngles(coord_idx)
 
     :returns: The phi and psi dihedral angles of every residue of *fragment*
+              or full entry at *coord_idx*
     :rtype:   :class:`list` of pairs (:class:`tuple`)
 
     :param fragment: Fragment definition from which to extract the dihedrals.
     :type fragment:  :class:`FragmentInfo`
 
+    :param coord_idx:   Idx of entry from which to extract the dihedral angles
+    :type coord_idx:    :class:`int`
+
     :raises:  :exc:`~exceptions.RuntimeError` if database does not contain 
-              dihedral angle data or if fragment is invalid. This is
-              the case when the fragment does not fully fit into one of the
+              dihedral angle data or if fragment/ coord_idx is invalid. 
+              Fragment can be invalid when it does not fully fit into one of the 
               connected stretches of residues in the database.
 
 
   .. method:: GetResidueDepths(fragment)
+              GetResidueDepths(coord_idx)
 
-    :returns: Residue depth for each residue of *fragment*.
+    :returns: Residue depth for each residue of *fragment* or full entry 
+              at *coord_idx*
     :rtype:   :class:`list` of :class:`float`
 
     :param fragment: Fragment definition from which to extract the residue
                      depths
     :type fragment:  :class:`FragmentInfo`
 
+    :param coord_idx:   Idx of entry from which to extract the residue depths
+    :type coord_idx:    :class:`int`
+
     :raises:  :exc:`~exceptions.RuntimeError` if database does not contain 
-              residue depth data or if fragment is invalid. This is
-              the case when the fragment does not fully fit into one of the
+              residue depth data or if fragment/ coord_idx is invalid. 
+              Fragment can be invalid when it does not fully fit into one of the 
               connected stretches of residues in the database.
 
 
   .. method:: GetSolventAccessibilitites(fragment)
+              GetSolventAccessibilitites(coord_idx)
 
-    :returns: Solvent accessibility for each residue of *fragment* in square A
-              as calculated by :meth:`~ost.mol.alg.Accessibility` when adding
-              the structure to the database.
+    :returns: Solvent accessibility for each residue of *fragment* or full entry
+              at *coord_idx* in square A as calculated by 
+              :meth:`~ost.mol.alg.Accessibility` when adding the structure to 
+              the database.
     :rtype:   :class:`list` of :class:`float`
 
     :param fragment: Fragment definition from which to extract the solvent
                      accessibilities
     :type fragment:  :class:`FragmentInfo`
 
+    :param coord_idx:   Idx of entry from which to extract the solvent 
+                        accessibilities
+    :type coord_idx:    :class:`int`
+
     :raises:  :exc:`~exceptions.RuntimeError` if database does not contain 
-              solvent accessibility data or if fragment is invalid. This is
-              the case when the fragment does not fully fit into one of the
+              solvent accessibility data or if fragment/ coord_idx is invalid. 
+              Fragment can be invalid when it does not fully fit into one of the 
               connected stretches of residues in the database.
 
 
   .. method:: GetSequenceProfile(fragment)
+              GetSequenceProfile(coord_idx)
 
-    :returns: The sequence profile for the residues defined by *fragment* with
-              the BLOSUM62 probabilities as NULL model.
+    :returns: The sequence profile for the residues defined by *fragment* or 
+              full entry at *coord_idx* with the BLOSUM62 probabilities as NULL 
+              model.
     :rtype:   :class:`ost.seq.ProfileHandle`
 
     :param fragment:    Fragment definition from which to extract the sequence
@@ -420,16 +457,21 @@ database, you might want to consider two things:
 
     :type fragment:     :class:`FragmentInfo`
 
-    :raises:  :exc:`~exceptions.RuntimeError` if database does not cotain
-              aa frequency data or if fragment is invalid. This is
-              the case when the fragment does not fully fit into one of the
+    :param coord_idx:   Idx of entry from which to extract the sequence profile
+    :type coord_idx:    :class:`int`
+
+    :raises:  :exc:`~exceptions.RuntimeError` if database does not contain 
+              sequence profile data or if fragment/ coord_idx is invalid. 
+              Fragment can be invalid when it does not fully fit into one of the 
               connected stretches of residues in the database.
                     
 
   .. method:: GetStructureProfile(fragment)
+              GetStructureProfile(coord_idx)
 
-    :returns: The structure profile for the residues defined by *fragment* with
-              the BLOSUM62 probabilities as NULL model.
+    :returns: The structure profile for the residues defined by *fragment* or
+              full entry at *coord_idx* with the BLOSUM62 probabilities as NULL 
+              model.
     :rtype:   :class:`ost.seq.ProfileHandle`
 
     :param fragment:    Fragment definition from which to extract the structure
@@ -437,9 +479,12 @@ database, you might want to consider two things:
 
     :type fragment:     :class:`FragmentInfo`
 
-    :raises:  :exc:`~exceptions.RuntimeError` if database does not contain
-              aa frequencies struct data or if fragment is invalid. This is
-              the case when the fragment does not fully fit into one of the
+    :param coord_idx:   Idx of entry from which to extract the structure profile
+    :type coord_idx:    :class:`int`
+
+    :raises:  :exc:`~exceptions.RuntimeError` if database does not contain 
+              structure profile data or if fragment/ coord_idx is invalid. 
+              Fragment can be invalid when it does not fully fit into one of the 
               connected stretches of residues in the database.
 
 
@@ -461,7 +506,7 @@ database, you might want to consider two things:
 
     :raises:  :exc:`~exceptions.RuntimeError` if *bb_list* and 
               *residue_depths* differ in size, when their size is 0
-              or when database does not contain aa frequencies struct data.
+              or when database does not contain residue depth data.
 
 
   .. method:: SetStructureProfile(coord_idx, prof)
diff --git a/doc/html/_sources/modelling/algorithms.txt b/doc/html/_sources/modelling/algorithms.txt
index 51357bc0615a49e58f2ef12f3efad67eeb3b003d..7c775b0a1ba537244c4f7e22bdff9a38cb5ef582 100644
--- a/doc/html/_sources/modelling/algorithms.txt
+++ b/doc/html/_sources/modelling/algorithms.txt
@@ -164,3 +164,165 @@ example pipeline.
 .. autofunction:: GenerateDeNovoTrajectories
 
 
+Motif Finder
+--------------------------------------------------------------------------------
+
+Distinct spatial arrangements of atoms or functional groups are key for protein 
+function. For their detection, ProMod3 implements the MotifFinder algorithm 
+which is based on geometric hashing as described by Nussinov and Wolfson 
+[nussinov1991]_. The algorithm consists of a learning stage, a detection stage 
+and a refinement stage.
+
+Learning Stage: A motif (query) is represented by a set of coordinates. Triplets
+(p1, p2, p3) of coordinates are selected that define triangles. For each 
+triangle one can define an orthogonal vector basis 
+(in our case v1 = norm(p2-p1), v3 = norm(cross(v1,p3-p1), 
+v2 = norm(cross(v1,v3)))). For each coordinate not in [p1,p2,p3], we add the 
+identity of the query/triangle as value to a hash map. 
+The corresponding key consists of discretized values describing the edge lengths 
+of the triangle, as well as the coordinate transformed into the triangle 
+specific orthogonal vector basis. That's 6 numbers in total.
+
+Detection Stage: The goal is to identify one or several subsets of target 
+coordinates that resemble an input query. 
+We first setup an accumulator containing a counter for each triangle observed 
+in the input query. We then iterate over each possible triangle with vertices 
+p1, p2 and p3 in the target coordinates. At the beginning of each iteration, 
+all counters in the accumulator are set to zero. Again, we build a vector basis 
+given that triangle and transform all coordinates not in [p1,p2,p3] into that 
+vector space. For each transformed coordinate we obtain a key for the query hash 
+map. If there is one or several values at that location in the hash map, 
+we increment the corresponding locations in the accumulator. 
+Once all coordinates are processed, we search for high counts in the 
+accumulator. Given *N* query coordinates, we keep a solution for further 
+refinement if count/(*N*-3) >= *hash_tresh*. This is repeated until all 
+triangles in the target are processed. One key problem with this approach is 
+the discretization of floating point numbers that give raise to the hash map 
+keys. Two extremely close values might end up in different bins just because
+they are close to the bin boundaries. For each of the 6 relevant numbers
+we estimate the actual bin as well as the closest neighbouring bin. Processing
+all possible combinations results in 64 hash map lookups instead of only one.
+
+Refinement Stage: Every potential solution identified in the detection stage is
+further refined based on the *distance_thresh* and *refine_thresh* parameters.
+A potential solution found in the detection stage is a pair of triangles, one
+in the query and one in the target, for which we find many matching coordinates 
+in their respective vector space. We start with a coordinate mapping based on 
+the triangle vertices from the query and the target (3 pairs). 
+This coordinate mapping is iteratively updated by estimating the minimum RMSD 
+superposition of the mapped query coordinates onto the target, apply that 
+superposition on the query, find the closest target coordinate for each 
+coordinate in the query and redo the mapping by including all pairs with 
+minimum distance < *distance_thresh*. Iteration stops if nothing changes 
+anymore. The solution is returned to the user if the final fraction of mapped 
+query coordinates is larger or equal *refine_thresh*.
+The larger the mapping, the more accurate the superposition. As we start with 
+only the three triangle vertices, *distance_thresh* is doubled for the initial 
+iteration.
+
+.. literalinclude:: ../../../tests/doc/scripts/modelling_motif_finder.py
+
+.. class:: MotifQuery(positions, identifier, min_triangle_edge_length, \
+                      max_triangle_edge_length, bin_size)
+           MotifQuery(positions, identifier, min_triangle_edge_length, \
+                      max_triangle_edge_length, bin_size, flags)
+           MotifQuery(query_list)
+
+  A single query or a container of queries.
+  The constructor performs the learning stage of a single query or combines
+  several queries, so they can be searched at once. 
+
+  :param positions:     Coordinates of the query
+  :param identifier:    Descriptor of the query
+  :param min_triangle_edge_length: To avoid the full O(n^3) hell, triangles
+                        with any edge length below *min_triangle_edge_length*
+                        are skipped
+  :param max_triangle_edge_length: Same as *min_triangle_edge_length* but 
+                        upper bound
+  :param bin_size:      Bin size in A, relevant to generate hash map keys
+  :param flags:         Flag in range [0,63] for every coordinate in *positions*.
+                        They're also added to the hash map keys (default: 0). 
+                        This means that additionally to having a matching 
+                        relative position, the coordinates must also have a 
+                        matching flag in the detection/refinement stage. 
+                        If not provided (in the query and in the search), 
+                        only coordinates matter.
+  :param query_list:    E pluribus unum
+
+  :type positions:      :class:`ost.geom.Vec3List`
+  :type identifier:     :class:`str`
+  :type min_triangle_edge_length: :class:`float`
+  :type max_triangle_edge_length: :class:`float`
+  :type bin_size:       :class:`float`
+  :type flags:          :class:`list` of :class:`int`
+  :type query_list:     :class:`list` of :class:`MotifQuery`
+
+
+  .. method:: Save(filename)
+
+    Saves the query down to disk 
+
+    :param filename:    filename
+    :type filename:     :class:`str`
+
+  .. staticmethod:: Load(filename)
+
+    Load query from disk
+
+    :param filename:    filename
+    :type filename:     :class:`str`
+
+  .. method:: GetPositions(query_idx)
+
+    Returns coordinates of specified query
+
+    :param query_idx:   Query from which you want the positions
+    :type query_idx:    :class:`int`
+
+  .. method:: GetIdentifiers()
+
+    Returns a list of all query identifiers.
+
+  .. method:: GetN()
+
+    Returns the number of queries
+
+
+
+.. class:: MotifMatch
+
+  Object that holds information about a match found in :meth:`FindMotifs`
+
+  .. attribute:: query_idx 
+
+    Index of matching query
+
+  .. attribute:: mat 
+
+    Transformation matrix to superpose matching query onto target
+
+  .. attribute:: alignment 
+
+    List of tuples which define matching pairs of query/target coordinates
+
+
+.. method:: FindMotifs(query, target_positions, hash_tresh=0.4, \
+                       distance_thresh=1.0, refine_thresh=0.7, \
+                       flags=list())
+
+  Performs the detection and refinement stages of the geometric hashing 
+  algorithm. 
+
+  :param query:         Query to be searched
+  :param target_positions: Coordinates of the target
+  :param hash_thresh:   Parameter relevant for detection stage
+  :param distance_thresh: Parameter relevant for refinement stage
+  :param refine_thresh: Parameter relevant for refinement stage
+  :param flags:         Equivalent to *flags* in :class:`MotifQuery`
+                        constructor. If you didn't provide anything there,
+                        this can be ignored. Only the actual coordinates
+                        matter in this case.
+
+  :returns:             All found matches
+
+  :rtype:               :class:`list` of :class:`MotifMatch`
diff --git a/doc/html/_sources/references.txt b/doc/html/_sources/references.txt
index 927de6ddbad6c032f0f760c17384e977d1ed31e9..18a5a3b25ba4779ccd336b9bbfdae278f04735ab 100644
--- a/doc/html/_sources/references.txt
+++ b/doc/html/_sources/references.txt
@@ -62,6 +62,10 @@ References
                Exploring the conformational space of protein side chains using 
                dead-end elimination and the A* algorithm. Proteins.
 
+.. [nussinov1991] Nussinov R and Wolfson HJ (1991).
+                  Efficient detection of three-dimensional structural motifs in
+                  biological macromolecules by computer vision techniques. PNAS.
+
 .. [shapovalov2011] Shapovalov MV and Dunbrack RL Jr. (2011). 
                     A smoothed backbone-dependent rotamer library for proteins 
                     derived from adaptive kernel density estimates and 
@@ -75,6 +79,10 @@ References
                potentials and threading score functions using information 
                maximization. Proteins. 
 
+.. [trott2010] Trott O, Olson AJ (2010). AutoDock Vina: improving the speed and 
+               accuracy of docking with a new scoring function, efficient 
+               optimization and multithreading. J Comput Chem
+
 .. [zhou2005] Zhou H, Zhou Y (2005). 
               Fold Recognition by Combining Sequence Profiles Derived From 
               Evolution and From Depth-Dependent Structural Alignment of 
diff --git a/doc/html/_sources/sidechain/frame.txt b/doc/html/_sources/sidechain/frame.txt
index d8365f4a5316d2efebaaaafb50a87238b1b3ac2d..94a3150d0361fa6fe2b468b35752f0f19d57cebb 100644
--- a/doc/html/_sources/sidechain/frame.txt
+++ b/doc/html/_sources/sidechain/frame.txt
@@ -14,7 +14,7 @@
 ..  limitations under the License.
 
 
-Frame
+Frame - The Rigid Part
 ================================================================================
 
 .. currentmodule:: promod3.sidechain
diff --git a/doc/html/_sources/sidechain/index.txt b/doc/html/_sources/sidechain/index.txt
index aeac7212ce7a9232b81c95d2178cb32d07ff6595..192257b499d3826c3ed5891cadb39ede1f7a7291 100644
--- a/doc/html/_sources/sidechain/index.txt
+++ b/doc/html/_sources/sidechain/index.txt
@@ -42,11 +42,10 @@ Contents:
 .. toctree::
    :maxdepth: 2
 
-   rotamer_id
    rotamer
    frame
-   rotamer_lib
    rotamer_constructor
+   rotamer_lib
    graph
    disulfid
    loading
diff --git a/doc/html/_sources/sidechain/rotamer.txt b/doc/html/_sources/sidechain/rotamer.txt
index d3ae44ebe66b3f2139cd7a5ba04e29de80efc9ac..56b95301448e5a955ef38ee0105c9d60b9de291f 100644
--- a/doc/html/_sources/sidechain/rotamer.txt
+++ b/doc/html/_sources/sidechain/rotamer.txt
@@ -14,22 +14,96 @@
 ..  limitations under the License.
 
 
-Rotamers
+Representing Sidechains - Rotamers & Co. 
 ================================================================================
 
 .. currentmodule:: promod3.sidechain
 
-A rotamer represents an amino acid sidechain and is basically a set of 
-:class:`Particle` objects. There exist two types. The :class:`RRMRotamer` and 
-:class:`FRMRotamer`. 
-To gather all possible rotamers for one particular sidechain position,
+A rotamer represents an amino acid sidechain identified by a :class:`RotamerID` 
+and is a set of :class:`Particle` objects. 
+Two types of rotamers exist. The :class:`RRMRotamer` and :class:`FRMRotamer`. 
+To gather all possible rotamers for one location,
 ProMod3 offers the :class:`RRMRotamerGroup` and :class:`FRMRotamerGroup`.
-Pairwise interactions between particles give raise to pairwise energies between 
-rotamers. Nevertheless, the energy calculation itself happens on the level
-of RotamerGroups and is mostly hidden away in the construction of the
-the :class:`RotamerGraph`. If you're too lazy to build up your rotamers
-by hand, you might be interested in the :class:`RotamerConstructor`.
+All parts of the structure that are kept rigid can be represented by
+a :class:`Frame` object.
+
 
+RotamerID
+--------------------------------------------------------------------------------
+
+The sidechain module has its own definition of amino acids to satisfy custom 
+requirements for the implemented sidechain construction algorithms. 
+As an example there are histidine in two possible protonation states, 
+that affect the hbond term or different versions of proline/cysteine. 
+
+.. class:: RotamerID
+
+  Enumerates the amino acids. Possible values:
+
+  .. hlist::
+    :columns: 2
+  
+    * ARG - Arginine
+    * ASN - Asparagine
+    * ASP - Aspartate
+    * GLN - Glutamine
+    * GLU - Glutamate
+    * LYS - Lysine
+    * SER - Serine
+    * CYS - Cystein
+    * CYH - "free" Cystein
+    * CYD - disulfid bonded Cystein
+    * MET - Methionine
+    * TRP - Tryptophane
+    * TYR - Tyrosine
+    * THR - Threonine
+    * VAL - Valine
+    * ILE - Isoleucine
+    * LEU - Leucine
+    * PRO - Proline
+    * CPR - cis-Proline
+    * TPR - trans-Proline
+    * HIS - Histidine
+    * HSD - d-protonated Histidine
+    * HSE - e-protonated Histidine
+    * PHE - Phenylalanine
+    * GLY - Glycine
+    * ALA - Alanine
+    * XXX - Invalid
+  
+  The RotamerID enum can be accessed either directly as ``promod3.sidechain.ARG``
+  or as ``promod3.sidechain.RotamerID.ARG``.
+
+  
+How can I get an ID?
+^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^
+
+The RotamerID enum can directly be accessed from Python. Two convenient
+functions exist to get RotamerIDs from the :class:`ost.conop.AminoAcid` enum
+or from amino acid three letter codes.
+
+.. method:: TLCToRotID(tlc)
+
+  Directly translates the three letter code into a RotamerID. Following
+  exactly the naming convention defined above.  
+
+  :param tlc:           Three letter code of amino acid
+  :type tlc:            :class:`str`
+
+  :returns:             :class:`RotamerID`, XXX if **tlc** cannot be recoginzed.
+
+
+.. method:: AAToRotID(aa)
+
+  Directly translates **aa** into a RotamerID. Note, that it is not possible
+  to generate special IDs this way 
+  (e.g. HSD, HSE or the special prolines/cysteins) since they're simply not
+  defined in :class:`ost.conop.AminoAcid` 
+
+  :param aa:            AA enum of amino acid
+  :type  aa:            :class:`ost.conop.AminoAcid`
+
+  :returns:             :class:`RotamerID`, XXX if **aa** is invalid.
 
 
 The Smallest Building Block - The Particle
@@ -44,7 +118,9 @@ function.
 
   The available scoring functions between :class:`Particle` objects
 
-  * SCWRL4
+  * SCWRL4 - :ref:`scwrl4-scoring-function`
+  * SCWRL3 - :ref:`scwrl3-scoring-function`
+  * VINA - :ref:`vina-scoring-function`
 
 .. class:: Particle
 
@@ -93,13 +169,19 @@ function.
 
 
 
+.. _scwrl4-scoring-function:
 
 The SCWRL4 scoring function
---------------------------------------------------------------------------------
+^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^
+
+The SCWRL4 scoring function combines a Lennard-Jones style term with 
+a hydrogen bond term. Details can be found in the relevant publication
+[krivov2009]_.
 
 .. class:: SCWRL4ParticleType
 
   The SCWRL4 energy function differentiates between following particle types
+  that define the behaviour of the Lennard-Jones style term:
 
   * HParticle   - represents hydrogen
   * CParticle   - default representation of a carbon
@@ -123,9 +205,17 @@ The SCWRL4 scoring function
   :param charge:        The charge of the particle, relevant for the hydrogen 
                         bond term
   :param lone_pairs:    Direction of all possible lone pairs of the particle,
-                        relevant for the hydrogen bond term
+                        relevant for the hydrogen bond term. If set, the 
+                        particle is a potential hydrogen bond acceptor.
+                        An example would be the Serine OG atom, where you can 
+                        represent the two lone pairs with vectors pointing
+                        from the OG position towards the lone pair centers.
   :param polar_direction: The polar direction of the particle,
-                          relevant for the hdrogen bond term
+                          relevant for the hydrogen bond term. If set, the 
+                          particle is a potential hydrogen bond donor. An
+                          example would be the Serine HG hydrogen. The 
+                          *polar_direction* would be a vector 
+                          estimated as follows: hg_pos-og_pos.
 
   :type name:           :class:`str`
   :type particle_type:  :class:`SCWRL4ParticleType`
@@ -135,6 +225,82 @@ The SCWRL4 scoring function
   :type polar_direction: :class:`ost.geom.Vec3`
 
 
+.. _scwrl3-scoring-function:
+
+The SCWRL3 scoring function
+^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^
+
+The SCWRL3 scoring function implements a simple repulsion term that depends on
+the hard-sphere radius of the involved particles. 
+Details can be found in the relevant publication [canutescu2003]_.
+
+.. method:: CreateSCWRL3Particle(name, radius, pos)
+
+  Creates and returns a :class:`Particle` that can evaluate the SCWRL3 scoring
+  function
+
+  :param name:          The name of the particle
+  :param radius:        The hard-sphere radius of the particle, relevant for the
+                        repulsion term.
+  :param pos:           The position of the particle
+
+  :type name:           :class:`str`
+  :type radius:         :class:`float`
+  :type pos:            :class:`ost.geom.Vec3`
+
+
+.. _vina-scoring-function:
+
+The VINA scoring function
+^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^
+
+The VINA scoring function is a combination of scores that are named 
+gaussian1, gaussian2, repulsion, hydrophobic and hbond in the Autodock Vina
+software [trott2010]_. VINA only evaluates heavy atoms. Gaussian1, gaussian2
+and repulsion are evaluated for all pairs of particles. Hydrophobic is only
+evaluated between C_VINAParticle :class:`VINAParticleType` and hbond is
+evaluated between hydrogen bond donor/acceptor pairs. While SCWRL3 and SCWRL4 
+are intended to evaluate sidechain-sidechain interactions in proteins, 
+VINA is mainly targeted at interactions between sidechains and ligands.
+
+The VINA scoring function differentiates between the following particle types:
+
+.. class:: VINAParticleType
+
+    * O_D_VINAParticle - Oxygen that can be a hydrogen bond donor 
+    * N_D_VINAParticle - Nitrogen that can be a hydrogen bond donor
+    * O_A_VINAParticle - Oxygen that can be a hydrogen bond acceptor
+    * N_A_VINAParticle - Nitrogen that can be a hydrogen bond acceptor
+    * O_AD_VINAParticle - Oxygen that can be a hydrogen bond donor and acceptor
+    * N_AD_VINAParticle - Nitrogen that can be a hydrogen bond donor and acceptor
+    * O_VINAParticle - Oxygen
+    * N_VINAParticle - Nitrogen    
+    * S_VINAParticle - Sulfur    
+    * P_VINAParticle - Phosphorus    
+    * C_P_VINAParticle - Polar carbon that is covalently bound to a charged atom  
+    * C_VINAParticle - Hydrophobic carbon that is only bound to other carbons or hydrogens
+    * F_VINAParticle - Fluorine
+    * Cl_VINAParticle - Chlorine   
+    * Br_VINAParticle - Bromine
+    * I_VINAParticle - Iodine    
+    * M_VINAParticle - Metals    
+    * INVALID_VINAParticle - Invalid particle... 
+
+
+.. method:: CreateVINAParticle(name, particle_type, pos)
+
+  Creates and returns a :class:`Particle` that can evaluate the VINA scoring
+  function
+
+  :param name:          The name of the particle
+  :param radius:        The type of the particle
+  :param pos:           The position of the particle
+
+  :type name:           :class:`str`
+  :type radius:         :class:`VINAParticleType`
+  :type pos:            :class:`ost.geom.Vec3`
+
+
 Rotamers
 --------------------------------------------------------------------------------
 
@@ -692,3 +858,4 @@ Rotamer Groups
 
     Searches rotamer with lowest self energy *l_e* and deletes all
     rotamers with *self_energy* > *l_e* + *thresh*
+
diff --git a/doc/html/_sources/sidechain/rotamer_constructor.txt b/doc/html/_sources/sidechain/rotamer_constructor.txt
index 3a297d5d0846dd0808cad22419dad15add0bf11b..c8cca8deb12f3b56c889c32e9c9bcc954d38599f 100644
--- a/doc/html/_sources/sidechain/rotamer_constructor.txt
+++ b/doc/html/_sources/sidechain/rotamer_constructor.txt
@@ -19,18 +19,18 @@ Rotamer Constructor
 
 .. currentmodule:: promod3.sidechain
 
-Instead of creating rotamers by yourself, you can simply use the convenient
-functionality provided by ProMod3.
+Instead of creating rotamers or frame residues by yourself, you can use the 
+convenient functionality provided by ProMod3.
 
 
-Constructing Rotamers and Frame Residues
+The RotamerConstructor Baseclass
 --------------------------------------------------------------------------------
 
 
 .. class:: RotamerConstructor
 
   Abstract base class that cannot be initialized from Python. It builds 
-  an interface implemented by energy function specific constructors 
+  an interface implemented by scoring function specific constructors 
   (e.g. :class:`SCWRL4RotamerConstructor`). 
 
   .. method:: ConstructRRMRotamerGroup(res, id, residue_index, rot_lib,\
@@ -213,6 +213,10 @@ Constructing Rotamers and Frame Residues
 
 
 
+Scoring Function Specific RotamerConstructors 
+--------------------------------------------------------------------------------
+
+
 .. class:: SCWRL4RotamerConstructor(cb_in_sidechain)
 
   This object implements the full interface defined in 
@@ -306,3 +310,180 @@ Constructing Rotamers and Frame Residues
     :type psi:          :class:`float`
     :type n_ter:        :class:`bool`
     :type c_ter:        :class:`bool`
+
+
+
+
+.. class:: SCWRL3RotamerConstructor(cb_in_sidechain)
+
+  This object implements the full interface defined in 
+  :class:`RotamerConstructor` and constructs rotamers and frame residues that 
+  are parametrized according to the SCWRL3 method. They contain only heavy atoms. 
+
+  :param cb_in_sidechain: If set to true, all constructed rotamers will contain 
+                          the cb atom. This flag also affects the construction 
+                          of frame residues and controls whether the cb atom 
+                          shows up in the backbone frame residues or sidechain 
+                          frame residues.
+                          This is useful when you want to represent ALA or 
+                          GLY with actual rotamers, but be aware of increased 
+                          runtime. This flag can be set to False for most
+                          modeling applications and you just don't generate
+                          any rotamers for ALA and GLY.
+
+  :type cb_in_sidechain: :class:`bool`
+
+
+  .. method:: AssignInternalEnergies(rot_group, id, residue_index, \
+                                     [phi = -1.0472, psi = -0.7854, \
+                                      n_ter = False, c_ter = False])
+
+    Overrides the method defined in :class:`RotamerConstructor`.
+    Takes the rotamer group and assigns every single rotamer its internal
+    energy based on the probabilistic approach used by SCWRL3.
+    => -internal_e_prefac*log(p/max_p), where internal_e_prefac and p are
+    rotamer specific and max_p is the maximum probablity of any of the rotamers
+    in **rot_group**. If you construct a rotamer group by the
+    ConstructRRMRotamerGroup/ConstructFRMRotamerGroup functions, this function 
+    is already called at construction and the energies are properly assigned.
+
+    :param rot_group:   containing all rotamers for which internal energies have
+                        to be assigned
+    :param id:          Identifies the sidechain
+    :param residue_index: The index of the residue which is represented by 
+                          *rot_group*    
+    :param phi:         The dihedral angle of the current residue
+    :param psi:         The dihedral angle of the current residue
+    :param n_ter:       Whether the residue is n-terminal
+    :param c_ter:       Whether the residue is c-terminal
+
+    :type rot_group:    :class:`RRMRotamerGroup` / :class:`FRMRotamerGroup`
+    :type id:           :class:`RotamerID`
+    :type residue_index: :class:`int`
+    :type phi:          :class:`float`
+    :type psi:          :class:`float`
+    :type n_ter:        :class:`bool`
+    :type c_ter:        :class:`bool`
+
+
+.. class:: VINARotamerConstructor(cb_in_sidechain)
+
+  This object implements the full interface defined in 
+  :class:`RotamerConstructor` and constructs rotamers and frame residues that 
+  are parametrized according to the VINA method. They contain only heavy atoms. 
+
+  :param cb_in_sidechain: If set to true, all constructed rotamers will contain 
+                          the cb atom. This flag also affects the construction 
+                          of frame residues and controls whether the cb atom 
+                          shows up in the backbone frame residues or sidechain 
+                          frame residues.
+                          This is useful when you want to represent ALA or 
+                          GLY with actual rotamers, but be aware of increased 
+                          runtime. This flag can be set to False for most
+                          modeling applications and you just don't generate
+                          any rotamers for ALA and GLY.
+
+  :type cb_in_sidechain: :class:`bool`
+
+
+  .. method:: AssignInternalEnergies(rot_group, id, residue_index, \
+                                     [phi = -1.0472, psi = -0.7854, \
+                                      n_ter = False, c_ter = False])
+
+    Overrides the method defined in :class:`RotamerConstructor`.
+    Takes the rotamer group and assigns every single rotamer its internal
+    energy based on the probabilistic approach used by SCWRL3/SCWRL4.
+    => -internal_e_prefac*log(p/max_p), where internal_e_prefac and p are
+    rotamer specific and max_p is the maximum probablity of any of the rotamers
+    in **rot_group**. If you construct a rotamer group by the
+    ConstructRRMRotamerGroup/ConstructFRMRotamerGroup functions, this function 
+    is already called at construction and the energies are properly assigned.
+
+    :param rot_group:   containing all rotamers for which internal energies have
+                        to be assigned
+    :param id:          Identifies the sidechain
+    :param residue_index: The index of the residue which is represented by 
+                          *rot_group*    
+    :param phi:         The dihedral angle of the current residue
+    :param psi:         The dihedral angle of the current residue
+    :param n_ter:       Whether the residue is n-terminal
+    :param c_ter:       Whether the residue is c-terminal
+
+    :type rot_group:    :class:`RRMRotamerGroup` / :class:`FRMRotamerGroup`
+    :type id:           :class:`RotamerID`
+    :type residue_index: :class:`int`
+    :type phi:          :class:`float`
+    :type psi:          :class:`float`
+    :type n_ter:        :class:`bool`
+    :type c_ter:        :class:`bool`
+
+
+  .. method:: ConstructFrameResidueHeuristic(res, res_idx)
+
+    Constructs a :class:`FrameResidue` from a :class:`ost.mol.ResidueHandle` using
+    a heuristic treatment of the atoms. It is important that the residue has 
+    proper bonds assigned, as they influence the atom typing procedure.
+    Furthermore, you need hydrogens to automatically estimate the correct
+    atom type for oxygens and nitrogens (hydrogen bond donor/acceptor). 
+    Alternatively you can assign generic properties to oxygens and nitrogens
+    to circumvent the requirement of hydrogens. This is further described for
+    the case of oxygen.
+
+    * Carbon is assigned C_VINAParticle :class:`VINAParticleType` if its only 
+      bound to other carbons or hydrogens (and deuterium). All other carbons are
+      assigned C_P_VINAParticle :class:`VINAParticleType`.
+    * In case of oxygen, the heuristic first checks for set generic properties.
+      If the atom has the bool properties "is_hbond_acceptor" AND 
+      "is_hbond_donor" set, it decides between the according oxygen types
+      in :class:`VINAParticleType`. If the generic properties are not set,
+      every oxygen is assumed to be an hbond acceptor. But only an hbond donor 
+      if its bound to a hydrogen (or deuterium). You can set the generic 
+      properties for an :class:`ost.mol.AtomHandle` by calling 
+      at.SetBoolProp("is_hbond_donor", False) and 
+      at.SetBoolProp("is_hbond_acceptor", True). An oxygen with those 
+      generic properties is assigned O_A_VINAParticle :class:`VINAParticleType`.
+    * In case of nitrogen, the heuristic again first checks for set generic
+      properties.
+      If the atom has the bool properties "is_hbond_acceptor" AND 
+      "is_hbond_donor" set, it decides between the according nitrogen types
+      in :class:`VINAParticleType`. If not, nitrogen is expected to be an
+      hbond donor if it is bound to a hydrogen (or deuterium) and 
+      an hbond acceptor if it is bound to less than 3 other atoms (sounds
+      horrible but works surprisingly well).
+    * Atoms of elements ["MG", "MN", "ZN", "CA", "FE"] are assigned 
+      M_VINAParticle :class:`VINAParticleType`.
+    * Atoms of elements ["S", "P", "F", "CL", "BR", "I"] are assigned their
+      corresponding :class:`VINAParticleType`.
+    * All other atoms are neglected and not added to the returned
+      :class:`FrameResidue`.
+
+    :param res:         Residue from which to create the 
+                        :class:`FrameResidue`
+    :param res_idx:     Index that is set in :class:`FrameResidue`
+    :type res:          :class:`ost.mol.ResidueHandle`
+    :type res_idx:      :class:`int`
+    :rtype:             :class:`FrameResidue`
+
+
+  .. method:: ConstructRRMRotamerHeuristic(res)
+
+    Construct a :class:`RRMRotamer` with the atom typing heuristic
+    as in the :meth:`ConstructFrameResidueHeuristic` method.
+
+    :param res:         Residue from which to create the 
+                        :class:`RRMRotamer`
+    :type res:          :class:`ost.mol.ResidueHandle`
+    :rtype:             :class:`RRMRotamer`
+
+
+  .. method:: ConstructFRMRotamerHeuristic(res)
+
+    Construct a :class:`FRMRotamer` with the atom typing heuristic
+    as in the :meth:`ConstructFrameResidueHeuristic` method. The
+    constructed :class:`FRMRotamer` only contains one subrotamer that
+    contains the atoms from *residue*.
+
+    :param res:         Residue from which to create the 
+                        :class:`FRMRotamer`
+    :type res:          :class:`ost.mol.ResidueHandle`
+    :rtype:             :class:`FRMRotamer`
diff --git a/doc/html/_sources/sidechain/rotamer_id.txt b/doc/html/_sources/sidechain/rotamer_id.txt
deleted file mode 100644
index 746a51641352c7295152567a742eda8befedc803..0000000000000000000000000000000000000000
--- a/doc/html/_sources/sidechain/rotamer_id.txt
+++ /dev/null
@@ -1,108 +0,0 @@
-..  Copyright (c) 2013-2018, SIB - Swiss Institute of Bioinformatics and 
-..                           Biozentrum - University of Basel
-..  
-..  Licensed under the Apache License, Version 2.0 (the "License");
-..  you may not use this file except in compliance with the License.
-..  You may obtain a copy of the License at
-..  
-..    http://www.apache.org/licenses/LICENSE-2.0
-..  
-..  Unless required by applicable law or agreed to in writing, software
-..  distributed under the License is distributed on an "AS IS" BASIS,
-..  WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied.
-..  See the License for the specific language governing permissions and
-..  limitations under the License.
-
-
-RotamerID
-================================================================================
-
-.. currentmodule:: promod3.sidechain
-
-The sidechain module has its own definition of amino acids to satisfy custom 
-requirements for the implemented sidechain construction algorithms. 
-As an example there are histidine in two possible protonation states, 
-that affect the hbond term or different versions of proline/cysteine. 
-
-
-The RotamerID
---------------------------------------------------------------------------------
-
-.. class:: RotamerID
-
-  Enumerates the amino acids. Possible values:
-
-  .. hlist::
-    :columns: 2
-  
-    * ARG - Arginine
-    * ASN - Asparagine
-    * ASP - Aspartate
-    * GLN - Glutamine
-    * GLU - Glutamate
-    * LYS - Lysine
-    * SER - Serine
-    * CYS - Cystein
-    * CYH - "free" Cystein
-    * CYD - disulfid bonded Cystein
-    * MET - Methionine
-    * TRP - Tryptophane
-    * TYR - Tyrosine
-    * THR - Threonine
-    * VAL - Valine
-    * ILE - Isoleucine
-    * LEU - Leucine
-    * PRO - Proline
-    * CPR - cis-Proline
-    * TPR - trans-Proline
-    * HIS - Histidine
-    * HSD - d-protonated Histidine
-    * HSE - e-protonated Histidine
-    * PHE - Phenylalanine
-    * GLY - Glycine
-    * ALA - Alanine
-    * XXX - Invalid
-  
-  The RotamerID enum can be accessed either directly as ``promod3.sidechain.ARG``
-  or as ``promod3.sidechain.RotamerID.ARG``.
-
-  
-How can I get an ID?
---------------------------------------------------------------------------------
-The RotamerID enum can directly be accessed from Python. Two convenient
-functions exist to get RotamerIDs from the :class:`ost.conop.AminoAcid` enum
-or from amino acid three letter codes.
-
-.. method:: TLCToRotID(tlc)
-
-  Directly translates the three letter code into a RotamerID. Following
-  exactly the naming convention defined above.  
-
-  :param tlc:           Three letter code of amino acid
-  :type tlc:            :class:`str`
-
-  :returns:             :class:`RotamerID`, XXX if **tlc** cannot be recoginzed.
-
-
-.. method:: AAToRotID(aa)
-
-  Directly translates **aa** into a RotamerID. Note, that it is not possible
-  to generate special IDs this way 
-  (e.g. HSD, HSE or the special prolines/cysteins) since they're simply not
-  defined in :class:`ost.conop.AminoAcid` 
-
-  :param aa:            AA enum of amino acid
-  :type  aa:            :class:`ost.conop.AminoAcid`
-
-  :returns:             :class:`RotamerID`, XXX if **aa** is invalid.
-
-
-
-
-
-
-
-
-
-
-
diff --git a/doc/html/actions/index.html b/doc/html/actions/index.html
index b8d6aa5a8c57bcc6cec7e372194809a028e7efde..22ca5ecdc00fdc3793c2328a87a2226bb4617d45 100644
--- a/doc/html/actions/index.html
+++ b/doc/html/actions/index.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>ProMod3 Actions &mdash; ProMod3 2.0.0 documentation</title>
+    <title>ProMod3 Actions &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="Documentation For Users" href="../users.html" />
     <link rel="next" title="Building ProMod3" href="../buildsystem.html" />
     <link rel="prev" title="Getting Started" href="../gettingstarted.html" />
@@ -112,7 +112,7 @@ Example:</p>
 </li>
 </ul>
 <p>Structures can be provided in PDB (<code class="docutils literal"><span class="pre">-p</span></code>) or in any format readable by the
-<a class="reference external" href="https://www.openstructure.org/docs/io/io/#ost.io.LoadEntity" title="(in OpenStructure v1.9.0)"><code class="xref py py-func docutils literal"><span class="pre">ost.io.LoadEntity()</span></code></a> method (<code class="docutils literal"><span class="pre">-e</span></code>). In the latter case, the format is
+<a class="reference external" href="https://www.openstructure.org/docs/io/io/#ost.io.LoadEntity" title="(in OpenStructure v1.10.0)"><code class="xref py py-func docutils literal"><span class="pre">ost.io.LoadEntity()</span></code></a> method (<code class="docutils literal"><span class="pre">-e</span></code>). In the latter case, the format is
 chosen by file ending. Recognized File Extensions: <code class="docutils literal"><span class="pre">.ent</span></code>, <code class="docutils literal"><span class="pre">.pdb</span></code>,
 <code class="docutils literal"><span class="pre">.ent.gz</span></code>, <code class="docutils literal"><span class="pre">.pdb.gz</span></code>, <code class="docutils literal"><span class="pre">.cif</span></code>, <code class="docutils literal"><span class="pre">.cif.gz</span></code>. At least one structure must be
 given and you cannot mix file formats. Multiple structures can be given and each
@@ -139,7 +139,7 @@ to the corresponding target sequences. This has an impact on loop scoring with
 the database approach.
 The profiles can be provided as plain files or gzipped. Following file
 extensions are understood: .hhm, .hhm.gz, .pssm, .pssm.gz.
-Consider to use <a class="reference external" href="https://www.openstructure.org/docs/bindings/hhblits/#ost.bindings.hhblits.HHblits.A3MToProfile" title="(in OpenStructure v1.9.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.bindings.hhblits.HHblits.A3MToProfile()</span></code></a> if you have a
+Consider to use <a class="reference external" href="https://www.openstructure.org/docs/bindings/hhblits/#ost.bindings.hhblits.HHblits.A3MToProfile" title="(in OpenStructure v1.10.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.bindings.hhblits.HHblits.A3MToProfile()</span></code></a> if you have a
 file in a3m format at hand.</p>
 <ul class="simple">
 <li>The profiles are mapped based on exact matches towards the gapless
@@ -194,7 +194,7 @@ detects and models disulfid bonds and reconstructs all sidechains with the
 flexible rotamer model. The result is stored as <code class="file docutils literal"><span class="pre">out.pdb</span></code>.
 The output filename can be controlled with the <code class="docutils literal"><span class="pre">-o</span></code> flag.</p>
 <p>A structure can be provided in PDB (<code class="docutils literal"><span class="pre">-p</span></code>) or in any format readable by the
-<a class="reference external" href="https://www.openstructure.org/docs/io/io/#ost.io.LoadEntity" title="(in OpenStructure v1.9.0)"><code class="xref py py-func docutils literal"><span class="pre">ost.io.LoadEntity()</span></code></a> method (<code class="docutils literal"><span class="pre">-e</span></code>). In the latter case, the format is
+<a class="reference external" href="https://www.openstructure.org/docs/io/io/#ost.io.LoadEntity" title="(in OpenStructure v1.10.0)"><code class="xref py py-func docutils literal"><span class="pre">ost.io.LoadEntity()</span></code></a> method (<code class="docutils literal"><span class="pre">-e</span></code>). In the latter case, the format is
 chosen by file ending. Recognized File Extensions: <code class="docutils literal"><span class="pre">.ent</span></code>, <code class="docutils literal"><span class="pre">.pdb</span></code>,
 <code class="docutils literal"><span class="pre">.ent.gz</span></code>, <code class="docutils literal"><span class="pre">.pdb.gz</span></code>, <code class="docutils literal"><span class="pre">.cif</span></code>, <code class="docutils literal"><span class="pre">.cif.gz</span></code>.</p>
 <p>Several flags control the modelling behaviour:</p>
@@ -287,7 +287,7 @@ supported by <a class="reference internal" href="../modelling/sidechain_reconstr
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/actions/index_dev.html b/doc/html/actions/index_dev.html
index 38817d23f9ff466370ec6d216532bb39f123df27..4da2b7382d8d688f3df5c57f972f272b8d0c9690 100644
--- a/doc/html/actions/index_dev.html
+++ b/doc/html/actions/index_dev.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>test_actions - Testing Actions &mdash; ProMod3 2.0.0 documentation</title>
+    <title>test_actions - Testing Actions &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="Documentation For Developers" href="../developers.html" />
     <link rel="next" title="ProMod3‘s Share Of CMake" href="../cmake/index.html" />
     <link rel="prev" title="Contributing" href="../contributing.html" />
@@ -194,7 +194,7 @@ happens if a user throws dirty input data in.</p>
 </div>
 <div class="section" id="making-the-script-executable">
 <h3>Making the Script Executable<a class="headerlink" href="#making-the-script-executable" title="Permalink to this headline">¶</a></h3>
-<p>In ProMod3, unit tests are run via <a class="reference external" href="https://www.OpenStructure.org">OST</a>&#8216;s <a class="reference external" href="https://www.openstructure.org/docs/base/testutils/#module-ost.testutils" title="(in OpenStructure v1.9.0)"><code class="xref py py-mod docutils literal"><span class="pre">ost.testutils</span></code></a> and Python&#8216;s
+<p>In ProMod3, unit tests are run via <a class="reference external" href="https://www.OpenStructure.org">OST</a>&#8216;s <a class="reference external" href="https://www.openstructure.org/docs/base/testutils/#module-ost.testutils" title="(in OpenStructure v1.10.0)"><code class="xref py py-mod docutils literal"><span class="pre">ost.testutils</span></code></a> and Python&#8216;s
 <a class="reference external" href="https://docs.python.org/2.7/library/unittest.html#unittest.TestCase" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">unittest.TestCase</span></code></a>. Those are called when the test module is executed
 as a script:</p>
 <div class="highlight-default"><table class="highlighttable"><tr><td class="linenos"><div class="linenodiv"><pre>13
@@ -411,7 +411,7 @@ file (also complains if a directory is found instead).</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/buildsystem.html b/doc/html/buildsystem.html
index fa8c0e469b4a5eb6c7390314fa906edb0abd5421..8a84acd090055744040cee4e433f39edb1fc5fce 100644
--- a/doc/html/buildsystem.html
+++ b/doc/html/buildsystem.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Building ProMod3 &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Building ProMod3 &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    './',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="_static/underscore.js"></script>
     <script type="text/javascript" src="_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="index.html" />
     <link rel="up" title="Documentation For Users" href="users.html" />
     <link rel="next" title="ProMod3 and Containers" href="container/index.html" />
     <link rel="prev" title="ProMod3 Actions" href="actions/index.html" />
@@ -47,20 +47,20 @@
 <div class="section" id="dependencies">
 <h2>Dependencies<a class="headerlink" href="#dependencies" title="Permalink to this headline">¶</a></h2>
 <p>ProMod3 is build on top of <a class="reference external" href="https://www.OpenStructure.org">OpenStructure</a> (OST), requiring at least version
-1.10.0. OST must be configured and compiled with <code class="docutils literal"><span class="pre">ENABLE_MM=1</span></code> to
-use <a class="reference external" href="http://openmm.org">OpenMM</a>. To create the build system, <a class="reference external" href="https://cmake.org/">CMake</a> is required. The same
-versions of <a class="reference external" href="https://www.python.org/">Python</a> and <a class="reference external" href="https://www.boost.org/">Boost</a> are needed as used in OST. For <a class="reference external" href="http://eigen.tuxfamily.org/index.php?title=Main_Page">Eigen 3</a>
-we need at least version 3.3.0. To build the documentation, <a class="reference external" href="http://sphinx-doc.org/">Sphinx</a> is
-required.</p>
+1.11.0. A C++11 compatible compiler is required. OST must be
+configured and compiled with <code class="docutils literal"><span class="pre">ENABLE_MM=1</span></code> to use <a class="reference external" href="http://openmm.org">OpenMM</a>. To create the
+build system, <a class="reference external" href="https://cmake.org/">CMake</a> is required. The same versions of <a class="reference external" href="https://www.python.org/">Python</a> and <a class="reference external" href="https://www.boost.org/">Boost</a>
+are needed as used in OST. For <a class="reference external" href="http://eigen.tuxfamily.org/index.php?title=Main_Page">Eigen 3</a> we need at least version 3.3.0. To
+build the documentation, <a class="reference external" href="http://sphinx-doc.org/">Sphinx</a> is required.</p>
 <p>The currently preferred versions are:</p>
 <ul class="simple">
-<li><a class="reference external" href="https://www.OpenStructure.org">OST</a> 1.10.0</li>
+<li><a class="reference external" href="https://www.OpenStructure.org">OST</a> 1.11.0</li>
 <li><a class="reference external" href="http://openmm.org">OpenMM</a> 7.1.1</li>
 <li><a class="reference external" href="https://cmake.org/">CMake</a> 2.8.12</li>
-<li><a class="reference external" href="https://www.python.org/">Python</a> 2.7.5</li>
+<li><a class="reference external" href="https://www.python.org/">Python</a> 2.7.11</li>
 <li><a class="reference external" href="https://www.boost.org/">Boost</a> 1.53.0</li>
-<li><a class="reference external" href="http://eigen.tuxfamily.org/index.php?title=Main_Page">Eigen 3</a> 3.3.0</li>
-<li><a class="reference external" href="http://sphinx-doc.org/">Sphinx</a> 1.3.1</li>
+<li><a class="reference external" href="http://eigen.tuxfamily.org/index.php?title=Main_Page">Eigen 3</a> 3.3.1</li>
+<li><a class="reference external" href="http://sphinx-doc.org/">Sphinx</a> 1.4.1</li>
 </ul>
 </div>
 <div class="section" id="using-cmake">
@@ -204,7 +204,7 @@ safely delete the whole source folder.</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/changelog.html b/doc/html/changelog.html
index 624bccd94e33f53368466218e89ad9391160b0ab..5a5229642a989f2bd592bbaf602a76587601f08f 100644
--- a/doc/html/changelog.html
+++ b/doc/html/changelog.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Changelog &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Changelog &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    './',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="_static/underscore.js"></script>
     <script type="text/javascript" src="_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="index.html" />
     <link rel="prev" title="References" href="references.html" />
    
   <link rel="stylesheet" href="_static/custom.css" type="text/css" />
@@ -42,6 +42,19 @@
             
   <div class="section" id="changelog">
 <h1>Changelog<a class="headerlink" href="#changelog" title="Permalink to this headline">¶</a></h1>
+<div class="section" id="release-2-1-0">
+<h2>Release 2.1.0<a class="headerlink" href="#release-2-1-0" title="Permalink to this headline">¶</a></h2>
+<ul class="simple">
+<li>This is expected to be the last release supporting Python 2.</li>
+<li>This project now requires a C++11 compatible compiler.</li>
+<li>Introduced VINA scoring function in the sidechain module. A scoring function
+specific RotamerConstructor is provided that comes with extensive heuristics
+to parametrize arbitrary compounds.</li>
+<li>Motif finding algorithm to identify objects in 3D space, e.g. binding sites.
+The algorithm is based on principles of geometric hashing.</li>
+<li>Several minor bug fixes, improvements, and speed-ups</li>
+</ul>
+</div>
 <div class="section" id="release-2-0-0">
 <h2>Release 2.0.0<a class="headerlink" href="#release-2-0-0" title="Permalink to this headline">¶</a></h2>
 <ul class="simple">
@@ -150,6 +163,7 @@ selected loops, reconstruct hydrogens and minimize energy with MM</li>
   <h3><a href="index.html">Table Of Contents</a></h3>
   <ul>
 <li><a class="reference internal" href="#">Changelog</a><ul>
+<li><a class="reference internal" href="#release-2-1-0">Release 2.1.0</a></li>
 <li><a class="reference internal" href="#release-2-0-0">Release 2.0.0</a></li>
 <li><a class="reference internal" href="#release-1-3-0">Release 1.3.0</a></li>
 <li><a class="reference internal" href="#release-1-2-0">Release 1.2.0</a></li>
@@ -188,7 +202,7 @@ selected loops, reconstruct hydrogens and minimize energy with MM</li>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/cmake/index.html b/doc/html/cmake/index.html
index dbdb850375223b71efa895b6a0829191f86ef661..f1be147fee04b09b4bae608526b985cdff0642b2 100644
--- a/doc/html/cmake/index.html
+++ b/doc/html/cmake/index.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>ProMod3‘s Share Of CMake &mdash; ProMod3 2.0.0 documentation</title>
+    <title>ProMod3‘s Share Of CMake &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="Documentation For Developers" href="../developers.html" />
     <link rel="next" title="Using Binary Files In ProMod3" href="../portableIO.html" />
     <link rel="prev" title="test_actions - Testing Actions" href="../actions/index_dev.html" />
@@ -373,7 +373,7 @@ target has to be created <strong>before</strong> any action may be attached to i
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/container/docker.html b/doc/html/container/docker.html
index aabd7220fa7648ca54682b5ecbab4d03828b924e..361df7199becb9d60af6d90f347e332504fb75a2 100644
--- a/doc/html/container/docker.html
+++ b/doc/html/container/docker.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Docker &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Docker &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="ProMod3 and Containers" href="index.html" />
     <link rel="next" title="Singularity" href="singularity.html" />
     <link rel="prev" title="ProMod3 and Containers" href="index.html" />
@@ -76,7 +76,7 @@ provide the (relative) path to the script and (relative) path to the file eg:</p
 </div>
 <div class="section" id="the-compound-library">
 <span id="docker-compound-lib"></span><h2>The Compound Library<a class="headerlink" href="#the-compound-library" title="Permalink to this headline">¶</a></h2>
-<p>At build time of the container, a <a class="reference external" href="https://www.openstructure.org/docs/conop/compoundlib/#ost.conop.CompoundLib" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">CompoundLib</span></code></a> is generated.
+<p>At build time of the container, a <a class="reference external" href="https://www.openstructure.org/docs/conop/compoundlib/#ost.conop.CompoundLib" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">CompoundLib</span></code></a> is generated.
 Compound libraries contain information on chemical compounds, such as their
 connectivity, chemical class and one-letter-code. The compound library has
 several uses, but the most important one is to provide the connectivy
@@ -175,7 +175,7 @@ output when running a Python script with following code in the container:</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/container/index.html b/doc/html/container/index.html
index db0c08685d4d1f055c795f795d7b5ce3553746d3..57ed423f9c5cf4397850c3e32fd12918bebb204a 100644
--- a/doc/html/container/index.html
+++ b/doc/html/container/index.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>ProMod3 and Containers &mdash; ProMod3 2.0.0 documentation</title>
+    <title>ProMod3 and Containers &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="Documentation For Users" href="../users.html" />
     <link rel="next" title="Docker" href="docker.html" />
     <link rel="prev" title="Building ProMod3" href="../buildsystem.html" />
@@ -94,7 +94,7 @@ some sugar on top.</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/container/singularity.html b/doc/html/container/singularity.html
index 1940dd077a6abb6bbd4ec67cd9215e20136d11c2..d3581fe64d2b761ef18aa06316c963d1c47571c4 100644
--- a/doc/html/container/singularity.html
+++ b/doc/html/container/singularity.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Singularity &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Singularity &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="ProMod3 and Containers" href="index.html" />
     <link rel="next" title="modelling - Protein Modelling" href="../modelling/index.html" />
     <link rel="prev" title="Docker" href="docker.html" />
@@ -162,7 +162,7 @@ in the Docker documentation: <a class="reference internal" href="docker.html#doc
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/contributing.html b/doc/html/contributing.html
index 6ba9fbd7067c5142f04d98e093072d0ddd560810..4cb717b7e531fa33b942add272bf1df27d613f33 100644
--- a/doc/html/contributing.html
+++ b/doc/html/contributing.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Contributing &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Contributing &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    './',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="_static/underscore.js"></script>
     <script type="text/javascript" src="_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="index.html" />
     <link rel="up" title="Documentation For Developers" href="developers.html" />
     <link rel="next" title="test_actions - Testing Actions" href="actions/index_dev.html" />
     <link rel="prev" title="ProMod3 Setup" href="dev_setup.html" />
@@ -660,7 +660,7 @@ contributions to web pages using ProMod3.</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/core/geometry.html b/doc/html/core/geometry.html
index d19a2ef9b2d9b9add2b2947d20380f58001ba1ad..6d4e9ca68f9e82a8513a6cc33fe50cf513e75cc2 100644
--- a/doc/html/core/geometry.html
+++ b/doc/html/core/geometry.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Geometry functions &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Geometry functions &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="core - ProMod3 Core Functionality" href="index.html" />
     <link rel="next" title="Runtime profiling" href="runtime_profiling.html" />
     <link rel="prev" title="helper - Shared Functionality For the Everything" href="helper.html" />
@@ -56,14 +56,14 @@
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>rule</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Gromacs rule</li>
 <li><strong>number</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Desired number of positions (max. 3)</li>
-<li><strong>anchors</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Anchor positions (max. 4)</li>
+<li><strong>anchors</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Anchor positions (max. 4)</li>
 </ul>
 </td>
 </tr>
 <tr class="field-even field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">Constructed <em>number</em> positions.</p>
 </td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Return type:</th><td class="field-body"><p class="first last"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a></p>
+<tr class="field-odd field"><th class="field-name">Return type:</th><td class="field-body"><p class="first last"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a></p>
 </td>
 </tr>
 </tbody>
@@ -79,16 +79,16 @@
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>c_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Position of C atom</li>
-<li><strong>n_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Position of nitrogen atom</li>
-<li><strong>ca_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Position of C-alpha atom</li>
+<li><strong>c_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Position of C atom</li>
+<li><strong>n_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Position of nitrogen atom</li>
+<li><strong>ca_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Position of C-alpha atom</li>
 </ul>
 </td>
 </tr>
 <tr class="field-even field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">Positions of O and OXT atoms.</p>
 </td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Return type:</th><td class="field-body"><p class="first last"><code class="xref py py-class docutils literal"><span class="pre">tuple</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a></p>
+<tr class="field-odd field"><th class="field-name">Return type:</th><td class="field-body"><p class="first last"><code class="xref py py-class docutils literal"><span class="pre">tuple</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a></p>
 </td>
 </tr>
 </tbody>
@@ -105,9 +105,9 @@ dihedral (A-B-C-D).</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>A</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Position of atom A</li>
-<li><strong>B</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Position of atom B</li>
-<li><strong>C</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Position of atom C</li>
+<li><strong>A</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Position of atom A</li>
+<li><strong>B</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Position of atom B</li>
+<li><strong>C</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Position of atom C</li>
 <li><strong>bond_length</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; Bond length (C-D)</li>
 <li><strong>angle</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; Angle (B-C-D)</li>
 <li><strong>dihedral</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; Dihedral (A-B-C-D)</li>
@@ -117,7 +117,7 @@ dihedral (A-B-C-D).</p>
 <tr class="field-even field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">Position of atom D</p>
 </td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Return type:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a></p>
+<tr class="field-odd field"><th class="field-name">Return type:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a></p>
 </td>
 </tr>
 </tbody>
@@ -134,16 +134,16 @@ C-alpha and C atoms.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>n_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Position of nitrogen atom</li>
-<li><strong>ca_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Position of C-alpha atom</li>
-<li><strong>c_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Position of C atom</li>
+<li><strong>n_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Position of nitrogen atom</li>
+<li><strong>ca_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Position of C-alpha atom</li>
+<li><strong>c_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Position of C atom</li>
 </ul>
 </td>
 </tr>
 <tr class="field-even field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">Position of C-beta atom</p>
 </td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Return type:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a></p>
+<tr class="field-odd field"><th class="field-name">Return type:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a></p>
 </td>
 </tr>
 </tbody>
@@ -160,8 +160,8 @@ around a line defined by <cite>axis</cite> and <cite>anchor</cite>.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>axis</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Axis of rotation</li>
-<li><strong>anchor</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Anchor for rotation</li>
+<li><strong>axis</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Axis of rotation</li>
+<li><strong>anchor</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Anchor for rotation</li>
 <li><strong>angle</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; Angle (in radians in range [-pi,pi]) of rotation</li>
 </ul>
 </td>
@@ -169,7 +169,7 @@ around a line defined by <cite>axis</cite> and <cite>anchor</cite>.</p>
 <tr class="field-even field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">Transformation matrix</p>
 </td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Return type:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat4" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Mat4</span></code></a></p>
+<tr class="field-odd field"><th class="field-name">Return type:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat4" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Mat4</span></code></a></p>
 </td>
 </tr>
 </tbody>
@@ -186,7 +186,7 @@ going through the origin.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>axis</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Axis of rotation</li>
+<li><strong>axis</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Axis of rotation</li>
 <li><strong>angle</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; Angle (in radians in range [-pi,pi]) of rotation</li>
 </ul>
 </td>
@@ -194,7 +194,7 @@ going through the origin.</p>
 <tr class="field-even field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">Rotation matrix</p>
 </td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Return type:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Mat3</span></code></a></p>
+<tr class="field-odd field"><th class="field-name">Return type:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Mat3</span></code></a></p>
 </td>
 </tr>
 </tbody>
@@ -211,7 +211,7 @@ going through the origin.</p>
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue handle from which to extract N, CA and C coordinates.</td>
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue handle from which to extract N, CA and C coordinates.</td>
 </tr>
 <tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if <em>res</em> does not contain N, CA and C
 atoms.</td>
@@ -230,7 +230,7 @@ atoms.</td>
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a></td>
+<tr class="field-odd field"><th class="field-name">Type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a></td>
 </tr>
 </tbody>
 </table>
@@ -347,7 +347,7 @@ angles and one distance and is used in the fragment database for fast lookups.</
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/core/graph_minimizer.html b/doc/html/core/graph_minimizer.html
index d68b21c165fc6019713bed993ea39f8cb2f4253b..e95c19333fd51a6f95e8d9086c3be91731f7eefc 100644
--- a/doc/html/core/graph_minimizer.html
+++ b/doc/html/core/graph_minimizer.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Graph Minimizer &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Graph Minimizer &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="core - ProMod3 Core Functionality" href="index.html" />
     <link rel="next" title="SetCompoundsChemlib()" href="setcompoundschemlib.html" />
     <link rel="prev" title="Runtime profiling" href="runtime_profiling.html" />
@@ -373,7 +373,7 @@ The second element is the according energy value.</td>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/core/helper.html b/doc/html/core/helper.html
index 87148791bae5e46800b3e711aab3997235ee5fa9..6690837afb52ef67ca60356b4aea1e1696e5f210 100644
--- a/doc/html/core/helper.html
+++ b/doc/html/core/helper.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>helper - Shared Functionality For the Everything &mdash; ProMod3 2.0.0 documentation</title>
+    <title>helper - Shared Functionality For the Everything &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="core - ProMod3 Core Functionality" href="index.html" />
     <link rel="next" title="Geometry functions" href="geometry.html" />
     <link rel="prev" title="pm3argparse - Parsing Command Lines" href="pm3argparse.html" />
@@ -247,7 +247,7 @@ script will terminate if a gzip file is found.</li>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/core/index.html b/doc/html/core/index.html
index 8b6e7db3867d73c6e293926c7fe4559efc646622..c99853589643093ceb89fc0dad473b51d1bdb52a 100644
--- a/doc/html/core/index.html
+++ b/doc/html/core/index.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>core - ProMod3 Core Functionality &mdash; ProMod3 2.0.0 documentation</title>
+    <title>core - ProMod3 Core Functionality &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="Documentation For Users" href="../users.html" />
     <link rel="next" title="pm3argparse - Parsing Command Lines" href="pm3argparse.html" />
     <link rel="prev" title="Loading Precomputed Objects" href="../loop/load_loop_objects.html" />
@@ -105,7 +105,7 @@ modeling per se but cover standard programming issues.</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/core/pm3argparse.html b/doc/html/core/pm3argparse.html
index 5a2053814b6e1a22491d37f93af21b4ec0d7e876..b7d2472f0af8cbe3c684eec4d42083337b8b5996 100644
--- a/doc/html/core/pm3argparse.html
+++ b/doc/html/core/pm3argparse.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>pm3argparse - Parsing Command Lines &mdash; ProMod3 2.0.0 documentation</title>
+    <title>pm3argparse - Parsing Command Lines &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="core - ProMod3 Core Functionality" href="index.html" />
     <link rel="next" title="helper - Shared Functionality For the Everything" href="helper.html" />
     <link rel="prev" title="core - ProMod3 Core Functionality" href="index.html" />
@@ -252,7 +252,7 @@ input is post processed and checked in <a class="reference internal" href="#prom
 by the <code class="xref py py-meth docutils literal"><span class="pre">ost.io.LoadSequenceProfile()</span></code> method. Format is chosen by 
 file ending. Recognized file extensions: .hhm, .hhm.gz, .pssm, 
 .pssm.gz. Consider to use 
-<a class="reference external" href="https://www.openstructure.org/docs/bindings/hhblits/#ost.bindings.hhblits.HHblits.A3MToProfile" title="(in OpenStructure v1.9.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.bindings.hhblits.HHblits.A3MToProfile()</span></code></a> if you have a file 
+<a class="reference external" href="https://www.openstructure.org/docs/bindings/hhblits/#ost.bindings.hhblits.HHblits.A3MToProfile" title="(in OpenStructure v1.10.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.bindings.hhblits.HHblits.A3MToProfile()</span></code></a> if you have a file 
 in a3m format at hand.</li>
 </ul>
 <p>Notes:</p>
@@ -266,7 +266,7 @@ target sequences</li>
 </ul>
 <p>Attributes added to the namespace returned by <a class="reference internal" href="#promod3.core.pm3argparse.PM3ArgumentParser.Parse" title="promod3.core.pm3argparse.PM3ArgumentParser.Parse"><code class="xref py py-meth docutils literal"><span class="pre">Parse()</span></code></a>:</p>
 <ul class="simple">
-<li><code class="xref py py-attr docutils literal"><span class="pre">profiles</span></code> - <code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a>, 
+<li><code class="xref py py-attr docutils literal"><span class="pre">profiles</span></code> - <code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a>, 
 ordered to match the target sequences.</li>
 </ul>
 <p>Exit codes related to profile input:</p>
@@ -424,7 +424,7 @@ and with the right constraints.</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/core/runtime_profiling.html b/doc/html/core/runtime_profiling.html
index b1d223150b95f9bf449b761943880311ae222d14..1e93da67dc60315f1a49e184805ebc77dec5a60a 100644
--- a/doc/html/core/runtime_profiling.html
+++ b/doc/html/core/runtime_profiling.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Runtime profiling &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Runtime profiling &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="core - ProMod3 Core Functionality" href="index.html" />
     <link rel="next" title="Graph Minimizer" href="graph_minimizer.html" />
     <link rel="prev" title="Geometry functions" href="geometry.html" />
@@ -201,7 +201,7 @@ will fail miserably if timers are currently running.</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/core/setcompoundschemlib.html b/doc/html/core/setcompoundschemlib.html
index 7fb563f83c914e52745443e88ba9a11993a702eb..0e9ebf7b873cf65e2a459594f701123ab045d1af 100644
--- a/doc/html/core/setcompoundschemlib.html
+++ b/doc/html/core/setcompoundschemlib.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>SetCompoundsChemlib() &mdash; ProMod3 2.0.0 documentation</title>
+    <title>SetCompoundsChemlib() &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="Documentation For Users" href="../users.html" />
     <link rel="next" title="Contributing" href="../user_contributions.html" />
     <link rel="prev" title="Graph Minimizer" href="graph_minimizer.html" />
@@ -106,7 +106,7 @@ enabled globally.</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/dev_setup.html b/doc/html/dev_setup.html
index 81c008ef7ec5ac3abde06e4c93516bdf3c8f12bd..b1f9b94e87b2209d1bac373e274593f0ea7978b0 100644
--- a/doc/html/dev_setup.html
+++ b/doc/html/dev_setup.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>ProMod3 Setup &mdash; ProMod3 2.0.0 documentation</title>
+    <title>ProMod3 Setup &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    './',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="_static/underscore.js"></script>
     <script type="text/javascript" src="_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="index.html" />
     <link rel="up" title="Documentation For Developers" href="developers.html" />
     <link rel="next" title="Contributing" href="contributing.html" />
     <link rel="prev" title="Documentation For Developers" href="developers.html" />
@@ -293,7 +293,7 @@ modules from there, use the binaries from <code class="file docutils literal"><s
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/developers.html b/doc/html/developers.html
index df1b45e5ad8a04972c1e0e61aa33e038ea49b9d7..80e54edf05379533716d36261103e34b904250ba 100644
--- a/doc/html/developers.html
+++ b/doc/html/developers.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Documentation For Developers &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Documentation For Developers &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    './',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="_static/underscore.js"></script>
     <script type="text/javascript" src="_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="index.html" />
     <link rel="next" title="ProMod3 Setup" href="dev_setup.html" />
     <link rel="prev" title="Contributing" href="user_contributions.html" />
    
@@ -125,7 +125,7 @@ new features.</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/genindex.html b/doc/html/genindex.html
index 8de63c6d8cfc5785d9b7876437a0251f12d01a0f..f0bf33a2b4a6e64aa4a8414a5fff8df4e452402b 100644
--- a/doc/html/genindex.html
+++ b/doc/html/genindex.html
@@ -7,7 +7,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Index &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Index &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="_static/pygments.css" type="text/css" />
@@ -15,7 +15,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    './',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -25,7 +25,7 @@
     <script type="text/javascript" src="_static/underscore.js"></script>
     <script type="text/javascript" src="_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="index.html" />
    
   <link rel="stylesheet" href="_static/custom.css" type="text/css" />
   
@@ -66,6 +66,7 @@
  | <a href="#S"><strong>S</strong></a>
  | <a href="#T"><strong>T</strong></a>
  | <a href="#U"><strong>U</strong></a>
+ | <a href="#V"><strong>V</strong></a>
  
 </div>
 <h2 id="Symbols">Symbols</h2>
@@ -244,7 +245,7 @@
 <table style="width: 100%" class="indextable genindextable"><tr>
   <td style="width: 33%" valign="top"><dl>
       
-  <dt><a href="sidechain/rotamer_id.html#promod3.sidechain.AAToRotID">AAToRotID() (in module promod3.sidechain)</a>
+  <dt><a href="sidechain/rotamer.html#promod3.sidechain.AAToRotID">AAToRotID() (in module promod3.sidechain)</a>
   </dt>
 
       
@@ -414,6 +415,10 @@
   </dt>
 
       
+  <dt><a href="modelling/algorithms.html#promod3.modelling.MotifMatch.alignment">alignment (promod3.modelling.MotifMatch attribute)</a>
+  </dt>
+
+      
   <dt><a href="modelling/pipeline.html#promod3.modelling.ModellingHandle.all_atom_scorer">all_atom_scorer (promod3.modelling.ModellingHandle attribute)</a>
   </dt>
 
@@ -421,12 +426,12 @@
   <dt><a href="modelling/pipeline.html#promod3.modelling.ModellingHandle.all_atom_scorer_env">all_atom_scorer_env (promod3.modelling.ModellingHandle attribute)</a>
   </dt>
 
+  </dl></td>
+  <td style="width: 33%" valign="top"><dl>
       
   <dt><a href="modelling/pipeline.html#promod3.modelling.ModellingHandle.all_atom_sidechain_env">all_atom_sidechain_env (promod3.modelling.ModellingHandle attribute)</a>
   </dt>
 
-  </dl></td>
-  <td style="width: 33%" valign="top"><dl>
       
   <dt><a href="loop/all_atom.html#promod3.loop.AllAtomEnvPositions.all_pos">all_pos (promod3.loop.AllAtomEnvPositions attribute)</a>
   </dt>
@@ -583,9 +588,17 @@
 
       <dd><dl>
         
+  <dt><a href="sidechain/rotamer_constructor.html#promod3.sidechain.SCWRL3RotamerConstructor.AssignInternalEnergies">(promod3.sidechain.SCWRL3RotamerConstructor method)</a>
+  </dt>
+
+        
   <dt><a href="sidechain/rotamer_constructor.html#promod3.sidechain.SCWRL4RotamerConstructor.AssignInternalEnergies">(promod3.sidechain.SCWRL4RotamerConstructor method)</a>
   </dt>
 
+        
+  <dt><a href="sidechain/rotamer_constructor.html#promod3.sidechain.VINARotamerConstructor.AssignInternalEnergies">(promod3.sidechain.VINARotamerConstructor method)</a>
+  </dt>
+
       </dl></dd>
       
   <dt><a href="core/graph_minimizer.html#promod3.core.GraphMinimizer.AStarSolve">AStarSolve() (promod3.core.GraphMinimizer method)</a>
@@ -632,7 +645,7 @@
   </dt>
 
       
-  <dt><a href="loop/backbone.html#promod3.loop.BackboneList.BackboneList">BackboneList() (promod3.loop.BackboneList method)</a>, <a href="loop/backbone.html#promod3.loop.BackboneList.BackboneList">[1]</a>, <a href="loop/backbone.html#promod3.loop.BackboneList.BackboneList">[2]</a>, <a href="loop/backbone.html#promod3.loop.BackboneList.BackboneList">[3]</a>
+  <dt><a href="loop/backbone.html#promod3.loop.BackboneList.BackboneList">BackboneList() (promod3.loop.BackboneList method)</a>, <a href="loop/backbone.html#promod3.loop.BackboneList.BackboneList">[1]</a>, <a href="loop/backbone.html#promod3.loop.BackboneList.BackboneList">[2]</a>, <a href="loop/backbone.html#promod3.loop.BackboneList.BackboneList">[3]</a>, <a href="loop/backbone.html#promod3.loop.BackboneList.BackboneList">[4]</a>
   </dt>
 
       
@@ -837,8 +850,6 @@
   <dt><a href="loop/all_atom.html#promod3.loop.AllAtomPositions.ClearPos">ClearPos() (promod3.loop.AllAtomPositions method)</a>
   </dt>
 
-  </dl></td>
-  <td style="width: 33%" valign="top"><dl>
       
   <dt><a href="loop/all_atom.html#promod3.loop.AllAtomPositions.ClearResidue">ClearResidue() (promod3.loop.AllAtomPositions method)</a>
   </dt>
@@ -881,6 +892,8 @@
   </dt>
 
       </dl></dd>
+  </dl></td>
+  <td style="width: 33%" valign="top"><dl>
       
   <dt><a href="modelling/pipeline.html#promod3.modelling.CloseGaps">CloseGaps() (in module promod3.modelling)</a>
   </dt>
@@ -991,11 +1004,25 @@
   <dt><a href="sidechain/rotamer_constructor.html#promod3.sidechain.SCWRL4RotamerConstructor.ConstructFrameResidueHeuristic">ConstructFrameResidueHeuristic() (promod3.sidechain.SCWRL4RotamerConstructor method)</a>
   </dt>
 
+      <dd><dl>
+        
+  <dt><a href="sidechain/rotamer_constructor.html#promod3.sidechain.VINARotamerConstructor.ConstructFrameResidueHeuristic">(promod3.sidechain.VINARotamerConstructor method)</a>
+  </dt>
+
+      </dl></dd>
+      
+  <dt><a href="sidechain/rotamer_constructor.html#promod3.sidechain.VINARotamerConstructor.ConstructFRMRotamerHeuristic">ConstructFRMRotamerHeuristic() (promod3.sidechain.VINARotamerConstructor method)</a>
+  </dt>
+
       
   <dt><a href="sidechain/rotamer_constructor.html#promod3.sidechain.RotamerConstructor.ConstructRRMRotamerGroup">ConstructRRMRotamerGroup() (promod3.sidechain.RotamerConstructor method)</a>, <a href="sidechain/rotamer_constructor.html#promod3.sidechain.RotamerConstructor.ConstructRRMRotamerGroup">[1]</a>, <a href="sidechain/rotamer_constructor.html#promod3.sidechain.RotamerConstructor.ConstructRRMRotamerGroup">[2]</a>, <a href="sidechain/rotamer_constructor.html#promod3.sidechain.RotamerConstructor.ConstructRRMRotamerGroup">[3]</a>
   </dt>
 
       
+  <dt><a href="sidechain/rotamer_constructor.html#promod3.sidechain.VINARotamerConstructor.ConstructRRMRotamerHeuristic">ConstructRRMRotamerHeuristic() (promod3.sidechain.VINARotamerConstructor method)</a>
+  </dt>
+
+      
   <dt><a href="sidechain/rotamer_constructor.html#promod3.sidechain.RotamerConstructor.ConstructSidechainFrameResidue">ConstructSidechainFrameResidue() (promod3.sidechain.RotamerConstructor method)</a>, <a href="sidechain/rotamer_constructor.html#promod3.sidechain.RotamerConstructor.ConstructSidechainFrameResidue">[1]</a>
   </dt>
 
@@ -1083,10 +1110,18 @@
   </dt>
 
       
+  <dt><a href="sidechain/rotamer.html#promod3.sidechain.CreateSCWRL3Particle">CreateSCWRL3Particle() (in module promod3.sidechain)</a>
+  </dt>
+
+      
   <dt><a href="sidechain/rotamer.html#promod3.sidechain.CreateSCWRL4Particle">CreateSCWRL4Particle() (in module promod3.sidechain)</a>
   </dt>
 
       
+  <dt><a href="sidechain/rotamer.html#promod3.sidechain.CreateVINAParticle">CreateVINAParticle() (in module promod3.sidechain)</a>
+  </dt>
+
+      
   <dt><a href="modelling/monte_carlo.html#promod3.modelling.CTerminalCloser">CTerminalCloser (class in promod3.modelling)</a>
   </dt>
 
@@ -1391,6 +1426,10 @@
   </dt>
 
       
+  <dt><a href="modelling/algorithms.html#promod3.modelling.FindMotifs">FindMotifs() (in module promod3.modelling)</a>
+  </dt>
+
+      
   <dt><a href="loop/mm_system_creation.html#promod3.loop.ForcefieldBondInfo.force_constant">force_constant (promod3.loop.ForcefieldBondInfo attribute)</a>
   </dt>
 
@@ -1811,6 +1850,10 @@
 
       </dl></dd>
       
+  <dt><a href="modelling/algorithms.html#promod3.modelling.MotifQuery.GetIdentifiers">GetIdentifiers() (promod3.modelling.MotifQuery method)</a>
+  </dt>
+
+      
   <dt><a href="loop/all_atom.html#promod3.loop.AllAtomPositions.GetIndex">GetIndex() (promod3.loop.AllAtomPositions method)</a>
   </dt>
 
@@ -1890,6 +1933,12 @@
   <dt><a href="loop/backbone.html#promod3.loop.BackboneList.GetN">GetN() (promod3.loop.BackboneList method)</a>
   </dt>
 
+      <dd><dl>
+        
+  <dt><a href="modelling/algorithms.html#promod3.modelling.MotifQuery.GetN">(promod3.modelling.MotifQuery method)</a>
+  </dt>
+
+      </dl></dd>
       
   <dt><a href="sidechain/rotamer.html#promod3.sidechain.Particle.GetName">GetName() (promod3.sidechain.Particle method)</a>
   </dt>
@@ -2007,6 +2056,10 @@
 
       </dl></dd>
       
+  <dt><a href="modelling/algorithms.html#promod3.modelling.MotifQuery.GetPositions">GetPositions() (promod3.modelling.MotifQuery method)</a>
+  </dt>
+
+      
   <dt><a href="loop/structure_db.html#promod3.loop.PsipredPrediction.GetPrediction">GetPrediction() (promod3.loop.PsipredPrediction method)</a>
   </dt>
 
@@ -2478,6 +2531,10 @@
   </dt>
 
         
+  <dt><a href="modelling/algorithms.html#promod3.modelling.MotifQuery.Load">(promod3.modelling.MotifQuery static method)</a>
+  </dt>
+
+        
   <dt><a href="scoring/all_atom_scorers.html#promod3.scoring.AllAtomInteractionScorer.Load">(promod3.scoring.AllAtomInteractionScorer static method)</a>
   </dt>
 
@@ -2719,6 +2776,10 @@
 
       </dl></dd>
       
+  <dt><a href="modelling/algorithms.html#promod3.modelling.MotifMatch.mat">mat (promod3.modelling.MotifMatch attribute)</a>
+  </dt>
+
+      
   <dt><a href="loop/structure_db.html#promod3.loop.FragDB.MaxFragLength">MaxFragLength() (promod3.loop.FragDB method)</a>
   </dt>
 
@@ -2802,6 +2863,14 @@
 
       </dl></dd>
       
+  <dt><a href="modelling/algorithms.html#promod3.modelling.MotifMatch">MotifMatch (class in promod3.modelling)</a>
+  </dt>
+
+      
+  <dt><a href="modelling/algorithms.html#promod3.modelling.MotifQuery">MotifQuery (class in promod3.modelling)</a>
+  </dt>
+
+      
   <dt><a href="core/helper.html#promod3.core.helper.MsgErrorAndExit">MsgErrorAndExit() (in module promod3.core.helper)</a>
   </dt>
 
@@ -3037,6 +3106,12 @@
 <table style="width: 100%" class="indextable genindextable"><tr>
   <td style="width: 33%" valign="top"><dl>
       
+  <dt><a href="modelling/algorithms.html#promod3.modelling.MotifMatch.query_idx">query_idx (promod3.modelling.MotifMatch attribute)</a>
+  </dt>
+
+  </dl></td>
+  <td style="width: 33%" valign="top"><dl>
+      
   <dt><a href="sidechain/rotamer_lib.html#promod3.sidechain.BBDepRotamerLib.QueryLib">QueryLib() (promod3.sidechain.BBDepRotamerLib method)</a>
   </dt>
 
@@ -3157,7 +3232,7 @@
   </dt>
 
       
-  <dt><a href="sidechain/rotamer_id.html#promod3.sidechain.RotamerID">RotamerID (class in promod3.sidechain)</a>
+  <dt><a href="sidechain/rotamer.html#promod3.sidechain.RotamerID">RotamerID (class in promod3.sidechain)</a>
   </dt>
 
       
@@ -3258,6 +3333,10 @@
   </dt>
 
         
+  <dt><a href="modelling/algorithms.html#promod3.modelling.MotifQuery.Save">(promod3.modelling.MotifQuery method)</a>
+  </dt>
+
+        
   <dt><a href="scoring/all_atom_scorers.html#promod3.scoring.AllAtomInteractionScorer.Save">(promod3.scoring.AllAtomInteractionScorer method)</a>
   </dt>
 
@@ -3393,6 +3472,10 @@
   </dt>
 
       
+  <dt><a href="sidechain/rotamer_constructor.html#promod3.sidechain.SCWRL3RotamerConstructor">SCWRL3RotamerConstructor (class in promod3.sidechain)</a>
+  </dt>
+
+      
   <dt><a href="sidechain/rotamer.html#promod3.sidechain.SCWRL4ParticleType">SCWRL4ParticleType (class in promod3.sidechain)</a>
   </dt>
 
@@ -3845,7 +3928,7 @@
   </dt>
 
       
-  <dt><a href="sidechain/rotamer_id.html#promod3.sidechain.TLCToRotID">TLCToRotID() (in module promod3.sidechain)</a>
+  <dt><a href="sidechain/rotamer.html#promod3.sidechain.TLCToRotID">TLCToRotID() (in module promod3.sidechain)</a>
   </dt>
 
       
@@ -3920,6 +4003,22 @@
   <dt><a href="loop/mm_system_creation.html#promod3.loop.ForcefieldConnectivity.urey_bradley_angles">urey_bradley_angles (promod3.loop.ForcefieldConnectivity attribute)</a>
   </dt>
 
+  </dl></td>
+</tr></table>
+
+<h2 id="V">V</h2>
+<table style="width: 100%" class="indextable genindextable"><tr>
+  <td style="width: 33%" valign="top"><dl>
+      
+  <dt><a href="sidechain/rotamer.html#promod3.sidechain.VINAParticleType">VINAParticleType (class in promod3.sidechain)</a>
+  </dt>
+
+  </dl></td>
+  <td style="width: 33%" valign="top"><dl>
+      
+  <dt><a href="sidechain/rotamer_constructor.html#promod3.sidechain.VINARotamerConstructor">VINARotamerConstructor (class in promod3.sidechain)</a>
+  </dt>
+
   </dl></td>
 </tr></table>
 
@@ -3954,7 +4053,7 @@
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/gettingstarted.html b/doc/html/gettingstarted.html
index 357e240355a9190825c5917add13b6acea6f2786..4d7ff9696487f382ec6af7b2464ebabc68f0302b 100644
--- a/doc/html/gettingstarted.html
+++ b/doc/html/gettingstarted.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Getting Started &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Getting Started &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    './',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="_static/underscore.js"></script>
     <script type="text/javascript" src="_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="index.html" />
     <link rel="up" title="Documentation For Users" href="users.html" />
     <link rel="next" title="ProMod3 Actions" href="actions/index.html" />
     <link rel="prev" title="Documentation For Users" href="users.html" />
@@ -98,7 +98,7 @@ is conserved</li>
 <li>Perform loop modelling to close all gaps (see <a class="reference internal" href="loop/index.html#module-promod3.loop" title="promod3.loop: Loop Handling"><code class="xref py py-mod docutils literal"><span class="pre">loop</span></code></a> module)</li>
 <li>Reconstruct sidechains (using <a class="reference internal" href="sidechain/index.html#module-promod3.sidechain" title="promod3.sidechain: Sidechain Modelling"><code class="xref py py-mod docutils literal"><span class="pre">sidechain</span></code></a> module)</li>
 <li>Minimize energy of final model using molecular mechanics
-(using <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/molmm/#module-ost.mol.mm" title="(in OpenStructure v1.9.0)"><code class="xref py py-mod docutils literal"><span class="pre">ost.mol.mm</span></code></a> from OST)</li>
+(using <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/molmm/#module-ost.mol.mm" title="(in OpenStructure v1.10.0)"><code class="xref py py-mod docutils literal"><span class="pre">ost.mol.mm</span></code></a> from OST)</li>
 </ul>
 <p>Since a good amount of time is spent in OpenMM routines to minimize energy, we
 try to use the fast and multi-threaded &#8220;CPU&#8221; platform of OpenMM (should be
@@ -157,7 +157,7 @@ not set, 1 thread will be used by default.</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/index.html b/doc/html/index.html
index 9d19520871229f8900a8a2009e90705197cff8b1..9e798617816b8b47ed902271e0e3a065ae188aff 100644
--- a/doc/html/index.html
+++ b/doc/html/index.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>ProMod3 &mdash; ProMod3 2.0.0 documentation</title>
+    <title>ProMod3 &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    './',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="_static/underscore.js"></script>
     <script type="text/javascript" src="_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="#" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="#" />
     <link rel="next" title="Documentation For Users" href="users.html" />
    
   <link rel="stylesheet" href="_static/custom.css" type="text/css" />
@@ -122,7 +122,7 @@ algorithms.</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/license.html b/doc/html/license.html
index 1841fd40a92b860fdbde8c9c1062f3075492e7c4..6f42206198fb624746da8fa674b391171a756099 100644
--- a/doc/html/license.html
+++ b/doc/html/license.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>License &mdash; ProMod3 2.0.0 documentation</title>
+    <title>License &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    './',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="_static/underscore.js"></script>
     <script type="text/javascript" src="_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="index.html" />
     <link rel="next" title="References" href="references.html" />
     <link rel="prev" title="Using Binary Files In ProMod3" href="portableIO.html" />
    
@@ -293,7 +293,7 @@ doc/Copyright_cmake.py.txt
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/loop/all_atom.html b/doc/html/loop/all_atom.html
index d0aee5addf9fffd6386651ec4a1f6c3c229451c8..4b0276cb78dbd9046716cf9f4cd696d99abd22f1 100644
--- a/doc/html/loop/all_atom.html
+++ b/doc/html/loop/all_atom.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Handling All Atom Positions &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Handling All Atom Positions &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="loop - Loop Handling" href="index.html" />
     <link rel="next" title="Generate ost.mol.mm systems" href="mm_system_creation.html" />
     <link rel="prev" title="Structural Data" href="structure_db.html" />
@@ -91,8 +91,8 @@ new loop is being added.</p>
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>seqres</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceHandle</span></code></a> /
-<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceList" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceList</span></code></a>) &#8211; Internal SEQRES to be set (single chain or list with one per
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>seqres</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceHandle</span></code></a> /
+<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceList" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceList</span></code></a>) &#8211; Internal SEQRES to be set (single chain or list with one per
 chain). Whenever setting structural data, consistency with this SEQRES is enforced.</td>
 </tr>
 </tbody>
@@ -114,7 +114,7 @@ concatenated one after each other (indexing starts at 0)</li>
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>env_structure</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.EntityHandle</span></code></a>) &#8211; Structral data to be set as environment. The chains
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>env_structure</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.EntityHandle</span></code></a>) &#8211; Structral data to be set as environment. The chains
 in <em>env_structure</em> are expected to be in the same
 order as the SEQRES items provided in constructor.</td>
 </tr>
@@ -144,7 +144,7 @@ means, that positions in the env. may be reset, newly set or cleared.</p>
 <li><strong>new_env_pos</strong> (<a class="reference internal" href="#promod3.loop.AllAtomEnvPositions" title="promod3.loop.AllAtomEnvPositions"><code class="xref py py-class docutils literal"><span class="pre">AllAtomEnvPositions</span></code></a>) &#8211; Structural data to be set as environment.</li>
 <li><strong>new_pos</strong> (<a class="reference internal" href="#promod3.loop.AllAtomPositions" title="promod3.loop.AllAtomPositions"><code class="xref py py-class docutils literal"><span class="pre">AllAtomPositions</span></code></a>) &#8211; Structural data to be set as environment.</li>
 <li><strong>bb_list</strong> (<a class="reference internal" href="backbone.html#promod3.loop.BackboneList" title="promod3.loop.BackboneList"><code class="xref py py-class docutils literal"><span class="pre">BackboneList</span></code></a>) &#8211; Backbone data to be set as environment.</li>
-<li><strong>start_resnum</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResNum" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResNum</span></code></a>) &#8211; Res. number defining the start position in the SEQRES.</li>
+<li><strong>start_resnum</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResNum" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResNum</span></code></a>) &#8211; Res. number defining the start position in the SEQRES.</li>
 <li><strong>chain_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Index of chain the structural data belongs to.</li>
 </ul>
 </td>
@@ -221,7 +221,7 @@ a loop to reset later with <a class="reference internal" href="#promod3.loop.All
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">SEQRES that was set in constructor (one sequence per chain).</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceList" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceList</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceList" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceList</span></code></a></td>
 </tr>
 </tbody>
 </table>
@@ -355,7 +355,7 @@ and if found set the corresponding position, otherwise we unset it.</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>res_index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Residue index</li>
-<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue providing atoms</li>
+<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue providing atoms</li>
 </ul>
 </td>
 </tr>
@@ -401,7 +401,7 @@ out of bounds or if residues in the two containers are inconsistent
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Set position at that index.</li>
-<li><strong>pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; Set position to <em>pos</em>.</li>
+<li><strong>pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; Set position to <em>pos</em>.</li>
 </ul>
 </td>
 </tr>
@@ -451,7 +451,7 @@ out of bounds or if residues in the two containers are inconsistent
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">Position at given index.</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a></td>
 </tr>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Atom position index.</td>
 </tr>
@@ -555,7 +555,7 @@ if <em>atom_name</em> is not one of that residue&#8217;s heavy atoms.</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">Amino acid type of residue at index <em>res_index</em>.</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a></td>
 </tr>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>res_index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Residue index</td>
 </tr>
@@ -834,9 +834,9 @@ atom (N, CA, C, O).</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">All residues packed in a single chain as an OST entity.
-Connectivity resolved with <a class="reference external" href="https://www.openstructure.org/docs/conop/connectivity/#ost.conop.HeuristicProcessor" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.HeuristicProcessor</span></code></a>.</td>
+Connectivity resolved with <a class="reference external" href="https://www.openstructure.org/docs/conop/connectivity/#ost.conop.HeuristicProcessor" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.HeuristicProcessor</span></code></a>.</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.EntityHandle</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.EntityHandle</span></code></a></td>
 </tr>
 </tbody>
 </table>
@@ -856,8 +856,8 @@ function efficient, we require the backbone atoms (N, C, CA) to be set.</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>res_index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Residue index</li>
-<li><strong>chain</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ChainHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ChainHandle</span></code></a>) &#8211; Chain into which we insert</li>
-<li><strong>start_resnum</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResNum" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResNum</span></code></a>) &#8211; Residue number for the inserted residue</li>
+<li><strong>chain</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ChainHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ChainHandle</span></code></a>) &#8211; Chain into which we insert</li>
+<li><strong>start_resnum</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResNum" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResNum</span></code></a>) &#8211; Residue number for the inserted residue</li>
 </ul>
 </td>
 </tr>
@@ -950,7 +950,7 @@ integer in the range [0, <em>XXX_NUM_HYDROGENS</em>-1].</p>
 <dt id="promod3.loop.AminoAcidLookup">
 <em class="property">class </em><code class="descclassname">promod3.loop.</code><code class="descname">AminoAcidLookup</code><a class="headerlink" href="#promod3.loop.AminoAcidLookup" title="Permalink to this definition">¶</a></dt>
 <dd><p>Collection of static methods to lookup properties of amino acid types
-(<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>), heavy atom types (<a class="reference internal" href="#promod3.loop.AminoAcidAtom" title="promod3.loop.AminoAcidAtom"><code class="xref py py-class docutils literal"><span class="pre">AminoAcidAtom</span></code></a>) and
+(<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>), heavy atom types (<a class="reference internal" href="#promod3.loop.AminoAcidAtom" title="promod3.loop.AminoAcidAtom"><code class="xref py py-class docutils literal"><span class="pre">AminoAcidAtom</span></code></a>) and
 hydrogen types (<a class="reference internal" href="#promod3.loop.AminoAcidHydrogen" title="promod3.loop.AminoAcidHydrogen"><code class="xref py py-class docutils literal"><span class="pre">AminoAcidHydrogen</span></code></a>).</p>
 <dl class="staticmethod">
 <dt id="promod3.loop.AminoAcidLookup.GetOLC">
@@ -963,7 +963,7 @@ hydrogen types (<a class="reference internal" href="#promod3.loop.AminoAcidHydro
 </tr>
 <tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a></td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">AminoAcid</span></code></a>) &#8211; Amino acid type</td>
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">AminoAcid</span></code></a>) &#8211; Amino acid type</td>
 </tr>
 </tbody>
 </table>
@@ -985,7 +985,7 @@ hydrogen types (<a class="reference internal" href="#promod3.loop.AminoAcidHydro
 </td>
 </tr>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">AminoAcid</span></code></a>) &#8211; Amino acid type</li>
+<li><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">AminoAcid</span></code></a>) &#8211; Amino acid type</li>
 <li><strong>atom_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Atom index (in [0, GetNumAtoms(aa)-1])</li>
 <li><strong>atom_name</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; Atom name</li>
 </ul>
@@ -1015,7 +1015,7 @@ hydrogen types (<a class="reference internal" href="#promod3.loop.AminoAcidHydro
 </td>
 </tr>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">AminoAcid</span></code></a>) &#8211; Amino acid type</li>
+<li><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">AminoAcid</span></code></a>) &#8211; Amino acid type</li>
 <li><strong>atom_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Atom index (in [0, GetNumHydrogens(aa)-1])</li>
 <li><strong>atom_name</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; Atom name</li>
 </ul>
@@ -1044,7 +1044,7 @@ atom.</p>
 </td>
 </tr>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">AminoAcid</span></code></a>) &#8211; Amino acid type</li>
+<li><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">AminoAcid</span></code></a>) &#8211; Amino acid type</li>
 <li><strong>atom_name</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; Atom name</li>
 </ul>
 </td>
@@ -1072,7 +1072,7 @@ and atom.</p>
 </td>
 </tr>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">AminoAcid</span></code></a>) &#8211; Amino acid type</li>
+<li><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">AminoAcid</span></code></a>) &#8211; Amino acid type</li>
 <li><strong>atom_name</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; Atom name</li>
 </ul>
 </td>
@@ -1096,7 +1096,7 @@ hydrogens of <em>aa</em>.</p>
 </tr>
 <tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a></td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">AminoAcid</span></code></a>) &#8211; Amino acid type</td>
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">AminoAcid</span></code></a>) &#8211; Amino acid type</td>
 </tr>
 </tbody>
 </table>
@@ -1128,7 +1128,7 @@ hydrogens of <em>aa</em>.</p>
 </tr>
 <tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a></td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">AminoAcid</span></code></a>) &#8211; Amino acid type</td>
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">AminoAcid</span></code></a>) &#8211; Amino acid type</td>
 </tr>
 </tbody>
 </table>
@@ -1161,7 +1161,7 @@ hydrogens of <em>aa</em>.</p>
 <tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">Amino acid type of the given heavy atom type</p>
 </td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><p class="first"><a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">AminoAcid</span></code></a></p>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><p class="first"><a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">AminoAcid</span></code></a></p>
 </td>
 </tr>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
@@ -1255,7 +1255,7 @@ when residue is peptide bound.</td>
 </tr>
 <tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a></td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">AminoAcid</span></code></a>) &#8211; Amino acid type</td>
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">AminoAcid</span></code></a>) &#8211; Amino acid type</td>
 </tr>
 <tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if no such atom (i.e. PRO)</td>
 </tr>
@@ -1279,7 +1279,7 @@ when residue is N terminal.</td>
 </tr>
 <tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a></td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">AminoAcid</span></code></a>) &#8211; Amino acid type</td>
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">AminoAcid</span></code></a>) &#8211; Amino acid type</td>
 </tr>
 <tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if no such atom (i.e. H3 for PRO)</td>
 </tr>
@@ -1343,7 +1343,7 @@ when residue is N terminal.</td>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/loop/backbone.html b/doc/html/loop/backbone.html
index f44cf2070cf736fde687d7cbeff88cf77e357bb7..5bc7e7738c7a762b3140782249f5ec57f9593d6b 100644
--- a/doc/html/loop/backbone.html
+++ b/doc/html/loop/backbone.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Representing Loops &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Representing Loops &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="loop - Loop Handling" href="index.html" />
     <link rel="next" title="Sampling Dihedral Angles" href="torsion_sampler.html" />
     <link rel="prev" title="loop - Loop Handling" href="index.html" />
@@ -47,7 +47,7 @@
 <p>The most simple representation of structural information in ProMod3 is the
 <a class="reference internal" href="#promod3.loop.BackboneList" title="promod3.loop.BackboneList"><code class="xref py py-class docutils literal"><span class="pre">BackboneList</span></code></a>. It provides a way to store the backbone positions of
 residues. They provide structural manipulations, they can be manipulated and
-converted from, to, or inserted to a <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.EntityHandle</span></code></a>.</p>
+converted from, to, or inserted to a <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.EntityHandle</span></code></a>.</p>
 <div class="highlight-default"><div class="highlight"><pre><span></span><span class="kn">from</span> <span class="nn">ost</span> <span class="k">import</span> <span class="n">io</span>
 <span class="kn">from</span> <span class="nn">ost</span> <span class="k">import</span> <span class="n">conop</span>
 <span class="kn">from</span> <span class="nn">promod3</span> <span class="k">import</span> <span class="n">loop</span>
@@ -150,6 +150,28 @@ code which is not one of the 20 default amino acids or if
 </table>
 </dd></dl>
 
+<dl class="method">
+<dt>
+<code class="descname">BackboneList</code><span class="sig-paren">(</span><em>residues</em><span class="sig-paren">)</span></dt>
+<dd><p>Creates a BackboneList with positions and sequence extracted from
+<em>residues</em>.</p>
+<table class="docutils field-list" frame="void" rules="none">
+<col class="field-name" />
+<col class="field-body" />
+<tbody valign="top">
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>residues</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code>) &#8211; List of <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a> objects from
+which the backbone positions and one letter codes
+are extracted.</td>
+</tr>
+<tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if a residue in <em>residues</em>
+contains a one letter code which is not one of the 20 default
+amino acids or when there is a residue not providing all
+required positions.</td>
+</tr>
+</tbody>
+</table>
+</dd></dl>
+
 <dl class="method">
 <dt>
 <code class="descname">BackboneList</code><span class="sig-paren">(</span><em>sequence</em>, <em>residues</em><span class="sig-paren">)</span></dt>
@@ -161,7 +183,7 @@ code which is not one of the 20 default amino acids or if
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>sequence</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; Sequence of created BackboneList</li>
-<li><strong>residues</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code>) &#8211; List of <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a> objects from
+<li><strong>residues</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code>) &#8211; List of <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a> objects from
 which the backbone positions are extracted.</li>
 </ul>
 </td>
@@ -185,7 +207,7 @@ a residue not providing all necessary positions.</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">The whole backbone list converted to a density map.</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/img/base/img/#ost.img.ImageHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.img.ImageHandle</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/img/base/img/#ost.img.ImageHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.img.ImageHandle</span></code></a></td>
 </tr>
 </tbody>
 </table>
@@ -195,7 +217,7 @@ a residue not providing all necessary positions.</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
 <li><strong>padding</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; </li>
-<li><strong>sampling</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; </li>
+<li><strong>sampling</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; </li>
 <li><strong>resolution</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; </li>
 <li><strong>high_resolution</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#bool" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">bool</span></code></a>) &#8211; </li>
 </ul>
@@ -214,7 +236,7 @@ a residue not providing all necessary positions.</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">The whole backbone list converted to an OST entity.</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.EntityHandle</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.EntityHandle</span></code></a></td>
 </tr>
 </tbody>
 </table>
@@ -231,8 +253,8 @@ be replaced, otherwise they will be added to the entity.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
-<li><strong>chain</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ChainHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ChainHandle</span></code></a>) &#8211; The chain</li>
-<li><strong>start_resnum</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResNum" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResNum</span></code></a>) &#8211; Residue number defining the start location of insertion</li>
+<li><strong>chain</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ChainHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ChainHandle</span></code></a>) &#8211; The chain</li>
+<li><strong>start_resnum</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResNum" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResNum</span></code></a>) &#8211; Residue number defining the start location of insertion</li>
 </ul>
 </td>
 </tr>
@@ -248,7 +270,7 @@ be replaced, otherwise they will be added to the entity.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
-<li><strong>map</strong> (<a class="reference external" href="https://www.openstructure.org/docs/img/base/img/#ost.img.ImageHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.img.ImageHandle</span></code></a>) &#8211; </li>
+<li><strong>map</strong> (<a class="reference external" href="https://www.openstructure.org/docs/img/base/img/#ost.img.ImageHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.img.ImageHandle</span></code></a>) &#8211; </li>
 <li><strong>resolution</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; </li>
 <li><strong>high_resolution</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#bool" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">bool</span></code></a>) &#8211; </li>
 </ul>
@@ -267,7 +289,7 @@ be replaced, otherwise they will be added to the entity.</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body"></td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/geom/composite/#ost.geom.AlignedCuboid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.AlignedCuboid</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/geom/composite/#ost.geom.AlignedCuboid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.AlignedCuboid</span></code></a></td>
 </tr>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>all_atom</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#bool" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">bool</span></code></a>) &#8211; </td>
 </tr>
@@ -371,7 +393,7 @@ actual fragment at specified <em>index</em></p>
 <tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">Position of nitrogen / alpha carbon / beta carbon / carbon / oxygen
 atom for residue at given index.</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a></td>
 </tr>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Residue index.</td>
 </tr>
@@ -396,7 +418,7 @@ atom for residue at given index.</td>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
 <li><strong>index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Residue index.</li>
-<li><strong>pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of nitrogen / alpha carbon / beta carbon / carbon
+<li><strong>pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of nitrogen / alpha carbon / beta carbon / carbon
 / oxygen atom to this.</li>
 </ul>
 </td>
@@ -448,7 +470,7 @@ atom for residue at given index.</td>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">Amino acid type of the residue at given index.</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a></td>
 </tr>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Residue index.</td>
 </tr>
@@ -465,7 +487,7 @@ atom for residue at given index.</td>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Residue index.</li>
-<li><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; Set amino acid type of the residue to this.</li>
+<li><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; Set amino acid type of the residue to this.</li>
 </ul>
 </td>
 </tr>
@@ -491,12 +513,12 @@ and set the amino acid type according to the given one letter code.</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
 <li><strong>index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Residue index.</li>
-<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ResidueHandle</span></code></a>) &#8211; Residue from which to extract backbone atom positions</li>
-<li><strong>n_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of nitrogen atom to this.</li>
-<li><strong>ca_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of alpha carbon atom to this.</li>
-<li><strong>cb_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of beta carbon atom to this.</li>
-<li><strong>c_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of carbon atom to this.</li>
-<li><strong>o_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of oxygen atom to this.</li>
+<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ResidueHandle</span></code></a>) &#8211; Residue from which to extract backbone atom positions</li>
+<li><strong>n_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of nitrogen atom to this.</li>
+<li><strong>ca_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of alpha carbon atom to this.</li>
+<li><strong>cb_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of beta carbon atom to this.</li>
+<li><strong>c_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of carbon atom to this.</li>
+<li><strong>o_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of oxygen atom to this.</li>
 <li><strong>olc</strong> (<code class="xref py py-class docutils literal"><span class="pre">char</span></code>) &#8211; Set one letter code of the residue to this.</li>
 </ul>
 </td>
@@ -566,12 +588,12 @@ to the given one letter code.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
-<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ResidueHandle</span></code></a>) &#8211; Residue from which to extract backbone atom positions</li>
-<li><strong>n_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of nitrogen atom to this.</li>
-<li><strong>ca_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of alpha carbon atom to this.</li>
-<li><strong>cb_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of beta carbon atom to this.</li>
-<li><strong>c_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of carbon atom to this.</li>
-<li><strong>o_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of oxygen atom to this.</li>
+<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ResidueHandle</span></code></a>) &#8211; Residue from which to extract backbone atom positions</li>
+<li><strong>n_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of nitrogen atom to this.</li>
+<li><strong>ca_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of alpha carbon atom to this.</li>
+<li><strong>cb_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of beta carbon atom to this.</li>
+<li><strong>c_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of carbon atom to this.</li>
+<li><strong>o_pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>) &#8211; Set position of oxygen atom to this.</li>
 <li><strong>olc</strong> (<code class="xref py py-class docutils literal"><span class="pre">char</span></code>) &#8211; Set one letter code of the residue to this.</li>
 </ul>
 </td>
@@ -635,7 +657,7 @@ reconstructed if the residue handle is valid.</p>
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>after_c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue following the C stem (C stem residue is last
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>after_c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue following the C stem (C stem residue is last
 element of this backbone list)</td>
 </tr>
 </tbody>
@@ -652,7 +674,7 @@ element of this backbone list)</td>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
 <li><strong>index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Residue index.</li>
-<li><strong>transform</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat4" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Mat4</span></code></a>) &#8211; The transformation</li>
+<li><strong>transform</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat4" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Mat4</span></code></a>) &#8211; The transformation</li>
 </ul>
 </td>
 </tr>
@@ -672,7 +694,7 @@ element of this backbone list)</td>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
 <li><strong>from</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Start index.</li>
 <li><strong>to</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; End index (one past last residue to transform).</li>
-<li><strong>transform</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat4" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Mat4</span></code></a>) &#8211; The transformation</li>
+<li><strong>transform</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat4" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Mat4</span></code></a>) &#8211; The transformation</li>
 </ul>
 </td>
 </tr>
@@ -688,7 +710,7 @@ element of this backbone list)</td>
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>transform</strong> (<code class="xref py py-class docutils literal"><span class="pre">ost.geom.Transform</span></code> / <a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat4" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Mat4</span></code></a>) &#8211; The transformation</td>
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>transform</strong> (<code class="xref py py-class docutils literal"><span class="pre">ost.geom.Transform</span></code> / <a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat4" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Mat4</span></code></a>) &#8211; The transformation</td>
 </tr>
 </tbody>
 </table>
@@ -708,12 +730,12 @@ residue <em>other_index</em> of <em>other</em> backbone list considering the
 positions of the N, CA and C atoms.</p>
 </td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><p class="first"><a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat4" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Mat4</span></code></a></p>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><p class="first"><a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat4" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Mat4</span></code></a></p>
 </td>
 </tr>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
 <li><strong>index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Residue index.</li>
-<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; The other residue.</li>
+<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; The other residue.</li>
 <li><strong>other</strong> (<a class="reference internal" href="#promod3.loop.BackboneList" title="promod3.loop.BackboneList"><code class="xref py py-class docutils literal"><span class="pre">BackboneList</span></code></a>) &#8211; The other backbone list.</li>
 <li><strong>other_index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Residue index in <em>other</em> backbone list.</li>
 </ul>
@@ -733,7 +755,7 @@ positions of the N, CA and C atoms.</p>
 <tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">Get minimum RMSD transformation of CA positions of this backbone
 list onto CA positions of <em>other</em> backbone list.</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat4" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Mat4</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat4" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Mat4</span></code></a></td>
 </tr>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>other</strong> (<a class="reference internal" href="#promod3.loop.BackboneList" title="promod3.loop.BackboneList"><code class="xref py py-class docutils literal"><span class="pre">BackboneList</span></code></a>) &#8211; The other backbone list.</td>
 </tr>
@@ -1005,7 +1027,7 @@ backbone list.</td>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/loop/index.html b/doc/html/loop/index.html
index 58b98b7aa4ff3f8e0be5b7e561bd02f62d6661b0..b5c82a2904e1141b2be11b0c06de3e1e21e7952a 100644
--- a/doc/html/loop/index.html
+++ b/doc/html/loop/index.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>loop - Loop Handling &mdash; ProMod3 2.0.0 documentation</title>
+    <title>loop - Loop Handling &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="Documentation For Users" href="../users.html" />
     <link rel="next" title="Representing Loops" href="backbone.html" />
     <link rel="prev" title="Other Scoring Functions" href="../scoring/other_scoring_functions.html" />
@@ -163,7 +163,7 @@ loops. The following example should give you an idea of what can be done:</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/loop/load_loop_objects.html b/doc/html/loop/load_loop_objects.html
index ce2e37a473c1447a33f8ba8679fed9dd2ece6047..862906c9a062de9f3447fbff595aaf1f20d50956 100644
--- a/doc/html/loop/load_loop_objects.html
+++ b/doc/html/loop/load_loop_objects.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Loading Precomputed Objects &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Loading Precomputed Objects &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="loop - Loop Handling" href="index.html" />
     <link rel="next" title="core - ProMod3 Core Functionality" href="../core/index.html" />
     <link rel="prev" title="Generate ost.mol.mm systems" href="mm_system_creation.html" />
@@ -204,7 +204,7 @@ returned by <a class="reference internal" href="#promod3.loop.LoadStructureDB" t
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/loop/mm_system_creation.html b/doc/html/loop/mm_system_creation.html
index 8dfaaaec37aec2fb0da5bfca21607687e1e8147f..a46f522fd8fab7a5f592707b11e5d2d8676db5a8 100644
--- a/doc/html/loop/mm_system_creation.html
+++ b/doc/html/loop/mm_system_creation.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Generate ost.mol.mm systems &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Generate ost.mol.mm systems &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="loop - Loop Handling" href="index.html" />
     <link rel="next" title="Loading Precomputed Objects" href="load_loop_objects.html" />
     <link rel="prev" title="Handling All Atom Positions" href="all_atom.html" />
@@ -43,8 +43,8 @@
           <div class="body" role="main">
             
   <div class="section" id="generate-ost-mol-mm-systems">
-<h1>Generate <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/molmm/#module-ost.mol.mm" title="(in OpenStructure v1.9.0)"><code class="xref py py-mod docutils literal"><span class="pre">ost.mol.mm</span></code></a> systems<a class="headerlink" href="#generate-ost-mol-mm-systems" title="Permalink to this headline">¶</a></h1>
-<p>To simplify the creation of <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/molmm/#module-ost.mol.mm" title="(in OpenStructure v1.9.0)"><code class="xref py py-mod docutils literal"><span class="pre">ost.mol.mm</span></code></a> / OpenMM simulations for loops in
+<h1>Generate <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/molmm/#module-ost.mol.mm" title="(in OpenStructure v1.10.0)"><code class="xref py py-mod docutils literal"><span class="pre">ost.mol.mm</span></code></a> systems<a class="headerlink" href="#generate-ost-mol-mm-systems" title="Permalink to this headline">¶</a></h1>
+<p>To simplify the creation of <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/molmm/#module-ost.mol.mm" title="(in OpenStructure v1.10.0)"><code class="xref py py-mod docutils literal"><span class="pre">ost.mol.mm</span></code></a> / OpenMM simulations for loops in
 proteins, we define a system creator for loops (<a class="reference internal" href="#promod3.loop.MmSystemCreator" title="promod3.loop.MmSystemCreator"><code class="xref py py-class docutils literal"><span class="pre">MmSystemCreator</span></code></a>) and a
 specialized forcefield lookup for amino acids (<a class="reference internal" href="#promod3.loop.ForcefieldLookup" title="promod3.loop.ForcefieldLookup"><code class="xref py py-class docutils literal"><span class="pre">ForcefieldLookup</span></code></a>).</p>
 <p>The example below showcases the creation and use of an MM system:</p>
@@ -289,7 +289,7 @@ acid types for <em>out_pos[res_indices[i]]</em> and <em>all_pos[res_indices[i]]<
 <tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">Simulation object setup by <a class="reference internal" href="#promod3.loop.MmSystemCreator.SetupSystem" title="promod3.loop.MmSystemCreator.SetupSystem"><code class="xref py py-meth docutils literal"><span class="pre">SetupSystem()</span></code></a>. Use this to run
 MM simulations.</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/mol/mm/simulation/#ost.mol.mm.Simulation" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.mm.Simulation</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/mol/mm/simulation/#ost.mol.mm.Simulation" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.mm.Simulation</span></code></a></td>
 </tr>
 </tbody>
 </table>
@@ -436,7 +436,7 @@ FF specific data for amino acids in a protein. We distinguish amino acid types
 <dl class="class">
 <dt id="promod3.loop.ForcefieldLookup">
 <em class="property">class </em><code class="descclassname">promod3.loop.</code><code class="descname">ForcefieldLookup</code><a class="headerlink" href="#promod3.loop.ForcefieldLookup" title="Permalink to this definition">¶</a></dt>
-<dd><p>This class provides all functionality to generate <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/simulation/#ost.mol.mm.Simulation" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.mm.Simulation</span></code></a> objects. Specifically, we can:</p>
+<dd><p>This class provides all functionality to generate <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/simulation/#ost.mol.mm.Simulation" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.mm.Simulation</span></code></a> objects. Specifically, we can:</p>
 <ul class="simple">
 <li>get a consistent indexing of each atom of each residue in [<em>0, N-1</em>], where
 <em>N</em> = <a class="reference internal" href="#promod3.loop.ForcefieldLookup.GetNumAtoms" title="promod3.loop.ForcefieldLookup.GetNumAtoms"><code class="xref py py-meth docutils literal"><span class="pre">GetNumAtoms()</span></code></a> (note that only OXT indexing depends on whether a
@@ -549,7 +549,7 @@ for details.</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">Amino acid type for given <em>ff_aa</em></td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a></td>
 </tr>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>ff_aa</strong> (<a class="reference internal" href="#promod3.loop.ForcefieldAminoAcid" title="promod3.loop.ForcefieldAminoAcid"><code class="xref py py-class docutils literal"><span class="pre">ForcefieldAminoAcid</span></code></a>) &#8211; Forcefield-specific amino acid type</td>
 </tr>
@@ -665,7 +665,7 @@ for details.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">Dampening factor for LJ 1,4 interactions (see
-<a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.SetFudgeLJ" title="(in OpenStructure v1.9.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.SetFudgeLJ()</span></code></a>)</td>
+<a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.SetFudgeLJ" title="(in OpenStructure v1.10.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.SetFudgeLJ()</span></code></a>)</td>
 </tr>
 <tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a></td>
 </tr>
@@ -681,7 +681,7 @@ for details.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">Dampening factor for electrostatic 1,4 interactions (see
-<a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.SetFudgeQQ" title="(in OpenStructure v1.9.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.SetFudgeQQ()</span></code></a>)</td>
+<a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.SetFudgeQQ" title="(in OpenStructure v1.10.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.SetFudgeQQ()</span></code></a>)</td>
 </tr>
 <tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a></td>
 </tr>
@@ -696,7 +696,7 @@ for details.</p>
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">Mass for each atom (see <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.SetMasses" title="(in OpenStructure v1.9.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.SetMasses()</span></code></a>)</p>
+<tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">Mass for each atom (see <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.SetMasses" title="(in OpenStructure v1.10.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.SetMasses()</span></code></a>)</p>
 </td>
 </tr>
 <tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><p class="first"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a> (length = <a class="reference internal" href="#promod3.loop.ForcefieldLookup.GetNumAtoms" title="promod3.loop.ForcefieldLookup.GetNumAtoms"><code class="xref py py-meth docutils literal"><span class="pre">GetNumAtoms()</span></code></a>)</p>
@@ -720,7 +720,7 @@ for details.</p>
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">Charge for each atom (see <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.SetCharges" title="(in OpenStructure v1.9.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.SetCharges()</span></code></a>)</p>
+<tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">Charge for each atom (see <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.SetCharges" title="(in OpenStructure v1.10.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.SetCharges()</span></code></a>)</p>
 </td>
 </tr>
 <tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><p class="first"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a> (length = <a class="reference internal" href="#promod3.loop.ForcefieldLookup.GetNumAtoms" title="promod3.loop.ForcefieldLookup.GetNumAtoms"><code class="xref py py-meth docutils literal"><span class="pre">GetNumAtoms()</span></code></a>)</p>
@@ -745,7 +745,7 @@ for details.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">Sigma in nm for each atom
-(see <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.SetSigmas" title="(in OpenStructure v1.9.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.SetSigmas()</span></code></a>)</p>
+(see <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.SetSigmas" title="(in OpenStructure v1.10.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.SetSigmas()</span></code></a>)</p>
 </td>
 </tr>
 <tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><p class="first"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a> (length = <a class="reference internal" href="#promod3.loop.ForcefieldLookup.GetNumAtoms" title="promod3.loop.ForcefieldLookup.GetNumAtoms"><code class="xref py py-meth docutils literal"><span class="pre">GetNumAtoms()</span></code></a>)</p>
@@ -770,7 +770,7 @@ for details.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">Epsilon in kJ/mol for each atom
-(see <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.SetEpsilons" title="(in OpenStructure v1.9.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.SetEpsilons()</span></code></a>)</p>
+(see <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.SetEpsilons" title="(in OpenStructure v1.10.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.SetEpsilons()</span></code></a>)</p>
 </td>
 </tr>
 <tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><p class="first"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a> (length = <a class="reference internal" href="#promod3.loop.ForcefieldLookup.GetNumAtoms" title="promod3.loop.ForcefieldLookup.GetNumAtoms"><code class="xref py py-meth docutils literal"><span class="pre">GetNumAtoms()</span></code></a>)</p>
@@ -916,7 +916,7 @@ for details.</p>
 <dt id="promod3.loop.ForcefieldAminoAcid">
 <em class="property">class </em><code class="descclassname">promod3.loop.</code><code class="descname">ForcefieldAminoAcid</code><a class="headerlink" href="#promod3.loop.ForcefieldAminoAcid" title="Permalink to this definition">¶</a></dt>
 <dd><p>Enumerates the amino acid types for forcefields. The first 20 values
-correspond to the 20 values of <a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>. Additionally,
+correspond to the 20 values of <a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>. Additionally,
 there are values for disulfid bridges (<em>FF_CYS2</em>), d-protonated histidine
 (<em>FF_HISD</em>, default for <em>ost.conop.HIS</em> is <em>FF_HISE</em>) and <em>FF_XXX</em> for unknown
 types. The full list of values is:</p>
@@ -933,7 +933,7 @@ types. The full list of values is:</p>
 <dd><p>Contains lists of bonds, angles, dihedrals, impropers and LJ pairs (exclusions
 are the combination of all bonds and 1,3 pairs of angles and are not stored
 separately). Each type of connectivity has it&#8217;s own class (see below) storing
-indices and parameters to be used for methods of <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.mm.Topology</span></code></a>.
+indices and parameters to be used for methods of <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.mm.Topology</span></code></a>.
 The indexing of atoms for internal connectivities is in [<em>0, N-1</em>], where <em>N</em>
 = <a class="reference internal" href="#promod3.loop.ForcefieldLookup.GetNumAtoms" title="promod3.loop.ForcefieldLookup.GetNumAtoms"><code class="xref py py-meth docutils literal"><span class="pre">ForcefieldLookup.GetNumAtoms()</span></code></a>. For connectivities of pairs of
 residues, atoms of the first residue are in [<em>0, N1-1</em>] and atoms of the
@@ -1043,7 +1043,7 @@ False, False)</em>.</p>
 <dl class="class">
 <dt id="promod3.loop.ForcefieldBondInfo">
 <em class="property">class </em><code class="descclassname">promod3.loop.</code><code class="descname">ForcefieldBondInfo</code><a class="headerlink" href="#promod3.loop.ForcefieldBondInfo" title="Permalink to this definition">¶</a></dt>
-<dd><p>Define harmonic bond (see <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.AddHarmonicBond" title="(in OpenStructure v1.9.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.AddHarmonicBond()</span></code></a>)</p>
+<dd><p>Define harmonic bond (see <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.AddHarmonicBond" title="(in OpenStructure v1.10.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.AddHarmonicBond()</span></code></a>)</p>
 <dl class="attribute">
 <dt id="promod3.loop.ForcefieldBondInfo.index_one">
 <code class="descname">index_one</code><a class="headerlink" href="#promod3.loop.ForcefieldBondInfo.index_one" title="Permalink to this definition">¶</a></dt>
@@ -1105,7 +1105,7 @@ False, False)</em>.</p>
 <dl class="class">
 <dt id="promod3.loop.ForcefieldHarmonicAngleInfo">
 <em class="property">class </em><code class="descclassname">promod3.loop.</code><code class="descname">ForcefieldHarmonicAngleInfo</code><a class="headerlink" href="#promod3.loop.ForcefieldHarmonicAngleInfo" title="Permalink to this definition">¶</a></dt>
-<dd><p>Define harmonic angle (see <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.AddHarmonicAngle" title="(in OpenStructure v1.9.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.AddHarmonicAngle()</span></code></a>)</p>
+<dd><p>Define harmonic angle (see <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.AddHarmonicAngle" title="(in OpenStructure v1.10.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.AddHarmonicAngle()</span></code></a>)</p>
 <dl class="attribute">
 <dt id="promod3.loop.ForcefieldHarmonicAngleInfo.index_one">
 <code class="descname">index_one</code><a class="headerlink" href="#promod3.loop.ForcefieldHarmonicAngleInfo.index_one" title="Permalink to this definition">¶</a></dt>
@@ -1182,7 +1182,7 @@ False, False)</em>.</p>
 <dt id="promod3.loop.ForcefieldUreyBradleyAngleInfo">
 <em class="property">class </em><code class="descclassname">promod3.loop.</code><code class="descname">ForcefieldUreyBradleyAngleInfo</code><a class="headerlink" href="#promod3.loop.ForcefieldUreyBradleyAngleInfo" title="Permalink to this definition">¶</a></dt>
 <dd><p>Define Urey-Bradley angle
-(see <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.AddUreyBradleyAngle" title="(in OpenStructure v1.9.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.AddUreyBradleyAngle()</span></code></a>)</p>
+(see <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.AddUreyBradleyAngle" title="(in OpenStructure v1.10.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.AddUreyBradleyAngle()</span></code></a>)</p>
 <dl class="attribute">
 <dt id="promod3.loop.ForcefieldUreyBradleyAngleInfo.index_one">
 <code class="descname">index_one</code><a class="headerlink" href="#promod3.loop.ForcefieldUreyBradleyAngleInfo.index_one" title="Permalink to this definition">¶</a></dt>
@@ -1287,8 +1287,8 @@ False, False)</em>.</p>
 <dt id="promod3.loop.ForcefieldPeriodicDihedralInfo">
 <em class="property">class </em><code class="descclassname">promod3.loop.</code><code class="descname">ForcefieldPeriodicDihedralInfo</code><a class="headerlink" href="#promod3.loop.ForcefieldPeriodicDihedralInfo" title="Permalink to this definition">¶</a></dt>
 <dd><p>Define periodic dihedral or improper (see
-<a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.AddPeriodicDihedral" title="(in OpenStructure v1.9.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.AddPeriodicDihedral()</span></code></a> and
-<a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.AddPeriodicImproper" title="(in OpenStructure v1.9.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.AddPeriodicImproper()</span></code></a>)</p>
+<a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.AddPeriodicDihedral" title="(in OpenStructure v1.10.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.AddPeriodicDihedral()</span></code></a> and
+<a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.AddPeriodicImproper" title="(in OpenStructure v1.10.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.AddPeriodicImproper()</span></code></a>)</p>
 <dl class="attribute">
 <dt id="promod3.loop.ForcefieldPeriodicDihedralInfo.index_one">
 <code class="descname">index_one</code><a class="headerlink" href="#promod3.loop.ForcefieldPeriodicDihedralInfo.index_one" title="Permalink to this definition">¶</a></dt>
@@ -1392,7 +1392,7 @@ False, False)</em>.</p>
 <dl class="class">
 <dt id="promod3.loop.ForcefieldHarmonicImproperInfo">
 <em class="property">class </em><code class="descclassname">promod3.loop.</code><code class="descname">ForcefieldHarmonicImproperInfo</code><a class="headerlink" href="#promod3.loop.ForcefieldHarmonicImproperInfo" title="Permalink to this definition">¶</a></dt>
-<dd><p>Define harmonic improper (see <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.AddHarmonicImproper" title="(in OpenStructure v1.9.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.AddHarmonicImproper()</span></code></a>)</p>
+<dd><p>Define harmonic improper (see <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.AddHarmonicImproper" title="(in OpenStructure v1.10.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.AddHarmonicImproper()</span></code></a>)</p>
 <dl class="attribute">
 <dt id="promod3.loop.ForcefieldHarmonicImproperInfo.index_one">
 <code class="descname">index_one</code><a class="headerlink" href="#promod3.loop.ForcefieldHarmonicImproperInfo.index_one" title="Permalink to this definition">¶</a></dt>
@@ -1482,7 +1482,7 @@ False, False)</em>.</p>
 <dl class="class">
 <dt id="promod3.loop.ForcefieldLJPairInfo">
 <em class="property">class </em><code class="descclassname">promod3.loop.</code><code class="descname">ForcefieldLJPairInfo</code><a class="headerlink" href="#promod3.loop.ForcefieldLJPairInfo" title="Permalink to this definition">¶</a></dt>
-<dd><p>Define LJ pair (see <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.AddLJPair" title="(in OpenStructure v1.9.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.AddLJPair()</span></code></a>)</p>
+<dd><p>Define LJ pair (see <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/topology/#ost.mol.mm.Topology.AddLJPair" title="(in OpenStructure v1.10.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.mm.Topology.AddLJPair()</span></code></a>)</p>
 <dl class="attribute">
 <dt id="promod3.loop.ForcefieldLJPairInfo.index_one">
 <code class="descname">index_one</code><a class="headerlink" href="#promod3.loop.ForcefieldLJPairInfo.index_one" title="Permalink to this definition">¶</a></dt>
@@ -1593,7 +1593,7 @@ False, False)</em>.</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/loop/structure_db.html b/doc/html/loop/structure_db.html
index 0b6af0659d3cd5399ce7aa1a943d430a83e6bd49..e9187bffffdf6c3282227c9959f929dfb75e07de 100644
--- a/doc/html/loop/structure_db.html
+++ b/doc/html/loop/structure_db.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Structural Data &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Structural Data &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="loop - Loop Handling" href="index.html" />
     <link rel="next" title="Handling All Atom Positions" href="all_atom.html" />
     <link rel="prev" title="Sampling Dihedral Angles" href="torsion_sampler.html" />
@@ -126,7 +126,7 @@ stuff to the structure db. (<a class="reference external" href="https://docs.pyt
 <dt id="promod3.loop.CoordInfo.shift">
 <code class="descname">shift</code><a class="headerlink" href="#promod3.loop.CoordInfo.shift" title="Permalink to this definition">¶</a></dt>
 <dd><p>Translation from original coordinates that has been applied before storing
-structural information in db. (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>)</p>
+structural information in db. (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>)</p>
 </dd></dl>
 
 </dd></dl>
@@ -243,16 +243,9 @@ and fill it with content.</p>
 
 <span class="k">for</span> <span class="n">i</span> <span class="ow">in</span> <span class="nb">range</span><span class="p">(</span><span class="n">structure_db_one</span><span class="o">.</span><span class="n">GetNumCoords</span><span class="p">()):</span>
 
-    <span class="c1"># get the CoordInfo for chain with index i </span>
-    <span class="n">coord_info</span> <span class="o">=</span> <span class="n">structure_db_one</span><span class="o">.</span><span class="n">GetCoordInfo</span><span class="p">(</span><span class="n">i</span><span class="p">)</span>
-
-    <span class="c1"># define a fragment, that covers the full length</span>
-    <span class="n">frag_info</span> <span class="o">=</span> <span class="n">loop</span><span class="o">.</span><span class="n">FragmentInfo</span><span class="p">(</span><span class="n">i</span><span class="p">,</span> <span class="mi">0</span><span class="p">,</span> <span class="n">coord_info</span><span class="o">.</span><span class="n">size</span><span class="p">)</span>
-
     <span class="c1"># extract all required information</span>
-    <span class="n">sequence</span> <span class="o">=</span> <span class="n">structure_db_one</span><span class="o">.</span><span class="n">GetSequence</span><span class="p">(</span><span class="n">frag_info</span><span class="p">)</span>
-    <span class="n">bb_list</span> <span class="o">=</span> <span class="n">structure_db_one</span><span class="o">.</span><span class="n">GetBackboneList</span><span class="p">(</span><span class="n">frag_info</span><span class="p">,</span> <span class="n">sequence</span><span class="p">)</span>
-    <span class="n">res_depths</span> <span class="o">=</span> <span class="n">structure_db_one</span><span class="o">.</span><span class="n">GetResidueDepths</span><span class="p">(</span><span class="n">frag_info</span><span class="p">)</span>
+    <span class="n">bb_list</span> <span class="o">=</span> <span class="n">structure_db_one</span><span class="o">.</span><span class="n">GetBackboneList</span><span class="p">(</span><span class="n">i</span><span class="p">)</span>
+    <span class="n">res_depths</span> <span class="o">=</span> <span class="n">structure_db_one</span><span class="o">.</span><span class="n">GetResidueDepths</span><span class="p">(</span><span class="n">i</span><span class="p">)</span>
 
     <span class="c1"># generate structure profiles based on structure_db_two</span>
     <span class="n">prof</span> <span class="o">=</span> <span class="n">structure_db_two</span><span class="o">.</span><span class="n">GenerateStructureProfile</span><span class="p">(</span><span class="n">bb_list</span><span class="p">,</span> 
@@ -275,7 +268,7 @@ database, you might want to consider two things:</p>
 <ol class="arabic simple">
 <li>Use a database of limited size to generate the actual profiles (something
 in between 5000 and 10000 nonredundant chains is enough)</li>
-<li>Use the <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileDB" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileDB</span></code></a> to gather profiles produced from jobs
+<li>Use the <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileDB" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileDB</span></code></a> to gather profiles produced from jobs
 running in parallel</li>
 </ol>
 <dl class="class">
@@ -284,14 +277,15 @@ running in parallel</li>
 <dd><p>The StructureDBDataType enum has to be passed at initialization of a
 StructureDB in order to define what data you want to store additionally
 to backbone coordinates and sequence.
+For the bare minimum (only backbone coordinates and sequence), use Minimal.
 If you want to store all data possible, use All. If you only want a subset,
 you can combine some of the datatypes with a bitwise or operation
 (see example script for <a class="reference internal" href="#promod3.loop.StructureDB" title="promod3.loop.StructureDB"><code class="xref py py-class docutils literal"><span class="pre">StructureDB</span></code></a>). One important note:
 If you enable AAFrequenciesStruct, the actual information is not automatically
 assigned. Only the according memory is allocated and set to zero, the actual
 information must be assigned manually (see example script again...).</p>
-<p>All, Dihedrals, SolventAccessibilities, ResidueDepths, DSSP, AAFrequencies,
-AAFrequenciesStruct</p>
+<p>Minimal, All, Dihedrals, SolventAccessibilities, ResidueDepths, DSSP,
+AAFrequencies, AAFrequenciesStruct</p>
 </dd></dl>
 
 <dl class="class">
@@ -409,10 +403,11 @@ in the according <a class="reference internal" href="#promod3.loop.CoordInfo" ti
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>id</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; identifier of the added structure (e.g. pdb id)</li>
 <li><strong>chain_name</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; Name of the chain in <em>ent</em> you want to add</li>
-<li><strong>ent</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityView" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.EntityView</span></code></a>) &#8211; The full entity that must contain a chain named
+<li><strong>ent</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.EntityHandle</span></code></a> /
+<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityView" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.EntityView</span></code></a>) &#8211; The full entity that must contain a chain named
 as specified by <em>chain_name</em>.</li>
-<li><strong>seqres</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceHandle</span></code></a>) &#8211; The reference sequence of chain with name <em>chain_name</em></li>
-<li><strong>prof</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a>) &#8211; Profile information for the chain with name
+<li><strong>seqres</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceHandle</span></code></a>) &#8211; The reference sequence of chain with name <em>chain_name</em></li>
+<li><strong>prof</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a>) &#8211; Profile information for the chain with name
 <em>chain_name</em>. The profile sequence must match <em>seqres</em>.</li>
 <li><strong>only_longest_stretch</strong> &#8211; Flag whether you want to add only the longest
 connected stretch of residues are all connected
@@ -526,12 +521,17 @@ the database.</td>
 <dt id="promod3.loop.StructureDB.GetBackboneList">
 <code class="descname">GetBackboneList</code><span class="sig-paren">(</span><em>fragment</em>, <em>sequence</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.loop.StructureDB.GetBackboneList" title="Permalink to this definition">¶</a></dt>
 <dt>
-<code class="descname">GetBackboneList</code><span class="sig-paren">(</span><em>n_stem</em>, <em>c_stem</em>, <em>fragment</em>, <em>sequence</em><span class="sig-paren">)</span></dt>
+<code class="descname">GetBackboneList</code><span class="sig-paren">(</span><em>n_stem</em>, <em>c_stem</em>, <em>fragment</em>, <em>sequence=&quot;&quot;</em><span class="sig-paren">)</span></dt>
+<dt>
+<code class="descname">GetBackboneList</code><span class="sig-paren">(</span><em>coord_idx</em>, <em>sequence=&quot;&quot;</em><span class="sig-paren">)</span></dt>
+<dt>
+<code class="descname">GetBackboneList</code><span class="sig-paren">(</span><em>n_stem</em>, <em>c_stem</em>, <em>coord_idx</em>, <em>sequence=&quot;&quot;</em><span class="sig-paren">)</span></dt>
 <dd><table class="docutils field-list" frame="void" rules="none">
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">Backbone list with positions extracted from <em>fragment</em>.</p>
+<tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">Backbone list with positions extracted from <em>fragment</em> or
+full entry at <em>coord_idx</em></p>
 </td>
 </tr>
 <tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><p class="first"><a class="reference internal" href="backbone.html#promod3.loop.BackboneList" title="promod3.loop.BackboneList"><code class="xref py py-class docutils literal"><span class="pre">BackboneList</span></code></a></p>
@@ -539,18 +539,23 @@ the database.</td>
 </tr>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>fragment</strong> (<a class="reference internal" href="#promod3.loop.FragmentInfo" title="promod3.loop.FragmentInfo"><code class="xref py py-class docutils literal"><span class="pre">FragmentInfo</span></code></a>) &#8211; Fragment definition from which to extract positions.</li>
-<li><strong>sequence</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; Sequence to set for the returned backbone list.</li>
-<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Positions on which the backbone list&#8217;s N-terminus should be
+<li><strong>coord_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Idx of entry from which to extract positions.</li>
+<li><strong>sequence</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; Sequence of the returned backbone list. If not
+set, the original sequence at specified location in the
+database is used.</li>
+<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Positions on which the backbone list&#8217;s N-terminus should be
 superposed onto.</li>
-<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Positions on which the backbone list&#8217;s C-terminus should be
+<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Positions on which the backbone list&#8217;s C-terminus should be
 superposed onto.</li>
 </ul>
 </td>
 </tr>
-<tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if fragment is invalid (happens
-if the fragment does not fully fit into one of the connected
-stretches in the database) or if <em>sequence</em> contains a one letter
-code which is not one of the 20 default amino acids.</p>
+<tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if the length of <em>sequence</em> does
+not match with the desired backbone list, if <em>sequence</em> contains
+a character which does not belong to the 20 proteinogenic amino
+acids or if <em>fragment</em> or <em>coord_idx</em> is invalid. Fragment can
+be invalid when it does not fully fit into one of the connected
+stretches of residues in the database.</p>
 </td>
 </tr>
 </tbody>
@@ -560,19 +565,28 @@ code which is not one of the 20 default amino acids.</p>
 <dl class="method">
 <dt id="promod3.loop.StructureDB.GetSequence">
 <code class="descname">GetSequence</code><span class="sig-paren">(</span><em>fragment</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.loop.StructureDB.GetSequence" title="Permalink to this definition">¶</a></dt>
+<dt>
+<code class="descname">GetSequence</code><span class="sig-paren">(</span><em>coord_idx</em><span class="sig-paren">)</span></dt>
 <dd><table class="docutils field-list" frame="void" rules="none">
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">The sequence of <em>fragment</em></td>
+<tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">The sequence of <em>fragment</em> or full entry at <em>coord_idx</em></p>
+</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><p class="first"><a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a></p>
+</td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>fragment</strong> (<a class="reference internal" href="#promod3.loop.FragmentInfo" title="promod3.loop.FragmentInfo"><code class="xref py py-class docutils literal"><span class="pre">FragmentInfo</span></code></a>) &#8211; Fragment definition from which to extract the sequence.</td>
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
+<li><strong>fragment</strong> (<a class="reference internal" href="#promod3.loop.FragmentInfo" title="promod3.loop.FragmentInfo"><code class="xref py py-class docutils literal"><span class="pre">FragmentInfo</span></code></a>) &#8211; Fragment definition from which to extract the sequence.</li>
+<li><strong>coord_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Idx of entry from which to extract the sequence</li>
+</ul>
+</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if fragment is invalid. This is
-the case when the fragment does not fully fit into one of the
-connected stretches of residues in the database.</td>
+<tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if fragment or coord_idx is
+invalid. Fragment can be invalid when it does not fully fit into
+one of the connected stretches of residues in the database.</p>
+</td>
 </tr>
 </tbody>
 </table>
@@ -581,20 +595,29 @@ connected stretches of residues in the database.</td>
 <dl class="method">
 <dt id="promod3.loop.StructureDB.GetDSSPStates">
 <code class="descname">GetDSSPStates</code><span class="sig-paren">(</span><em>fragment</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.loop.StructureDB.GetDSSPStates" title="Permalink to this definition">¶</a></dt>
+<dt>
+<code class="descname">GetDSSPStates</code><span class="sig-paren">(</span><em>coord_idx</em><span class="sig-paren">)</span></dt>
 <dd><table class="docutils field-list" frame="void" rules="none">
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">The dssp states of <em>fragment</em></td>
+<tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">The dssp states of <em>fragment</em> or full entry at <em>coord_idx</em></p>
+</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><p class="first"><a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a></p>
+</td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>fragment</strong> (<a class="reference internal" href="#promod3.loop.FragmentInfo" title="promod3.loop.FragmentInfo"><code class="xref py py-class docutils literal"><span class="pre">FragmentInfo</span></code></a>) &#8211; Fragment definition from which to extract the states.</td>
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
+<li><strong>fragment</strong> (<a class="reference internal" href="#promod3.loop.FragmentInfo" title="promod3.loop.FragmentInfo"><code class="xref py py-class docutils literal"><span class="pre">FragmentInfo</span></code></a>) &#8211; Fragment definition from which to extract the states.</li>
+<li><strong>coord_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Idx of entry from which to extract the dssp states</li>
+</ul>
+</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if database does not contain dssp
-data or if fragment is invalid. This is
-the case when the fragment does not fully fit into one of the
-connected stretches of residues in the database.</td>
+<tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if database does not contain dssp
+data or if fragment/ coord_idx is invalid. Fragment can be invalid
+when it does not fully fit into one of the connected stretches of
+residues in the database.</p>
+</td>
 </tr>
 </tbody>
 </table>
@@ -603,20 +626,30 @@ connected stretches of residues in the database.</td>
 <dl class="method">
 <dt id="promod3.loop.StructureDB.GetDihedralAngles">
 <code class="descname">GetDihedralAngles</code><span class="sig-paren">(</span><em>fragment</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.loop.StructureDB.GetDihedralAngles" title="Permalink to this definition">¶</a></dt>
+<dt>
+<code class="descname">GetDihedralAngles</code><span class="sig-paren">(</span><em>coord_idx</em><span class="sig-paren">)</span></dt>
 <dd><table class="docutils field-list" frame="void" rules="none">
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">The phi and psi dihedral angles of every residue of <em>fragment</em></td>
+<tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">The phi and psi dihedral angles of every residue of <em>fragment</em>
+or full entry at <em>coord_idx</em></p>
+</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of pairs (<code class="xref py py-class docutils literal"><span class="pre">tuple</span></code>)</td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><p class="first"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of pairs (<code class="xref py py-class docutils literal"><span class="pre">tuple</span></code>)</p>
+</td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>fragment</strong> (<a class="reference internal" href="#promod3.loop.FragmentInfo" title="promod3.loop.FragmentInfo"><code class="xref py py-class docutils literal"><span class="pre">FragmentInfo</span></code></a>) &#8211; Fragment definition from which to extract the dihedrals.</td>
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
+<li><strong>fragment</strong> (<a class="reference internal" href="#promod3.loop.FragmentInfo" title="promod3.loop.FragmentInfo"><code class="xref py py-class docutils literal"><span class="pre">FragmentInfo</span></code></a>) &#8211; Fragment definition from which to extract the dihedrals.</li>
+<li><strong>coord_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Idx of entry from which to extract the dihedral angles</li>
+</ul>
+</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if database does not contain
-dihedral angle data or if fragment is invalid. This is
-the case when the fragment does not fully fit into one of the
-connected stretches of residues in the database.</td>
+<tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if database does not contain
+dihedral angle data or if fragment/ coord_idx is invalid.
+Fragment can be invalid when it does not fully fit into one of the
+connected stretches of residues in the database.</p>
+</td>
 </tr>
 </tbody>
 </table>
@@ -625,21 +658,31 @@ connected stretches of residues in the database.</td>
 <dl class="method">
 <dt id="promod3.loop.StructureDB.GetResidueDepths">
 <code class="descname">GetResidueDepths</code><span class="sig-paren">(</span><em>fragment</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.loop.StructureDB.GetResidueDepths" title="Permalink to this definition">¶</a></dt>
+<dt>
+<code class="descname">GetResidueDepths</code><span class="sig-paren">(</span><em>coord_idx</em><span class="sig-paren">)</span></dt>
 <dd><table class="docutils field-list" frame="void" rules="none">
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">Residue depth for each residue of <em>fragment</em>.</td>
+<tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">Residue depth for each residue of <em>fragment</em> or full entry
+at <em>coord_idx</em></p>
+</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><p class="first"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a></p>
+</td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>fragment</strong> (<a class="reference internal" href="#promod3.loop.FragmentInfo" title="promod3.loop.FragmentInfo"><code class="xref py py-class docutils literal"><span class="pre">FragmentInfo</span></code></a>) &#8211; Fragment definition from which to extract the residue
-depths</td>
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
+<li><strong>fragment</strong> (<a class="reference internal" href="#promod3.loop.FragmentInfo" title="promod3.loop.FragmentInfo"><code class="xref py py-class docutils literal"><span class="pre">FragmentInfo</span></code></a>) &#8211; Fragment definition from which to extract the residue
+depths</li>
+<li><strong>coord_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Idx of entry from which to extract the residue depths</li>
+</ul>
+</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if database does not contain
-residue depth data or if fragment is invalid. This is
-the case when the fragment does not fully fit into one of the
-connected stretches of residues in the database.</td>
+<tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if database does not contain
+residue depth data or if fragment/ coord_idx is invalid.
+Fragment can be invalid when it does not fully fit into one of the
+connected stretches of residues in the database.</p>
+</td>
 </tr>
 </tbody>
 </table>
@@ -648,23 +691,34 @@ connected stretches of residues in the database.</td>
 <dl class="method">
 <dt id="promod3.loop.StructureDB.GetSolventAccessibilitites">
 <code class="descname">GetSolventAccessibilitites</code><span class="sig-paren">(</span><em>fragment</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.loop.StructureDB.GetSolventAccessibilitites" title="Permalink to this definition">¶</a></dt>
+<dt>
+<code class="descname">GetSolventAccessibilitites</code><span class="sig-paren">(</span><em>coord_idx</em><span class="sig-paren">)</span></dt>
 <dd><table class="docutils field-list" frame="void" rules="none">
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">Solvent accessibility for each residue of <em>fragment</em> in square A
-as calculated by <a class="reference external" href="https://www.openstructure.org/docs/mol/alg/molalg/#ost.mol.alg.Accessibility" title="(in OpenStructure v1.9.0)"><code class="xref py py-meth docutils literal"><span class="pre">Accessibility()</span></code></a> when adding
-the structure to the database.</td>
+<tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">Solvent accessibility for each residue of <em>fragment</em> or full entry
+at <em>coord_idx</em> in square A as calculated by
+<a class="reference external" href="https://www.openstructure.org/docs/mol/alg/molalg/#ost.mol.alg.Accessibility" title="(in OpenStructure v1.10.0)"><code class="xref py py-meth docutils literal"><span class="pre">Accessibility()</span></code></a> when adding the structure to
+the database.</p>
+</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><p class="first"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a></p>
+</td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>fragment</strong> (<a class="reference internal" href="#promod3.loop.FragmentInfo" title="promod3.loop.FragmentInfo"><code class="xref py py-class docutils literal"><span class="pre">FragmentInfo</span></code></a>) &#8211; Fragment definition from which to extract the solvent
-accessibilities</td>
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
+<li><strong>fragment</strong> (<a class="reference internal" href="#promod3.loop.FragmentInfo" title="promod3.loop.FragmentInfo"><code class="xref py py-class docutils literal"><span class="pre">FragmentInfo</span></code></a>) &#8211; Fragment definition from which to extract the solvent
+accessibilities</li>
+<li><strong>coord_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Idx of entry from which to extract the solvent
+accessibilities</li>
+</ul>
+</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if database does not contain
-solvent accessibility data or if fragment is invalid. This is
-the case when the fragment does not fully fit into one of the
-connected stretches of residues in the database.</td>
+<tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if database does not contain
+solvent accessibility data or if fragment/ coord_idx is invalid.
+Fragment can be invalid when it does not fully fit into one of the
+connected stretches of residues in the database.</p>
+</td>
 </tr>
 </tbody>
 </table>
@@ -673,22 +727,32 @@ connected stretches of residues in the database.</td>
 <dl class="method">
 <dt id="promod3.loop.StructureDB.GetSequenceProfile">
 <code class="descname">GetSequenceProfile</code><span class="sig-paren">(</span><em>fragment</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.loop.StructureDB.GetSequenceProfile" title="Permalink to this definition">¶</a></dt>
+<dt>
+<code class="descname">GetSequenceProfile</code><span class="sig-paren">(</span><em>coord_idx</em><span class="sig-paren">)</span></dt>
 <dd><table class="docutils field-list" frame="void" rules="none">
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">The sequence profile for the residues defined by <em>fragment</em> with
-the BLOSUM62 probabilities as NULL model.</td>
+<tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">The sequence profile for the residues defined by <em>fragment</em> or
+full entry at <em>coord_idx</em> with the BLOSUM62 probabilities as NULL
+model.</p>
+</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><p class="first"><a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a></p>
+</td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>fragment</strong> (<a class="reference internal" href="#promod3.loop.FragmentInfo" title="promod3.loop.FragmentInfo"><code class="xref py py-class docutils literal"><span class="pre">FragmentInfo</span></code></a>) &#8211; Fragment definition from which to extract the sequence
-profile</td>
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
+<li><strong>fragment</strong> (<a class="reference internal" href="#promod3.loop.FragmentInfo" title="promod3.loop.FragmentInfo"><code class="xref py py-class docutils literal"><span class="pre">FragmentInfo</span></code></a>) &#8211; Fragment definition from which to extract the sequence
+profile</li>
+<li><strong>coord_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Idx of entry from which to extract the sequence profile</li>
+</ul>
+</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if database does not cotain
-aa frequency data or if fragment is invalid. This is
-the case when the fragment does not fully fit into one of the
-connected stretches of residues in the database.</td>
+<tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if database does not contain
+sequence profile data or if fragment/ coord_idx is invalid.
+Fragment can be invalid when it does not fully fit into one of the
+connected stretches of residues in the database.</p>
+</td>
 </tr>
 </tbody>
 </table>
@@ -697,22 +761,32 @@ connected stretches of residues in the database.</td>
 <dl class="method">
 <dt id="promod3.loop.StructureDB.GetStructureProfile">
 <code class="descname">GetStructureProfile</code><span class="sig-paren">(</span><em>fragment</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.loop.StructureDB.GetStructureProfile" title="Permalink to this definition">¶</a></dt>
+<dt>
+<code class="descname">GetStructureProfile</code><span class="sig-paren">(</span><em>coord_idx</em><span class="sig-paren">)</span></dt>
 <dd><table class="docutils field-list" frame="void" rules="none">
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">The structure profile for the residues defined by <em>fragment</em> with
-the BLOSUM62 probabilities as NULL model.</td>
+<tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">The structure profile for the residues defined by <em>fragment</em> or
+full entry at <em>coord_idx</em> with the BLOSUM62 probabilities as NULL
+model.</p>
+</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><p class="first"><a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a></p>
+</td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>fragment</strong> (<a class="reference internal" href="#promod3.loop.FragmentInfo" title="promod3.loop.FragmentInfo"><code class="xref py py-class docutils literal"><span class="pre">FragmentInfo</span></code></a>) &#8211; Fragment definition from which to extract the structure
-profile</td>
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
+<li><strong>fragment</strong> (<a class="reference internal" href="#promod3.loop.FragmentInfo" title="promod3.loop.FragmentInfo"><code class="xref py py-class docutils literal"><span class="pre">FragmentInfo</span></code></a>) &#8211; Fragment definition from which to extract the structure
+profile</li>
+<li><strong>coord_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Idx of entry from which to extract the structure profile</li>
+</ul>
+</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if database does not contain
-aa frequencies struct data or if fragment is invalid. This is
-the case when the fragment does not fully fit into one of the
-connected stretches of residues in the database.</td>
+<tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if database does not contain
+structure profile data or if fragment/ coord_idx is invalid.
+Fragment can be invalid when it does not fully fit into one of the
+connected stretches of residues in the database.</p>
+</td>
 </tr>
 </tbody>
 </table>
@@ -739,12 +813,12 @@ containing that data.</li>
 probabilities as NULL model.</p>
 </td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Return type:</th><td class="field-body"><p class="first"><a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a></p>
+<tr class="field-odd field"><th class="field-name">Return type:</th><td class="field-body"><p class="first"><a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a></p>
 </td>
 </tr>
 <tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if <em>bb_list</em> and
 <em>residue_depths</em> differ in size, when their size is 0
-or when database does not contain aa frequencies struct data.</p>
+or when database does not contain residue depth data.</p>
 </td>
 </tr>
 </tbody>
@@ -761,7 +835,7 @@ frequencies in entry with <em>coord_idx</em></p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>prof</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a>) &#8211; Source of profile frequencies</li>
+<li><strong>prof</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a>) &#8211; Source of profile frequencies</li>
 <li><strong>coord_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; StructureDB index of entry for which to set frequencies
 (in [0, <a class="reference internal" href="#promod3.loop.StructureDB.GetNumCoords" title="promod3.loop.StructureDB.GetNumCoords"><code class="xref py py-meth docutils literal"><span class="pre">GetNumCoords()</span></code></a>-1])</li>
 </ul>
@@ -1064,8 +1138,8 @@ and <strong>c_stem</strong> and of the same length as the <strong>frag_size</str
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; The N-stem</li>
-<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; The C-stem</li>
+<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; The N-stem</li>
+<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; The C-stem</li>
 <li><strong>frag_size</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Number of residues of the fragment</li>
 <li><strong>extra_bins</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Whether to extend the search to include fragments from
 <em>extra_bins</em> additional bins surrounding the bin given by
@@ -1289,7 +1363,7 @@ linked to this object.</li>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
 <li><strong>w</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; linear weight</li>
-<li><strong>prof</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a>) &#8211; Profile for the fraggers target_sequence</li>
+<li><strong>prof</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a>) &#8211; Profile for the fraggers target_sequence</li>
 </ul>
 </td>
 </tr>
@@ -1307,7 +1381,7 @@ linked to this object.</li>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
 <li><strong>w</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; linear weight</li>
-<li><strong>prof</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a>) &#8211; Profile for the fraggers target_sequence</li>
+<li><strong>prof</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a>) &#8211; Profile for the fraggers target_sequence</li>
 </ul>
 </td>
 </tr>
@@ -1761,7 +1835,7 @@ to <strong>to</strong>, not including <strong>to</strong> itself</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/loop/torsion_sampler.html b/doc/html/loop/torsion_sampler.html
index 08cab65299b62467bf9c559ccbd086ddf997ad52..c30bb37417d8f8e58ddb80d0d2aea8dcfd0b2bdd 100644
--- a/doc/html/loop/torsion_sampler.html
+++ b/doc/html/loop/torsion_sampler.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Sampling Dihedral Angles &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Sampling Dihedral Angles &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="loop - Loop Handling" href="index.html" />
     <link rel="next" title="Structural Data" href="structure_db.html" />
     <link rel="prev" title="Representing Loops" href="backbone.html" />
@@ -139,7 +139,7 @@ acids not matching any of the group definitions.</p>
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>view</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityView" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.EntityView</span></code></a>) &#8211; structure from which parameters will be extracted</td>
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>view</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityView" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.EntityView</span></code></a>) &#8211; structure from which parameters will be extracted</td>
 </tr>
 </tbody>
 </table>
@@ -211,9 +211,9 @@ for details.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>before</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue before <em>central</em></li>
-<li><strong>central</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue for the central residue</li>
-<li><strong>after</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue after <em>central</em></li>
+<li><strong>before</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue before <em>central</em></li>
+<li><strong>central</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue for the central residue</li>
+<li><strong>after</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue after <em>central</em></li>
 </ul>
 </td>
 </tr>
@@ -253,9 +253,9 @@ standard amino acid</td>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>before</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue before <em>central</em></li>
-<li><strong>central</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue for which torsion angles will be drawn</li>
-<li><strong>after</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue after <em>central</em></li>
+<li><strong>before</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue before <em>central</em></li>
+<li><strong>central</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue for which torsion angles will be drawn</li>
+<li><strong>after</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue after <em>central</em></li>
 </ul>
 </td>
 </tr>
@@ -291,9 +291,9 @@ standard amino acid</td>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>before</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue before <em>central</em></li>
-<li><strong>central</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue for which the <em>phi</em> will be drawn</li>
-<li><strong>after</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue after <em>central</em></li>
+<li><strong>before</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue before <em>central</em></li>
+<li><strong>central</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue for which the <em>phi</em> will be drawn</li>
+<li><strong>after</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue after <em>central</em></li>
 <li><strong>psi</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; <em>psi</em> angle</li>
 </ul>
 </td>
@@ -335,9 +335,9 @@ standard amino acid</td>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>before</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue before <em>central</em></li>
-<li><strong>central</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue for which the <em>psi</em> angle will be drawn</li>
-<li><strong>after</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue after <em>central</em></li>
+<li><strong>before</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue before <em>central</em></li>
+<li><strong>central</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue for which the <em>psi</em> angle will be drawn</li>
+<li><strong>after</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue after <em>central</em></li>
 <li><strong>phi</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; <em>phi</em> angle</li>
 </ul>
 </td>
@@ -379,9 +379,9 @@ standard amino acid</td>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>before</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue before <em>central</em></li>
-<li><strong>central</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue for which the probability is calculated.</li>
-<li><strong>after</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue after <em>central</em></li>
+<li><strong>before</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue before <em>central</em></li>
+<li><strong>central</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue for which the probability is calculated.</li>
+<li><strong>after</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue after <em>central</em></li>
 <li><strong>phi</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; phi angle</li>
 <li><strong>psi</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; psi angle</li>
 </ul>
@@ -425,9 +425,9 @@ standard amino acid</td>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>before</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue before <em>central</em></li>
-<li><strong>central</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue for which the probability is calculated.</li>
-<li><strong>after</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue after <em>central</em></li>
+<li><strong>before</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue before <em>central</em></li>
+<li><strong>central</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue for which the probability is calculated.</li>
+<li><strong>after</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue after <em>central</em></li>
 <li><strong>phi</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; phi angle</li>
 <li><strong>psi</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; psi angle</li>
 </ul>
@@ -449,9 +449,9 @@ standard amino acid</td>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>before</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue before <em>central</em></li>
-<li><strong>central</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue for which the probability is calculated.</li>
-<li><strong>after</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue after <em>central</em></li>
+<li><strong>before</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue before <em>central</em></li>
+<li><strong>central</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue for which the probability is calculated.</li>
+<li><strong>after</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; id of the residue after <em>central</em></li>
 <li><strong>psi</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; phi angle</li>
 <li><strong>phi</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; psi angle</li>
 </ul>
@@ -590,7 +590,7 @@ standard amino acid</td>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/modelling/algorithms.html b/doc/html/modelling/algorithms.html
index 2070e317cc6919e6a68be9f020fbbf14782dab0b..bbcc316494931d4b60b9c3bcbe702bf53fa1972b 100644
--- a/doc/html/modelling/algorithms.html
+++ b/doc/html/modelling/algorithms.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Modelling Algorithms &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Modelling Algorithms &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="modelling - Protein Modelling" href="index.html" />
     <link rel="next" title="sidechain - Sidechain Modelling" href="../sidechain/index.html" />
     <link rel="prev" title="Sidechain Reconstruction" href="sidechain_reconstruction.html" />
@@ -95,7 +95,7 @@ of the solutions</li>
 indices of the common subsets (rigid blocks) relative
 to the input <a class="reference internal" href="../loop/backbone.html#promod3.loop.BackboneList" title="promod3.loop.BackboneList"><code class="xref py py-class docutils literal"><span class="pre">promod3.loop.BackboneList</span></code></a> objects
 and the second element being a <code class="xref py py-class docutils literal"><span class="pre">list</span></code> of
-<a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat4" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Mat4</span></code></a> defining the transformations to
+<a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat4" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Mat4</span></code></a> defining the transformations to
 superpose the according positions in <strong>bb_list_one</strong>
 onto <strong>bb_list_two</strong></p>
 </td>
@@ -113,7 +113,7 @@ onto <strong>bb_list_two</strong></p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>aln</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.AlignmentHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.AlignmentHandle</span></code></a>) &#8211; An alignment with attached <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityView" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.EntityView</span></code></a>
+<li><strong>aln</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.AlignmentHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.AlignmentHandle</span></code></a>) &#8211; An alignment with attached <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityView" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.EntityView</span></code></a>
 objects from which the positions are extracted</li>
 <li><strong>seq_idx_one</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; The idx of the first sequence from which the CA
 positions will be extracted</li>
@@ -134,9 +134,9 @@ of the solutions</li>
 <tr class="field-even field"><th class="field-name">Returns:</th><td class="field-body"><p class="first last"><code class="xref py py-class docutils literal"><span class="pre">tuple</span></code> with the first element being a
 <code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <code class="xref py py-class docutils literal"><span class="pre">list</span></code> defining the
 column indices of the common subsets (rigid blocks)
-relative to the input <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.AlignmentHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.AlignmentHandle</span></code></a>
+relative to the input <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.AlignmentHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.AlignmentHandle</span></code></a>
 and the second element being a <code class="xref py py-class docutils literal"><span class="pre">list</span></code> of
-<a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat4" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Mat4</span></code></a> defining the transformations to
+<a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat4" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Mat4</span></code></a> defining the transformations to
 superpose the according positions from the first
 sequence onto the second sequence.</p>
 </td>
@@ -173,7 +173,7 @@ of the solutions</li>
 indices of the common subsets (rigid blocks) relative
 to the input <code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3List</span></code> objects
 and the second element being a <code class="xref py py-class docutils literal"><span class="pre">list</span></code> of
-<a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat4" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Mat4</span></code></a> defining the transformations to
+<a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat4" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Mat4</span></code></a> defining the transformations to
 superpose the according positions in <strong>pos_one</strong>
 onto <strong>pos_two</strong></p>
 </td>
@@ -236,8 +236,8 @@ Weird things are happening otherwise.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
-<li><strong>sequence</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>/<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceHandle</span></code></a>) &#8211; SEQRES for this chain</li>
-<li><strong>profile</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a>) &#8211; Sequence profile for this chain.</li>
+<li><strong>sequence</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>/<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceHandle</span></code></a>) &#8211; SEQRES for this chain</li>
+<li><strong>profile</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a>) &#8211; Sequence profile for this chain.</li>
 <li><strong>psipred_pred</strong> (<a class="reference internal" href="../loop/structure_db.html#promod3.loop.PsipredPrediction" title="promod3.loop.PsipredPrediction"><code class="xref py py-class docutils literal"><span class="pre">promod3.loop.PsipredPrediction</span></code></a>) &#8211; Psipred prediction for this chain.</li>
 <li><strong>fragment_length</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Length (num. residues) of fragments to be extracted.</li>
 <li><strong>fragments_per_position</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Number of fragments to be extracted at each
@@ -329,7 +329,7 @@ want to generate</li>
 <li><strong>avg_sampling_per_position</strong> &#8211; Number of Monte Carlo sampling steps
 the total number is: 
 len(<strong>sequence</strong>) * <strong>avg_sampling_per_position</strong></li>
-<li><strong>profile</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a>) &#8211; The sequence profile for <strong>sequence</strong>. This increases the 
+<li><strong>profile</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a>) &#8211; The sequence profile for <strong>sequence</strong>. This increases the 
 fragment search performance.</li>
 <li><strong>psipred_prediction</strong> (<a class="reference internal" href="../loop/structure_db.html#promod3.loop.PsipredPrediction" title="promod3.loop.PsipredPrediction"><code class="xref py py-class docutils literal"><span class="pre">promod3.loop.PsipredPrediction</span></code></a>) &#8211; The psipred prediction for <strong>sequence</strong>. This
 increases the fragment search performance</li>
@@ -360,6 +360,267 @@ with the keys of the scores in <strong>scorer</strong></li>
 </table>
 </dd></dl>
 
+</div>
+<div class="section" id="motif-finder">
+<h2>Motif Finder<a class="headerlink" href="#motif-finder" title="Permalink to this headline">¶</a></h2>
+<p>Distinct spatial arrangements of atoms or functional groups are key for protein
+function. For their detection, ProMod3 implements the MotifFinder algorithm
+which is based on geometric hashing as described by Nussinov and Wolfson
+<a class="reference internal" href="../references.html#nussinov1991" id="id1">[nussinov1991]</a>. The algorithm consists of a learning stage, a detection stage
+and a refinement stage.</p>
+<p>Learning Stage: A motif (query) is represented by a set of coordinates. Triplets
+(p1, p2, p3) of coordinates are selected that define triangles. For each
+triangle one can define an orthogonal vector basis
+(in our case v1 = norm(p2-p1), v3 = norm(cross(v1,p3-p1),
+v2 = norm(cross(v1,v3)))). For each coordinate not in [p1,p2,p3], we add the
+identity of the query/triangle as value to a hash map.
+The corresponding key consists of discretized values describing the edge lengths
+of the triangle, as well as the coordinate transformed into the triangle
+specific orthogonal vector basis. That&#8217;s 6 numbers in total.</p>
+<p>Detection Stage: The goal is to identify one or several subsets of target
+coordinates that resemble an input query.
+We first setup an accumulator containing a counter for each triangle observed
+in the input query. We then iterate over each possible triangle with vertices
+p1, p2 and p3 in the target coordinates. At the beginning of each iteration,
+all counters in the accumulator are set to zero. Again, we build a vector basis
+given that triangle and transform all coordinates not in [p1,p2,p3] into that
+vector space. For each transformed coordinate we obtain a key for the query hash
+map. If there is one or several values at that location in the hash map,
+we increment the corresponding locations in the accumulator.
+Once all coordinates are processed, we search for high counts in the
+accumulator. Given <em>N</em> query coordinates, we keep a solution for further
+refinement if count/(<em>N</em>-3) &gt;= <em>hash_tresh</em>. This is repeated until all
+triangles in the target are processed. One key problem with this approach is
+the discretization of floating point numbers that give raise to the hash map
+keys. Two extremely close values might end up in different bins just because
+they are close to the bin boundaries. For each of the 6 relevant numbers
+we estimate the actual bin as well as the closest neighbouring bin. Processing
+all possible combinations results in 64 hash map lookups instead of only one.</p>
+<p>Refinement Stage: Every potential solution identified in the detection stage is
+further refined based on the <em>distance_thresh</em> and <em>refine_thresh</em> parameters.
+A potential solution found in the detection stage is a pair of triangles, one
+in the query and one in the target, for which we find many matching coordinates
+in their respective vector space. We start with a coordinate mapping based on
+the triangle vertices from the query and the target (3 pairs).
+This coordinate mapping is iteratively updated by estimating the minimum RMSD
+superposition of the mapped query coordinates onto the target, apply that
+superposition on the query, find the closest target coordinate for each
+coordinate in the query and redo the mapping by including all pairs with
+minimum distance &lt; <em>distance_thresh</em>. Iteration stops if nothing changes
+anymore. The solution is returned to the user if the final fraction of mapped
+query coordinates is larger or equal <em>refine_thresh</em>.
+The larger the mapping, the more accurate the superposition. As we start with
+only the three triangle vertices, <em>distance_thresh</em> is doubled for the initial
+iteration.</p>
+<div class="highlight-default"><div class="highlight"><pre><span></span><span class="c1"># Example script that loads protein structures that contain ATP and</span>
+<span class="c1"># generates motif queries describing their binding pockets.</span>
+<span class="c1"># In a second step, those pockets are matched against a protein </span>
+<span class="c1"># structure that only contains an ATP analog. The ATP from every </span>
+<span class="c1"># match is transformed and stored to disk for further processing.</span>
+
+<span class="kn">from</span> <span class="nn">ost</span> <span class="k">import</span> <span class="n">io</span><span class="p">,</span> <span class="n">geom</span><span class="p">,</span> <span class="n">mol</span>
+<span class="kn">from</span> <span class="nn">promod3</span> <span class="k">import</span> <span class="n">modelling</span>
+
+<span class="n">files</span> <span class="o">=</span> <span class="p">[</span><span class="s1">&#39;data/1E2Q.pdb&#39;</span><span class="p">,</span> <span class="s1">&#39;data/1KO5.pdb&#39;</span><span class="p">,</span> <span class="s1">&#39;data/2IYW.pdb&#39;</span><span class="p">]</span>
+
+<span class="n">atp_list</span> <span class="o">=</span> <span class="nb">list</span><span class="p">()</span>
+<span class="n">query_list</span> <span class="o">=</span> <span class="nb">list</span><span class="p">()</span>
+
+<span class="k">for</span> <span class="n">f</span> <span class="ow">in</span> <span class="n">files</span><span class="p">:</span>
+
+    <span class="n">prot</span> <span class="o">=</span> <span class="n">io</span><span class="o">.</span><span class="n">LoadPDB</span><span class="p">(</span><span class="n">f</span><span class="p">)</span>
+    <span class="n">peptide_sel</span> <span class="o">=</span> <span class="n">prot</span><span class="o">.</span><span class="n">Select</span><span class="p">(</span><span class="s2">&quot;peptide=true&quot;</span><span class="p">)</span>
+    <span class="n">atp_sel</span> <span class="o">=</span> <span class="n">prot</span><span class="o">.</span><span class="n">Select</span><span class="p">(</span><span class="s2">&quot;rname=ATP&quot;</span><span class="p">)</span>
+
+    <span class="c1"># generate a single query for each ATP pocket</span>
+    <span class="k">for</span> <span class="n">atp_idx</span><span class="p">,</span> <span class="n">atp_r</span> <span class="ow">in</span> <span class="nb">enumerate</span><span class="p">(</span><span class="n">atp_sel</span><span class="o">.</span><span class="n">residues</span><span class="p">):</span>
+        <span class="n">pocket_view</span> <span class="o">=</span> <span class="n">peptide_sel</span><span class="o">.</span><span class="n">CreateEmptyView</span><span class="p">()</span>
+        <span class="k">for</span> <span class="n">atp_at</span> <span class="ow">in</span> <span class="n">atp_r</span><span class="o">.</span><span class="n">atoms</span><span class="p">:</span>
+            <span class="n">close_at</span> <span class="o">=</span> <span class="n">peptide_sel</span><span class="o">.</span><span class="n">FindWithin</span><span class="p">(</span><span class="n">atp_at</span><span class="o">.</span><span class="n">GetPos</span><span class="p">(),</span> <span class="mf">4.5</span><span class="p">)</span>
+            <span class="k">for</span> <span class="n">at</span> <span class="ow">in</span> <span class="n">close_at</span><span class="p">:</span>
+                <span class="n">r</span> <span class="o">=</span> <span class="n">at</span><span class="o">.</span><span class="n">handle</span><span class="o">.</span><span class="n">GetResidue</span><span class="p">()</span>
+                <span class="n">add_flag</span> <span class="o">=</span> <span class="n">mol</span><span class="o">.</span><span class="n">INCLUDE_ATOMS</span> <span class="o">|</span> <span class="n">mol</span><span class="o">.</span><span class="n">CHECK_DUPLICATES</span>
+                <span class="n">pocket_view</span><span class="o">.</span><span class="n">AddResidue</span><span class="p">(</span><span class="n">r</span><span class="p">,</span> <span class="n">add_flag</span><span class="p">)</span>
+
+        <span class="n">ca_positions</span> <span class="o">=</span> <span class="n">geom</span><span class="o">.</span><span class="n">Vec3List</span><span class="p">()</span>
+        <span class="k">for</span> <span class="n">res</span> <span class="ow">in</span> <span class="n">pocket_view</span><span class="o">.</span><span class="n">residues</span><span class="p">:</span>
+            <span class="n">ca_positions</span><span class="o">.</span><span class="n">append</span><span class="p">(</span><span class="n">res</span><span class="o">.</span><span class="n">FindAtom</span><span class="p">(</span><span class="s2">&quot;CA&quot;</span><span class="p">)</span><span class="o">.</span><span class="n">GetPos</span><span class="p">())</span>
+        <span class="n">i</span> <span class="o">=</span> <span class="s2">&quot;</span><span class="si">%s</span><span class="s2">_</span><span class="si">%i</span><span class="s2">&quot;</span><span class="o">%</span><span class="p">(</span><span class="n">f</span><span class="p">,</span> <span class="n">atp_idx</span><span class="p">)</span>
+        <span class="n">query</span> <span class="o">=</span> <span class="n">modelling</span><span class="o">.</span><span class="n">MotifQuery</span><span class="p">(</span><span class="n">ca_positions</span><span class="p">,</span> <span class="n">i</span><span class="p">,</span> <span class="mf">4.0</span><span class="p">,</span> <span class="mf">9.0</span><span class="p">,</span> <span class="mf">1.0</span><span class="p">)</span>
+        <span class="n">query_list</span><span class="o">.</span><span class="n">append</span><span class="p">(</span><span class="n">query</span><span class="p">)</span>
+     
+        <span class="c1"># create an entity from atp for later use</span>
+        <span class="n">atp_view</span> <span class="o">=</span> <span class="n">prot</span><span class="o">.</span><span class="n">CreateEmptyView</span><span class="p">()</span>
+        <span class="n">atp_view</span><span class="o">.</span><span class="n">AddResidue</span><span class="p">(</span><span class="n">atp_r</span><span class="p">,</span> <span class="n">mol</span><span class="o">.</span><span class="n">INCLUDE_ATOMS</span><span class="p">)</span>
+        <span class="n">atp_list</span><span class="o">.</span><span class="n">append</span><span class="p">(</span><span class="n">mol</span><span class="o">.</span><span class="n">CreateEntityFromView</span><span class="p">(</span><span class="n">atp_view</span><span class="p">,</span> <span class="kc">True</span><span class="p">))</span>
+
+<span class="c1"># That&#39;s it, let&#39;s combine the single queries</span>
+<span class="n">full_query</span> <span class="o">=</span> <span class="n">modelling</span><span class="o">.</span><span class="n">MotifQuery</span><span class="p">(</span><span class="n">query_list</span><span class="p">)</span>
+
+<span class="n">prot</span> <span class="o">=</span> <span class="n">io</span><span class="o">.</span><span class="n">LoadPDB</span><span class="p">(</span><span class="s2">&quot;data/1AKE.pdb&quot;</span><span class="p">)</span>
+<span class="n">peptide_sel</span> <span class="o">=</span> <span class="n">prot</span><span class="o">.</span><span class="n">Select</span><span class="p">(</span><span class="s2">&quot;peptide=true&quot;</span><span class="p">)</span>
+<span class="n">ca_positions</span> <span class="o">=</span> <span class="n">geom</span><span class="o">.</span><span class="n">Vec3List</span><span class="p">()</span>
+<span class="k">for</span> <span class="n">r</span> <span class="ow">in</span> <span class="n">peptide_sel</span><span class="o">.</span><span class="n">residues</span><span class="p">:</span>
+    <span class="n">ca_positions</span><span class="o">.</span><span class="n">append</span><span class="p">(</span><span class="n">r</span><span class="o">.</span><span class="n">FindAtom</span><span class="p">(</span><span class="s2">&quot;CA&quot;</span><span class="p">)</span><span class="o">.</span><span class="n">GetPos</span><span class="p">())</span>
+
+<span class="c1"># search all matches, fetch the corresponding atps,</span>
+<span class="c1"># transform them onto the 1ake binding site and dump them to disk</span>
+<span class="n">matches</span> <span class="o">=</span> <span class="n">modelling</span><span class="o">.</span><span class="n">FindMotifs</span><span class="p">(</span><span class="n">full_query</span><span class="p">,</span> <span class="n">ca_positions</span><span class="p">)</span>
+<span class="k">for</span> <span class="n">m_idx</span><span class="p">,</span> <span class="n">m</span> <span class="ow">in</span> <span class="nb">enumerate</span><span class="p">(</span><span class="n">matches</span><span class="p">):</span>
+    <span class="n">atp</span> <span class="o">=</span> <span class="n">atp_list</span><span class="p">[</span><span class="n">m</span><span class="o">.</span><span class="n">query_idx</span><span class="p">]</span><span class="o">.</span><span class="n">Copy</span><span class="p">()</span>
+    <span class="n">atp</span><span class="o">.</span><span class="n">EditXCS</span><span class="p">()</span><span class="o">.</span><span class="n">ApplyTransform</span><span class="p">(</span><span class="n">m</span><span class="o">.</span><span class="n">mat</span><span class="p">)</span>
+    <span class="n">io</span><span class="o">.</span><span class="n">SavePDB</span><span class="p">(</span><span class="n">atp</span><span class="p">,</span> <span class="s2">&quot;m_</span><span class="si">%i</span><span class="s2">.pdb&quot;</span><span class="o">%</span><span class="p">(</span><span class="n">m_idx</span><span class="p">))</span>
+
+</pre></div>
+</div>
+<dl class="class">
+<dt id="promod3.modelling.MotifQuery">
+<em class="property">class </em><code class="descclassname">promod3.modelling.</code><code class="descname">MotifQuery</code><span class="sig-paren">(</span><em>positions</em>, <em>identifier</em>, <em>min_triangle_edge_length</em>, <em>max_triangle_edge_length</em>, <em>bin_size</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.modelling.MotifQuery" title="Permalink to this definition">¶</a></dt>
+<dt>
+<em class="property">class </em><code class="descclassname">promod3.modelling.</code><code class="descname">MotifQuery</code><span class="sig-paren">(</span><em>positions</em>, <em>identifier</em>, <em>min_triangle_edge_length</em>, <em>max_triangle_edge_length</em>, <em>bin_size</em>, <em>flags</em><span class="sig-paren">)</span></dt>
+<dt>
+<em class="property">class </em><code class="descclassname">promod3.modelling.</code><code class="descname">MotifQuery</code><span class="sig-paren">(</span><em>query_list</em><span class="sig-paren">)</span></dt>
+<dd><p>A single query or a container of queries.
+The constructor performs the learning stage of a single query or combines
+several queries, so they can be searched at once.</p>
+<table class="docutils field-list" frame="void" rules="none">
+<col class="field-name" />
+<col class="field-body" />
+<tbody valign="top">
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
+<li><strong>positions</strong> (<code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3List</span></code>) &#8211; Coordinates of the query</li>
+<li><strong>identifier</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; Descriptor of the query</li>
+<li><strong>min_triangle_edge_length</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; To avoid the full O(n^3) hell, triangles
+with any edge length below <em>min_triangle_edge_length</em>
+are skipped</li>
+<li><strong>max_triangle_edge_length</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; Same as <em>min_triangle_edge_length</em> but
+upper bound</li>
+<li><strong>bin_size</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; Bin size in A, relevant to generate hash map keys</li>
+<li><strong>flags</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Flag in range [0,63] for every coordinate in <em>positions</em>.
+They&#8217;re also added to the hash map keys (default: 0).
+This means that additionally to having a matching
+relative position, the coordinates must also have a
+matching flag in the detection/refinement stage.
+If not provided (in the query and in the search),
+only coordinates matter.</li>
+<li><strong>query_list</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference internal" href="#promod3.modelling.MotifQuery" title="promod3.modelling.MotifQuery"><code class="xref py py-class docutils literal"><span class="pre">MotifQuery</span></code></a>) &#8211; E pluribus unum</li>
+</ul>
+</td>
+</tr>
+</tbody>
+</table>
+<dl class="method">
+<dt id="promod3.modelling.MotifQuery.Save">
+<code class="descname">Save</code><span class="sig-paren">(</span><em>filename</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.modelling.MotifQuery.Save" title="Permalink to this definition">¶</a></dt>
+<dd><p>Saves the query down to disk</p>
+<table class="docutils field-list" frame="void" rules="none">
+<col class="field-name" />
+<col class="field-body" />
+<tbody valign="top">
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>filename</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; filename</td>
+</tr>
+</tbody>
+</table>
+</dd></dl>
+
+<dl class="staticmethod">
+<dt id="promod3.modelling.MotifQuery.Load">
+<em class="property">static </em><code class="descname">Load</code><span class="sig-paren">(</span><em>filename</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.modelling.MotifQuery.Load" title="Permalink to this definition">¶</a></dt>
+<dd><p>Load query from disk</p>
+<table class="docutils field-list" frame="void" rules="none">
+<col class="field-name" />
+<col class="field-body" />
+<tbody valign="top">
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>filename</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; filename</td>
+</tr>
+</tbody>
+</table>
+</dd></dl>
+
+<dl class="method">
+<dt id="promod3.modelling.MotifQuery.GetPositions">
+<code class="descname">GetPositions</code><span class="sig-paren">(</span><em>query_idx</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.modelling.MotifQuery.GetPositions" title="Permalink to this definition">¶</a></dt>
+<dd><p>Returns coordinates of specified query</p>
+<table class="docutils field-list" frame="void" rules="none">
+<col class="field-name" />
+<col class="field-body" />
+<tbody valign="top">
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>query_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Query from which you want the positions</td>
+</tr>
+</tbody>
+</table>
+</dd></dl>
+
+<dl class="method">
+<dt id="promod3.modelling.MotifQuery.GetIdentifiers">
+<code class="descname">GetIdentifiers</code><span class="sig-paren">(</span><span class="sig-paren">)</span><a class="headerlink" href="#promod3.modelling.MotifQuery.GetIdentifiers" title="Permalink to this definition">¶</a></dt>
+<dd><p>Returns a list of all query identifiers.</p>
+</dd></dl>
+
+<dl class="method">
+<dt id="promod3.modelling.MotifQuery.GetN">
+<code class="descname">GetN</code><span class="sig-paren">(</span><span class="sig-paren">)</span><a class="headerlink" href="#promod3.modelling.MotifQuery.GetN" title="Permalink to this definition">¶</a></dt>
+<dd><p>Returns the number of queries</p>
+</dd></dl>
+
+</dd></dl>
+
+<dl class="class">
+<dt id="promod3.modelling.MotifMatch">
+<em class="property">class </em><code class="descclassname">promod3.modelling.</code><code class="descname">MotifMatch</code><a class="headerlink" href="#promod3.modelling.MotifMatch" title="Permalink to this definition">¶</a></dt>
+<dd><p>Object that holds information about a match found in <a class="reference internal" href="#promod3.modelling.FindMotifs" title="promod3.modelling.FindMotifs"><code class="xref py py-meth docutils literal"><span class="pre">FindMotifs()</span></code></a></p>
+<dl class="attribute">
+<dt id="promod3.modelling.MotifMatch.query_idx">
+<code class="descname">query_idx</code><a class="headerlink" href="#promod3.modelling.MotifMatch.query_idx" title="Permalink to this definition">¶</a></dt>
+<dd><p>Index of matching query</p>
+</dd></dl>
+
+<dl class="attribute">
+<dt id="promod3.modelling.MotifMatch.mat">
+<code class="descname">mat</code><a class="headerlink" href="#promod3.modelling.MotifMatch.mat" title="Permalink to this definition">¶</a></dt>
+<dd><p>Transformation matrix to superpose matching query onto target</p>
+</dd></dl>
+
+<dl class="attribute">
+<dt id="promod3.modelling.MotifMatch.alignment">
+<code class="descname">alignment</code><a class="headerlink" href="#promod3.modelling.MotifMatch.alignment" title="Permalink to this definition">¶</a></dt>
+<dd><p>List of tuples which define matching pairs of query/target coordinates</p>
+</dd></dl>
+
+</dd></dl>
+
+<dl class="method">
+<dt id="promod3.modelling.FindMotifs">
+<code class="descclassname">promod3.modelling.</code><code class="descname">FindMotifs</code><span class="sig-paren">(</span><em>query</em>, <em>target_positions</em>, <em>hash_tresh=0.4</em>, <em>distance_thresh=1.0</em>, <em>refine_thresh=0.7</em>, <em>flags=list()</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.modelling.FindMotifs" title="Permalink to this definition">¶</a></dt>
+<dd><p>Performs the detection and refinement stages of the geometric hashing
+algorithm.</p>
+<table class="docutils field-list" frame="void" rules="none">
+<col class="field-name" />
+<col class="field-body" />
+<tbody valign="top">
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
+<li><strong>query</strong> &#8211; Query to be searched</li>
+<li><strong>target_positions</strong> &#8211; Coordinates of the target</li>
+<li><strong>hash_thresh</strong> &#8211; Parameter relevant for detection stage</li>
+<li><strong>distance_thresh</strong> &#8211; Parameter relevant for refinement stage</li>
+<li><strong>refine_thresh</strong> &#8211; Parameter relevant for refinement stage</li>
+<li><strong>flags</strong> &#8211; Equivalent to <em>flags</em> in <a class="reference internal" href="#promod3.modelling.MotifQuery" title="promod3.modelling.MotifQuery"><code class="xref py py-class docutils literal"><span class="pre">MotifQuery</span></code></a>
+constructor. If you didn&#8217;t provide anything there,
+this can be ignored. Only the actual coordinates
+matter in this case.</li>
+</ul>
+</td>
+</tr>
+<tr class="field-even field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">All found matches</p>
+</td>
+</tr>
+<tr class="field-odd field"><th class="field-name">Return type:</th><td class="field-body"><p class="first last"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference internal" href="#promod3.modelling.MotifMatch" title="promod3.modelling.MotifMatch"><code class="xref py py-class docutils literal"><span class="pre">MotifMatch</span></code></a></p>
+</td>
+</tr>
+</tbody>
+</table>
+</dd></dl>
+
 </div>
 </div>
 
@@ -374,6 +635,7 @@ with the keys of the scores in <strong>scorer</strong></li>
 <li><a class="reference internal" href="#">Modelling Algorithms</a><ul>
 <li><a class="reference internal" href="#rigid-blocks">Rigid Blocks</a></li>
 <li><a class="reference internal" href="#de-novo-modelling">De Novo Modelling</a></li>
+<li><a class="reference internal" href="#motif-finder">Motif Finder</a></li>
 </ul>
 </li>
 </ul>
@@ -412,7 +674,7 @@ with the keys of the scores in <strong>scorer</strong></li>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/modelling/gap_handling.html b/doc/html/modelling/gap_handling.html
index 5d52d66e2f53f35fe5e372accb51963bceef9d14..856ed3a388cb7915ae2d01dab313469d5e6c2824 100644
--- a/doc/html/modelling/gap_handling.html
+++ b/doc/html/modelling/gap_handling.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Handling Gaps &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Handling Gaps &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="modelling - Protein Modelling" href="index.html" />
     <link rel="next" title="Handling Loop Candidates" href="loop_candidates.html" />
     <link rel="prev" title="Model Checking" href="model_checking.html" />
@@ -61,8 +61,8 @@ invalid residue handles to <cite>before</cite> or <cite>after</cite>.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>before</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Fills <a class="reference internal" href="#promod3.modelling.StructuralGap.before" title="promod3.modelling.StructuralGap.before"><code class="xref py py-attr docutils literal"><span class="pre">before</span></code></a></li>
-<li><strong>after</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Fills <a class="reference internal" href="#promod3.modelling.StructuralGap.after" title="promod3.modelling.StructuralGap.after"><code class="xref py py-attr docutils literal"><span class="pre">after</span></code></a></li>
+<li><strong>before</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Fills <a class="reference internal" href="#promod3.modelling.StructuralGap.before" title="promod3.modelling.StructuralGap.before"><code class="xref py py-attr docutils literal"><span class="pre">before</span></code></a></li>
+<li><strong>after</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Fills <a class="reference internal" href="#promod3.modelling.StructuralGap.after" title="promod3.modelling.StructuralGap.after"><code class="xref py py-attr docutils literal"><span class="pre">after</span></code></a></li>
 <li><strong>seq</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; Fills <a class="reference internal" href="#promod3.modelling.StructuralGap.seq" title="promod3.modelling.StructuralGap.seq"><code class="xref py py-attr docutils literal"><span class="pre">seq</span></code></a></li>
 </ul>
 </td>
@@ -117,7 +117,7 @@ are valid and:</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">Chain, the gap is belonging to</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ChainHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ChainHandle</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ChainHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ChainHandle</span></code></a></td>
 </tr>
 </tbody>
 </table>
@@ -268,13 +268,13 @@ extend the gap past another gap.</p>
 <dl class="attribute">
 <dt id="promod3.modelling.StructuralGap.before">
 <code class="descname">before</code><a class="headerlink" href="#promod3.modelling.StructuralGap.before" title="Permalink to this definition">¶</a></dt>
-<dd><p>Residue before the gap (read-only, <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>)</p>
+<dd><p>Residue before the gap (read-only, <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>)</p>
 </dd></dl>
 
 <dl class="attribute">
 <dt id="promod3.modelling.StructuralGap.after">
 <code class="descname">after</code><a class="headerlink" href="#promod3.modelling.StructuralGap.after" title="Permalink to this definition">¶</a></dt>
-<dd><p>Residue after the gap (read-only, <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>)</p>
+<dd><p>Residue after the gap (read-only, <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>)</p>
 </dd></dl>
 
 <dl class="attribute">
@@ -319,7 +319,7 @@ False if no new extension possible.</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>gap</strong> (<a class="reference internal" href="#promod3.modelling.StructuralGap" title="promod3.modelling.StructuralGap"><code class="xref py py-class docutils literal"><span class="pre">StructuralGap</span></code></a>) &#8211; The gap which will be extended by <a class="reference internal" href="#promod3.modelling.GapExtender.Extend" title="promod3.modelling.GapExtender.Extend"><code class="xref py py-meth docutils literal"><span class="pre">Extend()</span></code></a>.</li>
-<li><strong>seqres</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceHandle</span></code></a>) &#8211; The full sequence of the chain, the gap is associated with.</li>
+<li><strong>seqres</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceHandle</span></code></a>) &#8211; The full sequence of the chain, the gap is associated with.</li>
 </ul>
 </td>
 </tr>
@@ -360,7 +360,7 @@ valid termini.</td>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>gap</strong> (<a class="reference internal" href="#promod3.modelling.StructuralGap" title="promod3.modelling.StructuralGap"><code class="xref py py-class docutils literal"><span class="pre">StructuralGap</span></code></a>) &#8211; The gap which will be extended by <a class="reference internal" href="#promod3.modelling.FullGapExtender.Extend" title="promod3.modelling.FullGapExtender.Extend"><code class="xref py py-meth docutils literal"><span class="pre">Extend()</span></code></a>.</li>
-<li><strong>seqres</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceHandle</span></code></a>) &#8211; The full sequence of the chain, the gap is associated with.</li>
+<li><strong>seqres</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceHandle</span></code></a>) &#8211; The full sequence of the chain, the gap is associated with.</li>
 <li><strong>max_length</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; <ul>
 <li>If -1, all possible non-terminal gaps are returned.</li>
 <li>If &gt;= 0, this restricts the max. gap-length
@@ -413,7 +413,7 @@ score = num_gap_extensions * <cite>extension_penalty</cite> + sum( <cite>penalti
 <li><strong>gap</strong> (<a class="reference internal" href="#promod3.modelling.StructuralGap" title="promod3.modelling.StructuralGap"><code class="xref py py-class docutils literal"><span class="pre">StructuralGap</span></code></a>) &#8211; The gap which will be extended by <a class="reference internal" href="#promod3.modelling.ScoringGapExtender.Extend" title="promod3.modelling.ScoringGapExtender.Extend"><code class="xref py py-meth docutils literal"><span class="pre">Extend()</span></code></a>.</li>
 <li><strong>extension_penalty</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; Penalty for length of gap.</li>
 <li><strong>penalties</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; Penalty for each residue added to gap.</li>
-<li><strong>seqres</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceHandle</span></code></a>) &#8211; The full sequence of the chain, the gap is associated with.</li>
+<li><strong>seqres</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceHandle</span></code></a>) &#8211; The full sequence of the chain, the gap is associated with.</li>
 <li><strong>max_length</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; <ul>
 <li>If -2, <a class="reference internal" href="#promod3.modelling.GapExtender" title="promod3.modelling.GapExtender"><code class="xref py py-class docutils literal"><span class="pre">GapExtender</span></code></a> is used instead of <a class="reference internal" href="#promod3.modelling.FullGapExtender" title="promod3.modelling.FullGapExtender"><code class="xref py py-class docutils literal"><span class="pre">FullGapExtender</span></code></a>
 (i.e. it stops at gaps and termini).</li>
@@ -653,7 +653,7 @@ gaps of different chains or an N-terminal gap with a C-terminal gap.</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/modelling/index.html b/doc/html/modelling/index.html
index d23c5cba75446f74ed5ef10605a6c07b8e44f214..4d1d100b5b554a0b27e792d8f223784866bc4aac 100644
--- a/doc/html/modelling/index.html
+++ b/doc/html/modelling/index.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>modelling - Protein Modelling &mdash; ProMod3 2.0.0 documentation</title>
+    <title>modelling - Protein Modelling &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="Documentation For Users" href="../users.html" />
     <link rel="next" title="Modelling Pipeline" href="pipeline.html" />
     <link rel="prev" title="Singularity" href="../container/singularity.html" />
@@ -114,6 +114,7 @@ a model fully automatically as follows:</p>
 <li class="toctree-l1"><a class="reference internal" href="algorithms.html">Modelling Algorithms</a><ul>
 <li class="toctree-l2"><a class="reference internal" href="algorithms.html#rigid-blocks">Rigid Blocks</a></li>
 <li class="toctree-l2"><a class="reference internal" href="algorithms.html#de-novo-modelling">De Novo Modelling</a></li>
+<li class="toctree-l2"><a class="reference internal" href="algorithms.html#motif-finder">Motif Finder</a></li>
 </ul>
 </li>
 </ul>
@@ -158,7 +159,7 @@ a model fully automatically as follows:</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/modelling/loop_candidates.html b/doc/html/modelling/loop_candidates.html
index 2c2ed901ea6407d3f0c1662efa8e1052550ff6e1..82e51fce4011104f6a35012c2e1d73417da3b4b4 100644
--- a/doc/html/modelling/loop_candidates.html
+++ b/doc/html/modelling/loop_candidates.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Handling Loop Candidates &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Handling Loop Candidates &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="modelling - Protein Modelling" href="index.html" />
     <link rel="next" title="Fitting Loops Into Gaps" href="loop_closing.html" />
     <link rel="prev" title="Handling Gaps" href="gap_handling.html" />
@@ -133,8 +133,8 @@ a fragment database.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; The residue at the N-terminal end of the loop</li>
-<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; The residue at the C-terminal end of the loop</li>
+<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; The residue at the N-terminal end of the loop</li>
+<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; The residue at the C-terminal end of the loop</li>
 <li><strong>seq</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; The sequence of residues to be added including the
 <em>n_stem</em> and <em>c_stem</em></li>
 <li><strong>frag_db</strong> (<a class="reference internal" href="../loop/structure_db.html#promod3.loop.FragDB" title="promod3.loop.FragDB"><code class="xref py py-class docutils literal"><span class="pre">FragDB</span></code></a>) &#8211; The fragment database</li>
@@ -245,9 +245,9 @@ not depending on a metropolis criterium.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue defining the n-stem positions every candidate
+<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue defining the n-stem positions every candidate
 should match. See <a class="reference internal" href="loop_closing.html#promod3.modelling.CCD.CCD" title="promod3.modelling.CCD.CCD"><code class="xref py py-meth docutils literal"><span class="pre">CCD()</span></code></a>.</li>
-<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue defining the c-stem positions every candidate
+<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue defining the c-stem positions every candidate
 should match. See <a class="reference internal" href="loop_closing.html#promod3.modelling.CCD.CCD" title="promod3.modelling.CCD.CCD"><code class="xref py py-meth docutils literal"><span class="pre">CCD()</span></code></a>.</li>
 <li><strong>torsion_sampler</strong> (<a class="reference internal" href="../loop/torsion_sampler.html#promod3.loop.TorsionSampler" title="promod3.loop.TorsionSampler"><code class="xref py py-class docutils literal"><span class="pre">TorsionSampler</span></code></a> / <code class="xref py py-class docutils literal"><span class="pre">list</span></code>
 of <a class="reference internal" href="../loop/torsion_sampler.html#promod3.loop.TorsionSampler" title="promod3.loop.TorsionSampler"><code class="xref py py-class docutils literal"><span class="pre">TorsionSampler</span></code></a>) &#8211; A torsion sampler (used for all residues) or a list
@@ -289,9 +289,9 @@ candidate. This leads to an increase in number of loops.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue defining the n-stem positions every candidate
+<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue defining the n-stem positions every candidate
 should match</li>
-<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue defining the c-stem positions every candidate
+<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue defining the c-stem positions every candidate
 should match</li>
 <li><strong>pivot_one</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; First pivot residue</li>
 <li><strong>pivot_two</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Second pivot residue</li>
@@ -365,7 +365,7 @@ anything is raised when calculating the scores.</p>
 <code class="descname">CalculateStructureProfileScores</code><span class="sig-paren">(</span><em>score_container</em>, <em>structure_db</em>, <em>prof</em>, <em>offset=0</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.modelling.LoopCandidates.CalculateStructureProfileScores" title="Permalink to this definition">¶</a></dt>
 <dd><p>Calculates a score comparing the given profile <em>prof</em> starting at <em>offset</em>
 with the sequence / structure profile of each candidate as extracted from
-<em>structure_db</em> (see <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle.GetAverageScore" title="(in OpenStructure v1.9.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.seq.ProfileHandle.GetAverageScore()</span></code></a> for
+<em>structure_db</em> (see <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle.GetAverageScore" title="(in OpenStructure v1.10.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.seq.ProfileHandle.GetAverageScore()</span></code></a> for
 details, <em>prof.null_model</em> is used for weighting).</p>
 <p>Note that for profile scores a higher &#8220;score&#8221; is better! So take care when
 combining this to other scores, where it is commonly the other way around.</p>
@@ -381,7 +381,7 @@ with this DB).</p>
 <li><strong>score_container</strong> (<a class="reference internal" href="#promod3.modelling.ScoreContainer" title="promod3.modelling.ScoreContainer"><code class="xref py py-class docutils literal"><span class="pre">ScoreContainer</span></code></a>) &#8211; Add scores to this score container using the default
 key name defined in <a class="reference internal" href="#promod3.modelling.ScoringWeights" title="promod3.modelling.ScoringWeights"><code class="xref py py-class docutils literal"><span class="pre">ScoringWeights</span></code></a></li>
 <li><strong>structural_db</strong> (<a class="reference internal" href="../loop/structure_db.html#promod3.loop.StructureDB" title="promod3.loop.StructureDB"><code class="xref py py-class docutils literal"><span class="pre">StructureDB</span></code></a>) &#8211; Structural database used in <a class="reference internal" href="#promod3.modelling.LoopCandidates.FillFromDatabase" title="promod3.modelling.LoopCandidates.FillFromDatabase"><code class="xref py py-meth docutils literal"><span class="pre">FillFromDatabase()</span></code></a></li>
-<li><strong>prof</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a>) &#8211; Profile information for target.</li>
+<li><strong>prof</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a>) &#8211; Profile information for target.</li>
 <li><strong>offset</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Loop starts at index <em>offset</em> in <em>prof</em>.</li>
 </ul>
 </td>
@@ -413,8 +413,8 @@ positions and the corresponding atoms in <em>c_stem</em>.</p>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>score_container</strong> (<a class="reference internal" href="#promod3.modelling.ScoreContainer" title="promod3.modelling.ScoreContainer"><code class="xref py py-class docutils literal"><span class="pre">ScoreContainer</span></code></a>) &#8211; Add scores to this score container using the default
 key name defined in <a class="reference internal" href="#promod3.modelling.ScoringWeights" title="promod3.modelling.ScoringWeights"><code class="xref py py-class docutils literal"><span class="pre">ScoringWeights</span></code></a></li>
-<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; The residue at the N-terminal end of the loop.</li>
-<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; The residue at the C-terminal end of the loop.</li>
+<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; The residue at the N-terminal end of the loop.</li>
+<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; The residue at the C-terminal end of the loop.</li>
 </ul>
 </td>
 </tr>
@@ -1140,7 +1140,7 @@ scoring routines, <a class="reference internal" href="#promod3.modelling.ScoreCo
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/modelling/loop_closing.html b/doc/html/modelling/loop_closing.html
index b80eab62447dcba8e7a6a7fce292eb359a5eb063..7c104e3051826856a67092851e155c422174f8a3 100644
--- a/doc/html/modelling/loop_closing.html
+++ b/doc/html/modelling/loop_closing.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Fitting Loops Into Gaps &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Fitting Loops Into Gaps &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="modelling - Protein Modelling" href="index.html" />
     <link rel="next" title="Generating Loops De Novo" href="monte_carlo.html" />
     <link rel="prev" title="Handling Loop Candidates" href="loop_candidates.html" />
@@ -84,11 +84,11 @@ to avoid moving into unfavourable regions of the backbone dihedrals.</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>sequence</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; Sequence of the backbones to be closed</li>
-<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue defining the n_stem.
+<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue defining the n_stem.
 If the residue before <em>n_stem</em> doesn&#8217;t exist, the
 torsion sampler will use a default residue (ALA) and
 and phi angle (-1.0472) to evaluate the first angle.</li>
-<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue defining the c_stem.
+<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue defining the c_stem.
 If the residue after <em>c_stem</em> doesn&#8217;t exist, the
 torsion sampler will use a default residue (ALA) and
 psi angle (-0.7854) to evaluate the last angle.</li>
@@ -125,8 +125,8 @@ This is faster but might lead to weird backbone dihedral pairs.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
-<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue defining the n_stem</li>
-<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue defining the c_stem</li>
+<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue defining the n_stem</li>
+<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue defining the c_stem</li>
 <li><strong>max_steps</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Maximal number of iterations</li>
 <li><strong>rmsd_cutoff</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; The algorithm stops as soon as the c_stem of the loop to
 be  closed has RMSD below the given <em>c_stem</em></li>
@@ -327,7 +327,7 @@ size or sequence as the initial one.</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Idx of residue</li>
-<li><strong>pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; Restraint Position (in Angstrom)</li>
+<li><strong>pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; Restraint Position (in Angstrom)</li>
 <li><strong>force_constant</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; Force constant in kJ/mol/nm^2</li>
 </ul>
 </td>
@@ -349,7 +349,7 @@ size or sequence as the initial one.</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Idx of residue</li>
-<li><strong>pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; Restraint Position (in Angstrom)</li>
+<li><strong>pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; Restraint Position (in Angstrom)</li>
 <li><strong>force_constant</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; Force constant in kJ/mol/nm^2</li>
 </ul>
 </td>
@@ -372,7 +372,7 @@ doesn&#8217;t do anything if specified residue is a glycine</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Idx of residue</li>
-<li><strong>pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; Restraint Position (in Angstrom)</li>
+<li><strong>pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; Restraint Position (in Angstrom)</li>
 <li><strong>force_constant</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; Force constant in kJ/mol/nm^2</li>
 </ul>
 </td>
@@ -394,7 +394,7 @@ doesn&#8217;t do anything if specified residue is a glycine</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Idx of residue</li>
-<li><strong>pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; Restraint Position (in Angstrom)</li>
+<li><strong>pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; Restraint Position (in Angstrom)</li>
 <li><strong>force_constant</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; Force constant in kJ/mol/nm^2</li>
 </ul>
 </td>
@@ -416,7 +416,7 @@ doesn&#8217;t do anything if specified residue is a glycine</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Idx of residue</li>
-<li><strong>pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; Restraint Position (in Angstrom)</li>
+<li><strong>pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; Restraint Position (in Angstrom)</li>
 <li><strong>force_constant</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; Force constant in kJ/mol/nm^2</li>
 </ul>
 </td>
@@ -643,7 +643,7 @@ the one given in the constructor.</td>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/modelling/model_checking.html b/doc/html/modelling/model_checking.html
index 7c4a7a84be245178429a9b27b181b29da09d76a2..b944116fa0366bf0023ddaa88572d819f5cd94f3 100644
--- a/doc/html/modelling/model_checking.html
+++ b/doc/html/modelling/model_checking.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Model Checking &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Model Checking &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="modelling - Protein Modelling" href="index.html" />
     <link rel="next" title="Handling Gaps" href="gap_handling.html" />
     <link rel="prev" title="Modelling Pipeline" href="pipeline.html" />
@@ -58,14 +58,14 @@ three of the atoms exist (center and radii are estimated then).</p>
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>ent</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">EntityHandle</span></code></a> or <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityView" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">EntityView</span></code></a>) &#8211; Structure for which to detect rings.</td>
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>ent</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">EntityHandle</span></code></a> or <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityView" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">EntityView</span></code></a>) &#8211; Structure for which to detect rings.</td>
 </tr>
 <tr class="field-even field"><th class="field-name">Returns:</th><td class="field-body"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of rings to perform ring checks. Each ring is a named
 tuple with:
-center (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>),
-plane (<a class="reference external" href="https://www.openstructure.org/docs/geom/composite/#ost.geom.Plane" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Plane</span></code></a>),
+center (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Vec3</span></code></a>),
+plane (<a class="reference external" href="https://www.openstructure.org/docs/geom/composite/#ost.geom.Plane" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Plane</span></code></a>),
 radius (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>),
-residue (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ResidueHandle</span></code></a>).</td>
+residue (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ResidueHandle</span></code></a>).</td>
 </tr>
 </tbody>
 </table>
@@ -81,11 +81,11 @@ residue (<a class="reference external" href="https://www.openstructure.org/docs/
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>rings</strong> &#8211; List of rings as provided by <a class="reference internal" href="#promod3.modelling.GetRings" title="promod3.modelling.GetRings"><code class="xref py py-func docutils literal"><span class="pre">GetRings()</span></code></a>.</li>
-<li><strong>ent</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">EntityHandle</span></code></a> or <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityView" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">EntityView</span></code></a>) &#8211; Structure for which to detect punches.</li>
+<li><strong>ent</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">EntityHandle</span></code></a> or <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityView" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">EntityView</span></code></a>) &#8211; Structure for which to detect punches.</li>
 </ul>
 </td>
 </tr>
-<tr class="field-even field"><th class="field-name">Returns:</th><td class="field-body"><p class="first last"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of residues (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ResidueHandle</span></code></a>) which
+<tr class="field-even field"><th class="field-name">Returns:</th><td class="field-body"><p class="first last"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of residues (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ResidueHandle</span></code></a>) which
 have a punched ring.</p>
 </td>
 </tr>
@@ -104,7 +104,7 @@ This check is faster than using <a class="reference internal" href="#promod3.mod
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>rings</strong> &#8211; List of rings as provided by <a class="reference internal" href="#promod3.modelling.GetRings" title="promod3.modelling.GetRings"><code class="xref py py-func docutils literal"><span class="pre">GetRings()</span></code></a>.</li>
-<li><strong>ent</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">EntityHandle</span></code></a> or <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityView" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">EntityView</span></code></a>) &#8211; Structure for which to detect punches.</li>
+<li><strong>ent</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">EntityHandle</span></code></a> or <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityView" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">EntityView</span></code></a>) &#8211; Structure for which to detect punches.</li>
 </ul>
 </td>
 </tr>
@@ -129,7 +129,7 @@ This check is faster than using <a class="reference internal" href="#promod3.mod
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
 <li><strong>candidates</strong> (<code class="xref py py-class docutils literal"><span class="pre">LoopCandidates</span></code>) &#8211; Loop candidates meant to fill <em>gap</em> within <em>model</em>.
 Offending candidates are removed from this list.</li>
-<li><strong>model</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">EntityHandle</span></code></a>) &#8211; Model for which loop is to be filled.</li>
+<li><strong>model</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">EntityHandle</span></code></a>) &#8211; Model for which loop is to be filled.</li>
 <li><strong>gap</strong> (<a class="reference internal" href="gap_handling.html#promod3.modelling.StructuralGap" title="promod3.modelling.StructuralGap"><code class="xref py py-class docutils literal"><span class="pre">StructuralGap</span></code></a>.) &#8211; Gap for which loop is to be filled.</li>
 <li><strong>orig_indices</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code>) &#8211; Mapping to old indexing of candidates. If given, it
 must have as many elements as <em>candidates</em>.</li>
@@ -194,7 +194,7 @@ with <code class="docutils literal"><span class="pre">MolProbity</span> <span cl
 <tr class="field-odd field"><th class="field-name">Return type:</th><td class="field-body"><p class="first"><a class="reference external" href="https://docs.python.org/2.7/library/stdtypes.html#dict" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">dict</span></code></a></p>
 </td>
 </tr>
-<tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://www.openstructure.org/docs/base/settings/#ost.settings.FileNotFound" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">FileNotFound</span></code></a> if the &#8220;phenix.molprobity&#8221;
+<tr class="field-even field"><th class="field-name">Raises:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://www.openstructure.org/docs/base/settings/#ost.settings.FileNotFound" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">FileNotFound</span></code></a> if the &#8220;phenix.molprobity&#8221;
 executable is not found.</p>
 </td>
 </tr>
@@ -211,7 +211,7 @@ executable is not found.</p>
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>ost_ent</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Entity</span></code></a>) &#8211; OST entity on which to do analysis.</td>
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>ost_ent</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Entity</span></code></a>) &#8211; OST entity on which to do analysis.</td>
 </tr>
 </tbody>
 </table>
@@ -283,7 +283,7 @@ executable is not found.</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/modelling/monte_carlo.html b/doc/html/modelling/monte_carlo.html
index 36c37e6adae99ef01fc1e36b383ca6cc525e14b3..e10a1bfadccc3282e33e6e99a11a4ba2272e5154 100644
--- a/doc/html/modelling/monte_carlo.html
+++ b/doc/html/modelling/monte_carlo.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Generating Loops De Novo &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Generating Loops De Novo &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="modelling - Protein Modelling" href="index.html" />
     <link rel="next" title="Sidechain Reconstruction" href="sidechain_reconstruction.html" />
     <link rel="prev" title="Fitting Loops Into Gaps" href="loop_closing.html" />
@@ -506,9 +506,9 @@ avoid moving into unfavourable phi/psi ranges.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
-<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Defining stem positions the closed conformation
+<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Defining stem positions the closed conformation
 should adapt. See <a class="reference internal" href="loop_closing.html#promod3.modelling.CCD.CCD" title="promod3.modelling.CCD.CCD"><code class="xref py py-meth docutils literal"><span class="pre">CCD()</span></code></a>.</li>
-<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Defining stem positions the closed conformation
+<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Defining stem positions the closed conformation
 should adapt. See <a class="reference internal" href="loop_closing.html#promod3.modelling.CCD.CCD" title="promod3.modelling.CCD.CCD"><code class="xref py py-meth docutils literal"><span class="pre">CCD()</span></code></a>.</li>
 <li><strong>sequence</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; Sequence of the conformation to be closed.</li>
 <li><strong>torsion_sampler</strong> (<a class="reference internal" href="../loop/torsion_sampler.html#promod3.loop.TorsionSampler" title="promod3.loop.TorsionSampler"><code class="xref py py-class docutils literal"><span class="pre">TorsionSampler</span></code></a> / <code class="xref py py-class docutils literal"><span class="pre">list</span></code>
@@ -556,9 +556,9 @@ dihedral angles as it is the case for the <a class="reference internal" href="#p
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
-<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Defining stem positions the closed conformation
+<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Defining stem positions the closed conformation
 should adapt.</li>
-<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Defining stem positions the closed conformation
+<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Defining stem positions the closed conformation
 should adapt.</li>
 </ul>
 </td>
@@ -598,9 +598,9 @@ solutions. The KICCloser simply picks the first one.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
-<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Defining stem positions the closed conformation should
+<li><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Defining stem positions the closed conformation should
 adapt.</li>
-<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Defining stem positions the closed conformation should
+<li><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Defining stem positions the closed conformation should
 adapt.</li>
 <li><strong>seed</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Seed for internal random generators.</li>
 </ul>
@@ -639,7 +639,7 @@ superposing the c_stem with the desired positions.</p>
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Defining stem positions the closed conformation should
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>c_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Defining stem positions the closed conformation should
 adapt.</td>
 </tr>
 </tbody>
@@ -677,7 +677,7 @@ superposing the n_stem with the desired positions.</p>
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Defining stem positions the closed conformation should
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>n_stem</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Defining stem positions the closed conformation should
 adapt.</td>
 </tr>
 </tbody>
@@ -940,7 +940,7 @@ internal counter to 0</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/modelling/pipeline.html b/doc/html/modelling/pipeline.html
index 70a70284b31c5fa1fe17ea2b1acd9290dfda5763..33215e8bfb81487a015e272515314a80690fa0ee 100644
--- a/doc/html/modelling/pipeline.html
+++ b/doc/html/modelling/pipeline.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Modelling Pipeline &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Modelling Pipeline &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="modelling - Protein Modelling" href="index.html" />
     <link rel="next" title="Model Checking" href="model_checking.html" />
     <link rel="prev" title="modelling - Protein Modelling" href="index.html" />
@@ -118,7 +118,7 @@ chain follows afterwards.</p>
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">EntityHandle</span></code></a></td>
+<tr class="field-odd field"><th class="field-name">Type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">EntityHandle</span></code></a></td>
 </tr>
 </tbody>
 </table>
@@ -144,13 +144,13 @@ Gaps of different chains are appended one after another.</p>
 <dl class="attribute">
 <dt id="promod3.modelling.ModellingHandle.seqres">
 <code class="descname">seqres</code><a class="headerlink" href="#promod3.modelling.ModellingHandle.seqres" title="Permalink to this definition">¶</a></dt>
-<dd><p>List of sequences with one <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">SequenceHandle</span></code></a> for each chain
+<dd><p>List of sequences with one <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">SequenceHandle</span></code></a> for each chain
 of the target protein.</p>
 <table class="docutils field-list" frame="void" rules="none">
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceList" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">SequenceList</span></code></a></td>
+<tr class="field-odd field"><th class="field-name">Type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceList" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">SequenceList</span></code></a></td>
 </tr>
 </tbody>
 </table>
@@ -159,7 +159,7 @@ of the target protein.</p>
 <dl class="attribute">
 <dt id="promod3.modelling.ModellingHandle.profiles">
 <code class="descname">profiles</code><a class="headerlink" href="#promod3.modelling.ModellingHandle.profiles" title="Permalink to this definition">¶</a></dt>
-<dd><p>List of profiles with one <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a> for each chain of
+<dd><p>List of profiles with one <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a> for each chain of
 the target protein (same order as in <a class="reference internal" href="#promod3.modelling.ModellingHandle.seqres" title="promod3.modelling.ModellingHandle.seqres"><code class="xref py py-attr docutils literal"><span class="pre">seqres</span></code></a>). Please note, that this
 attribute won&#8217;t be set by simply calling <a class="reference internal" href="#promod3.modelling.BuildFromRawModel" title="promod3.modelling.BuildFromRawModel"><code class="xref py py-func docutils literal"><span class="pre">BuildFromRawModel()</span></code></a>. You have
 to fill it manually or even better by the convenient function
@@ -168,7 +168,7 @@ to fill it manually or even better by the convenient function
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Type:</th><td class="field-body"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a></td>
+<tr class="field-odd field"><th class="field-name">Type:</th><td class="field-body"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a></td>
 </tr>
 </tbody>
 </table>
@@ -355,7 +355,7 @@ alignment handle or an alignment handle list. Every list item is treated as a
 single chain in the final raw model.</p>
 <p>Each alignment handle must contain exactly two sequences and the second
 sequence is considered the template sequence, which must have a
-<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityView" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">EntityView</span></code></a> attached.</p>
+<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityView" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">EntityView</span></code></a> attached.</p>
 <p>This is a basic protein core modelling algorithm that copies backbone
 coordinates based on the sequence alignment. For matching residues, the
 side chain coordinates are also copied. Gaps are ignored. Hydrogen an
@@ -383,7 +383,7 @@ as information about insertions and deletions in the gaps list.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>aln</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.AlignmentHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">AlignmentHandle</span></code></a> / <code class="xref py py-class docutils literal"><span class="pre">AlignmentList</span></code>) &#8211; Single alignment handle for raw model with single chain or
+<li><strong>aln</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.AlignmentHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">AlignmentHandle</span></code></a> / <code class="xref py py-class docutils literal"><span class="pre">AlignmentList</span></code>) &#8211; Single alignment handle for raw model with single chain or
 list of alignment handles for raw model with multiple chains.</li>
 <li><strong>include_ligands</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#bool" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">bool</span></code></a>) &#8211; True, if we wish to include ligands in the model. This
 searches for ligands in all OST handles of the views
@@ -409,7 +409,7 @@ in SMTL). All ligands are added to a new chain named
 <li>the second sequence does not have an attached structure</li>
 <li>the residues of the template structure do not match with the
 alignment sequence (note that you can set an &#8220;offset&#8221; (see
-<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.AlignmentHandle.SetSequenceOffset" title="(in OpenStructure v1.9.0)"><code class="xref py py-meth docutils literal"><span class="pre">SetSequenceOffset()</span></code></a>) for the
+<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.AlignmentHandle.SetSequenceOffset" title="(in OpenStructure v1.10.0)"><code class="xref py py-meth docutils literal"><span class="pre">SetSequenceOffset()</span></code></a>) for the
 template sequence (but not for the target))</li>
 <li>the target sequence has a non-zero offset (cannot be honored as
 the resulting model will always start its residue numbering at 1)</li>
@@ -453,12 +453,12 @@ return an incomplete model.</p>
 <li><strong>mhandle</strong> (<a class="reference internal" href="#promod3.modelling.ModellingHandle" title="promod3.modelling.ModellingHandle"><code class="xref py py-class docutils literal"><span class="pre">ModellingHandle</span></code></a>) &#8211; The prepared template coordinates loaded with the input
 alignment.</li>
 <li><strong>use_amber_ff</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#bool" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">bool</span></code></a>) &#8211; if True, use the AMBER force field instead of the def.
-CHARMM one (see <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/forcefield/#ost.mol.mm.LoadAMBERForcefield" title="(in OpenStructure v1.9.0)"><code class="xref py py-func docutils literal"><span class="pre">ost.mol.mm.LoadAMBERForcefield()</span></code></a>
-and <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/forcefield/#ost.mol.mm.LoadCHARMMForcefield" title="(in OpenStructure v1.9.0)"><code class="xref py py-func docutils literal"><span class="pre">ost.mol.mm.LoadCHARMMForcefield()</span></code></a>).
+CHARMM one (see <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/forcefield/#ost.mol.mm.LoadAMBERForcefield" title="(in OpenStructure v1.10.0)"><code class="xref py py-func docutils literal"><span class="pre">ost.mol.mm.LoadAMBERForcefield()</span></code></a>
+and <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/forcefield/#ost.mol.mm.LoadCHARMMForcefield" title="(in OpenStructure v1.10.0)"><code class="xref py py-func docutils literal"><span class="pre">ost.mol.mm.LoadCHARMMForcefield()</span></code></a>).
 Both do a similarly good job without ligands (CHARMM
 slightly better), but you will want to be consistent
 with the optional force fields in <cite>extra_force_fields</cite>.</li>
-<li><strong>extra_force_fields</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/forcefield/#ost.mol.mm.Forcefield" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.mm.Forcefield</span></code></a>) &#8211; Additional list of force fields to use if a 
+<li><strong>extra_force_fields</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/forcefield/#ost.mol.mm.Forcefield" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.mm.Forcefield</span></code></a>) &#8211; Additional list of force fields to use if a 
 (ligand) residue cannot be parametrized with the
 default force field. The force fields are tried
 in the order as given and ligands without an
@@ -479,7 +479,7 @@ limited. Termini of length 1 won&#8217;t be modelled.</li>
 <tr class="field-even field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">Delivers the model as an OST entity.</p>
 </td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Return type:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Entity</span></code></a></p>
+<tr class="field-odd field"><th class="field-name">Return type:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Entity</span></code></a></p>
 </td>
 </tr>
 </tbody>
@@ -654,7 +654,7 @@ environments get updated in <strong>target_mhandle</strong>.</p>
 <li><strong>target_chain_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; This is the chain where the info goes to</li>
 <li><strong>start_resnum</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; First residue of the copied stretch</li>
 <li><strong>end_resnum</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Last residue of the copied stretch</li>
-<li><strong>transform</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat4" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Mat4</span></code></a>) &#8211; Transformation to be applied to all atom positions when
+<li><strong>transform</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/mat/#ost.geom.Mat4" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Mat4</span></code></a>) &#8211; Transformation to be applied to all atom positions when
 they&#8217;re copied over</li>
 </ul>
 </td>
@@ -685,7 +685,7 @@ while ensuring consistency with the <a class="reference internal" href="#promod3
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>mhandle</strong> (<a class="reference internal" href="#promod3.modelling.ModellingHandle" title="promod3.modelling.ModellingHandle"><code class="xref py py-class docutils literal"><span class="pre">ModellingHandle</span></code></a>) &#8211; Will have the profiles attached afterwards</li>
-<li><strong>profiles</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a>) &#8211; The sequence profiles to attach</li>
+<li><strong>profiles</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.ProfileHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.ProfileHandle</span></code></a>) &#8211; The sequence profiles to attach</li>
 </ul>
 </td>
 </tr>
@@ -842,7 +842,7 @@ For the scondary-structure-penalty to work,
 the model-template must have the appropriate
 information before <a class="reference internal" href="#promod3.modelling.BuildRawModel" title="promod3.modelling.BuildRawModel"><code class="xref py py-func docutils literal"><span class="pre">BuildRawModel()</span></code></a> is
 called (e.g. with 
-<a class="reference external" href="https://www.openstructure.org/docs/mol/alg/molalg/#ost.mol.alg.AssignSecStruct" title="(in OpenStructure v1.9.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.alg.AssignSecStruct()</span></code></a>).</li>
+<a class="reference external" href="https://www.openstructure.org/docs/mol/alg/molalg/#ost.mol.alg.AssignSecStruct" title="(in OpenStructure v1.10.0)"><code class="xref py py-meth docutils literal"><span class="pre">ost.mol.alg.AssignSecStruct()</span></code></a>).</li>
 <li><strong>use_full_extender</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#bool" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">bool</span></code></a>) &#8211; True = use <a class="reference internal" href="gap_handling.html#promod3.modelling.FullGapExtender" title="promod3.modelling.FullGapExtender"><code class="xref py py-class docutils literal"><span class="pre">FullGapExtender</span></code></a> instead of
 of <a class="reference internal" href="gap_handling.html#promod3.modelling.GapExtender" title="promod3.modelling.GapExtender"><code class="xref py py-class docutils literal"><span class="pre">GapExtender</span></code></a>. Also works in combination
 with <cite>use_scoring_extender</cite>. This allows the gap
@@ -913,7 +913,7 @@ both in this resnum range.</li>
 
 <dl class="function">
 <dt id="promod3.modelling.FillLoopsByDatabase">
-<code class="descclassname">promod3.modelling.</code><code class="descname">FillLoopsByDatabase</code><span class="sig-paren">(</span><em>mhandle</em>, <em>fragment_db</em>, <em>structure_db</em>, <em>torsion_sampler</em>, <em>max_loops_to_search=40</em>, <em>min_loops_required=4</em>, <em>max_res_extension=-1</em>, <em>extended_search=True</em>, <em>use_scoring_extender=True</em>, <em>use_full_extender=True</em>, <em>score_variant=0</em>, <em>ring_punch_detection=1</em>, <em>chain_idx=None</em>, <em>resnum_range=None</em>, <em>max_num_all_atom=0</em>, <em>clash_thresh=-1</em>, <em>length_dep_weights=False</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.modelling.FillLoopsByDatabase" title="Permalink to this definition">¶</a></dt>
+<code class="descclassname">promod3.modelling.</code><code class="descname">FillLoopsByDatabase</code><span class="sig-paren">(</span><em>mhandle</em>, <em>fragment_db</em>, <em>structure_db</em>, <em>torsion_sampler=None</em>, <em>max_loops_to_search=40</em>, <em>min_loops_required=4</em>, <em>max_res_extension=-1</em>, <em>extended_search=True</em>, <em>use_scoring_extender=True</em>, <em>use_full_extender=True</em>, <em>score_variant=0</em>, <em>ring_punch_detection=1</em>, <em>chain_idx=None</em>, <em>resnum_range=None</em>, <em>max_num_all_atom=0</em>, <em>clash_thresh=-1</em>, <em>length_dep_weights=False</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.modelling.FillLoopsByDatabase" title="Permalink to this definition">¶</a></dt>
 <dd><p>Try to fill up loops from a structural database.</p>
 <p>Usually this will extend the gaps a bit to match candidates from the
 database. Do not expect a gap being filled in between its actual stem
@@ -946,7 +946,8 @@ This function cannot fill gaps at C- or N-terminal.</p>
 <li><strong>mhandle</strong> (<a class="reference internal" href="#promod3.modelling.ModellingHandle" title="promod3.modelling.ModellingHandle"><code class="xref py py-class docutils literal"><span class="pre">ModellingHandle</span></code></a>) &#8211; Modelling handle on which to apply change.</li>
 <li><strong>fragment_db</strong> (<a class="reference internal" href="../loop/structure_db.html#promod3.loop.FragDB" title="promod3.loop.FragDB"><code class="xref py py-class docutils literal"><span class="pre">FragDB</span></code></a>) &#8211; A fragment database coupled to the <em>structure_db</em>.</li>
 <li><strong>structure_db</strong> (<a class="reference internal" href="../loop/structure_db.html#promod3.loop.StructureDB" title="promod3.loop.StructureDB"><code class="xref py py-class docutils literal"><span class="pre">StructureDB</span></code></a>) &#8211; Backbone/profile data.</li>
-<li><strong>torsion_sampler</strong> (<a class="reference internal" href="../loop/torsion_sampler.html#promod3.loop.TorsionSampler" title="promod3.loop.TorsionSampler"><code class="xref py py-class docutils literal"><span class="pre">TorsionSampler</span></code></a>) &#8211; A sampler for torsion angles.</li>
+<li><strong>torsion_sampler</strong> (<a class="reference internal" href="../loop/torsion_sampler.html#promod3.loop.TorsionSampler" title="promod3.loop.TorsionSampler"><code class="xref py py-class docutils literal"><span class="pre">TorsionSampler</span></code></a>) &#8211; A sampler for torsion angles. A default one is 
+loaded if None.</li>
 <li><strong>max_loops_to_search</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Define how many candidates are &#8216;enough&#8217; to be
 evaluated per loop. The actual found candidates
 may be more (if we found &#8216;enough&#8217;) or less (if
@@ -1015,7 +1016,7 @@ loops.</li>
 
 <dl class="function">
 <dt id="promod3.modelling.FillLoopsByMonteCarlo">
-<code class="descclassname">promod3.modelling.</code><code class="descname">FillLoopsByMonteCarlo</code><span class="sig-paren">(</span><em>mhandle</em>, <em>torsion_sampler</em>, <em>max_loops_to_search=6</em>, <em>max_extension=30</em>, <em>mc_num_loops=2</em>, <em>mc_steps=5000</em>, <em>use_scoring_extender=True</em>, <em>use_full_extender=True</em>, <em>score_variant=0</em>, <em>ring_punch_detection=1</em>, <em>fragger_handles=None</em>, <em>chain_idx=None</em>, <em>resnum_range=None</em>, <em>length_dep_weights=False</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.modelling.FillLoopsByMonteCarlo" title="Permalink to this definition">¶</a></dt>
+<code class="descclassname">promod3.modelling.</code><code class="descname">FillLoopsByMonteCarlo</code><span class="sig-paren">(</span><em>mhandle</em>, <em>torsion_sampler=None</em>, <em>max_loops_to_search=6</em>, <em>max_extension=30</em>, <em>mc_num_loops=2</em>, <em>mc_steps=5000</em>, <em>use_scoring_extender=True</em>, <em>use_full_extender=True</em>, <em>score_variant=0</em>, <em>ring_punch_detection=1</em>, <em>fragger_handles=None</em>, <em>chain_idx=None</em>, <em>resnum_range=None</em>, <em>length_dep_weights=False</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.modelling.FillLoopsByMonteCarlo" title="Permalink to this definition">¶</a></dt>
 <dd><p>Try to fill up loops with Monte Carlo sampling.</p>
 <p>This is meant as a &#8220;last-resort&#8221; approach when it is not possible to fill
 the loops from the database with <a class="reference internal" href="#promod3.modelling.FillLoopsByDatabase" title="promod3.modelling.FillLoopsByDatabase"><code class="xref py py-func docutils literal"><span class="pre">FillLoopsByDatabase()</span></code></a>.
@@ -1049,7 +1050,8 @@ is only used if the gap length is &gt;= the length of fragments stored.</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
 <li><strong>mhandle</strong> (<a class="reference internal" href="#promod3.modelling.ModellingHandle" title="promod3.modelling.ModellingHandle"><code class="xref py py-class docutils literal"><span class="pre">ModellingHandle</span></code></a>) &#8211; Modelling handle on which to apply change.</li>
-<li><strong>torsion_sampler</strong> (<a class="reference internal" href="../loop/torsion_sampler.html#promod3.loop.TorsionSampler" title="promod3.loop.TorsionSampler"><code class="xref py py-class docutils literal"><span class="pre">TorsionSampler</span></code></a>) &#8211; A sampler for torsion angles.</li>
+<li><strong>torsion_sampler</strong> (<a class="reference internal" href="../loop/torsion_sampler.html#promod3.loop.TorsionSampler" title="promod3.loop.TorsionSampler"><code class="xref py py-class docutils literal"><span class="pre">TorsionSampler</span></code></a>) &#8211; A sampler for torsion angles. A default one is 
+loaded if None.</li>
 <li><strong>max_loops_to_search</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Define how many candidates are &#8216;enough&#8217; to be
 evaluated per loop.</li>
 <li><strong>max_extension</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Maximal number of gap extension steps to perform
@@ -1211,7 +1213,7 @@ one is loaded if None.</li>
 <dt id="promod3.modelling.MinimizeModelEnergy">
 <code class="descclassname">promod3.modelling.</code><code class="descname">MinimizeModelEnergy</code><span class="sig-paren">(</span><em>mhandle</em>, <em>max_iterations=12</em>, <em>max_iter_sd=20</em>, <em>max_iter_lbfgs=10</em>, <em>use_amber_ff=False</em>, <em>extra_force_fields=[]</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.modelling.MinimizeModelEnergy" title="Permalink to this definition">¶</a></dt>
 <dd><p>Minimize energy of final model using molecular mechanics.</p>
-<p>Uses <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/molmm/#module-ost.mol.mm" title="(in OpenStructure v1.9.0)"><code class="xref py py-mod docutils literal"><span class="pre">ost.mol.mm</span></code></a> to perform energy minimization.
+<p>Uses <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/molmm/#module-ost.mol.mm" title="(in OpenStructure v1.10.0)"><code class="xref py py-mod docutils literal"><span class="pre">ost.mol.mm</span></code></a> to perform energy minimization.
 It will iteratively (at most <em>max_iterations</em> times):</p>
 <ul class="simple">
 <li>run up to <em>max_iter_sd</em> minimization iter. of a steepest descend method</li>
@@ -1239,7 +1241,7 @@ minimization is aborted. This issue is logged and added as a major issue to
 <li><strong>max_iter_lbfgs</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Max. number of iterations within LBFGS method</li>
 <li><strong>use_amber_ff</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#bool" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">bool</span></code></a>) &#8211; if True, use the AMBER force field instead of the def.
 CHARMM one (see <a class="reference internal" href="#promod3.modelling.BuildFromRawModel" title="promod3.modelling.BuildFromRawModel"><code class="xref py py-meth docutils literal"><span class="pre">BuildFromRawModel()</span></code></a>).</li>
-<li><strong>extra_force_fields</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/forcefield/#ost.mol.mm.Forcefield" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.mm.Forcefield</span></code></a>) &#8211; Additional list of force fields to use (see
+<li><strong>extra_force_fields</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/mol/mm/forcefield/#ost.mol.mm.Forcefield" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.mm.Forcefield</span></code></a>) &#8211; Additional list of force fields to use (see
 <a class="reference internal" href="#promod3.modelling.BuildFromRawModel" title="promod3.modelling.BuildFromRawModel"><code class="xref py py-meth docutils literal"><span class="pre">BuildFromRawModel()</span></code></a>).</li>
 </ul>
 </td>
@@ -1247,7 +1249,7 @@ CHARMM one (see <a class="reference internal" href="#promod3.modelling.BuildFrom
 <tr class="field-even field"><th class="field-name">Returns:</th><td class="field-body"><p class="first">The model including all oxygens as used in the minimizer.</p>
 </td>
 </tr>
-<tr class="field-odd field"><th class="field-name">Return type:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">Entity</span></code></a></p>
+<tr class="field-odd field"><th class="field-name">Return type:</th><td class="field-body"><p class="first last"><a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">Entity</span></code></a></p>
 </td>
 </tr>
 </tbody>
@@ -1335,8 +1337,8 @@ set to True, if the problem affects backbone atoms.</li>
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Type:</th><td class="field-body"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ResidueHandle</span></code></a> /
-<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueView" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ResidueView</span></code></a></td>
+<tr class="field-odd field"><th class="field-name">Type:</th><td class="field-body"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ResidueHandle</span></code></a> /
+<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueView" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ResidueView</span></code></a></td>
 </tr>
 </tbody>
 </table>
@@ -1453,7 +1455,7 @@ attribute yet, it is added.</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/modelling/sidechain_reconstruction.html b/doc/html/modelling/sidechain_reconstruction.html
index 58ac0f35df0c576c780fb241eb008d389dba9dcc..0a2b09ea8c269e3a61396bf576b543c5f59cf734 100644
--- a/doc/html/modelling/sidechain_reconstruction.html
+++ b/doc/html/modelling/sidechain_reconstruction.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Sidechain Reconstruction &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Sidechain Reconstruction &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="modelling - Protein Modelling" href="index.html" />
     <link rel="next" title="Modelling Algorithms" href="algorithms.html" />
     <link rel="prev" title="Generating Loops De Novo" href="monte_carlo.html" />
@@ -47,7 +47,7 @@
 <p>Two methods are provided to fully reconstruct sidechains of residues:</p>
 <ul class="simple">
 <li>the <a class="reference internal" href="#promod3.modelling.ReconstructSidechains" title="promod3.modelling.ReconstructSidechains"><code class="xref py py-func docutils literal"><span class="pre">ReconstructSidechains()</span></code></a> function handles a full OST
-<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">EntityHandle</span></code></a></li>
+<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">EntityHandle</span></code></a></li>
 <li>the <a class="reference internal" href="#promod3.modelling.SidechainReconstructor" title="promod3.modelling.SidechainReconstructor"><code class="xref py py-class docutils literal"><span class="pre">SidechainReconstructor</span></code></a> is linked to an all atom environment
 and used to reconstruct sidechains of single loops</li>
 </ul>
@@ -102,7 +102,7 @@ and used to reconstruct sidechains of single loops</li>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
-<li><strong>ent</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.EntityHandle</span></code></a>) &#8211; Structure for sidechain reconstruction. Note, that the sidechain
+<li><strong>ent</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.EntityHandle</span></code></a>) &#8211; Structure for sidechain reconstruction. Note, that the sidechain
 reconstruction gets directly applied on the structure itself.</li>
 <li><strong>keep_sidechains</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#bool" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">bool</span></code></a>) &#8211; Flag, whether complete sidechains in <em>ent</em> (i.e. 
 containing all required atoms) should be kept rigid
@@ -214,7 +214,7 @@ environment before calling this!</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>start_resnum</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResNum" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResNum</span></code></a>) &#8211; Start of loop.</li>
+<li><strong>start_resnum</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResNum" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResNum</span></code></a>) &#8211; Start of loop.</li>
 <li><strong>num_residues</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Length of loop.</li>
 <li><strong>chain_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Chain the loop belongs to.</li>
 <li><strong>start_resnum_list</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Starts of loops.</li>
@@ -441,7 +441,7 @@ in the environment (same length as <em>env_pos.res_indices</em>)</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/objects.inv b/doc/html/objects.inv
index 01a546df33de2546098bf5872f811a54f33353fe..02ecc00e655c54dada0b5e1e709b33f23e845db2 100644
Binary files a/doc/html/objects.inv and b/doc/html/objects.inv differ
diff --git a/doc/html/portableIO.html b/doc/html/portableIO.html
index b1fbc6e8a0374ebe94ecc2eaa2d0ee2f8623c101..807daaeef51b0813f61a4e40407916889de0aa02 100644
--- a/doc/html/portableIO.html
+++ b/doc/html/portableIO.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Using Binary Files In ProMod3 &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Using Binary Files In ProMod3 &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    './',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="_static/underscore.js"></script>
     <script type="text/javascript" src="_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="index.html" />
     <link rel="up" title="Documentation For Developers" href="developers.html" />
     <link rel="next" title="License" href="license.html" />
     <link rel="prev" title="ProMod3‘s Share Of CMake" href="cmake/index.html" />
@@ -478,7 +478,7 @@ in the <code class="file docutils literal"><span class="pre">extras/data_generat
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/py-modindex.html b/doc/html/py-modindex.html
index 47841194a7a87d9425151bf3bb96d3332b3d75cb..8382e9e26c6f32c6bdb0bac184c676e330cf50fd 100644
--- a/doc/html/py-modindex.html
+++ b/doc/html/py-modindex.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Python Module Index &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Python Module Index &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    './',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="_static/underscore.js"></script>
     <script type="text/javascript" src="_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="index.html" />
 
    
   <link rel="stylesheet" href="_static/custom.css" type="text/css" />
@@ -132,7 +132,7 @@
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/references.html b/doc/html/references.html
index d0836ee0a3ecb34c9bc50de14cb86f68f3ce9c47..cee6d5434a8074eff00e925c919d771815a4f10d 100644
--- a/doc/html/references.html
+++ b/doc/html/references.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>References &mdash; ProMod3 2.0.0 documentation</title>
+    <title>References &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    './',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="_static/underscore.js"></script>
     <script type="text/javascript" src="_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="index.html" />
     <link rel="next" title="Changelog" href="changelog.html" />
     <link rel="prev" title="License" href="license.html" />
    
@@ -132,6 +132,14 @@ Exploring the conformational space of protein side chains using
 dead-end elimination and the A* algorithm. Proteins.</td></tr>
 </tbody>
 </table>
+<table class="docutils citation" frame="void" id="nussinov1991" rules="none">
+<colgroup><col class="label" /><col /></colgroup>
+<tbody valign="top">
+<tr><td class="label">[nussinov1991]</td><td>Nussinov R and Wolfson HJ (1991).
+Efficient detection of three-dimensional structural motifs in
+biological macromolecules by computer vision techniques. PNAS.</td></tr>
+</tbody>
+</table>
 <table class="docutils citation" frame="void" id="shapovalov2011" rules="none">
 <colgroup><col class="label" /><col /></colgroup>
 <tbody valign="top">
@@ -157,6 +165,14 @@ potentials and threading score functions using information
 maximization. Proteins.</td></tr>
 </tbody>
 </table>
+<table class="docutils citation" frame="void" id="trott2010" rules="none">
+<colgroup><col class="label" /><col /></colgroup>
+<tbody valign="top">
+<tr><td class="label">[trott2010]</td><td>Trott O, Olson AJ (2010). AutoDock Vina: improving the speed and
+accuracy of docking with a new scoring function, efficient
+optimization and multithreading. J Comput Chem</td></tr>
+</tbody>
+</table>
 <table class="docutils citation" frame="void" id="zhou2005" rules="none">
 <colgroup><col class="label" /><col /></colgroup>
 <tbody valign="top">
@@ -204,7 +220,7 @@ Fragments. Proteins.</td></tr>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/scoring/all_atom_scorers.html b/doc/html/scoring/all_atom_scorers.html
index 9c9f58223d159cc67c8941f0301d9412442629be..2c1ceae1ca06c0417fd24bbe814e340ccb68e694 100644
--- a/doc/html/scoring/all_atom_scorers.html
+++ b/doc/html/scoring/all_atom_scorers.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>All Atom Scorers &mdash; ProMod3 2.0.0 documentation</title>
+    <title>All Atom Scorers &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="scoring - Loop Scoring" href="index.html" />
     <link rel="next" title="Other Scoring Functions" href="other_scoring_functions.html" />
     <link rel="prev" title="Backbone Scorers" href="backbone_scorers.html" />
@@ -672,7 +672,7 @@ of residues in the input loop. True by default.</td>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/scoring/backbone_score_env.html b/doc/html/scoring/backbone_score_env.html
index 6235608ccb7f65b630125f4963999b8efe227e07..4102971fd221d81757841b4e3daa61f0d0a36a4b 100644
--- a/doc/html/scoring/backbone_score_env.html
+++ b/doc/html/scoring/backbone_score_env.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Backbone Score Environment &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Backbone Score Environment &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="scoring - Loop Scoring" href="index.html" />
     <link rel="next" title="Backbone Scorers" href="backbone_scorers.html" />
     <link rel="prev" title="scoring - Loop Scoring" href="index.html" />
@@ -69,8 +69,8 @@ task.</p>
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>seqres</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceHandle</span></code></a> /
-<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceList" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceList</span></code></a>) &#8211; Internal SEQRES to be set (single chain or list with one per
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>seqres</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceHandle</span></code></a> /
+<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceList" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceList</span></code></a>) &#8211; Internal SEQRES to be set (single chain or list with one per
 chain). Whenever setting structural data, consistency with this SEQRES is enforced.</td>
 </tr>
 </tbody>
@@ -107,7 +107,7 @@ structural data was already set, all the existing data gets cleared first.</p>
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>env_structure</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.EntityHandle</span></code></a>) &#8211; Structral data to be set as environment. The chains
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>env_structure</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.EntityHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.EntityHandle</span></code></a>) &#8211; Structral data to be set as environment. The chains
 in <em>env_structure</em> are expected to be in the same
 order as the SEQRES items provided in constructor.</td>
 </tr>
@@ -131,7 +131,7 @@ positions.</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>bb_list</strong> (<a class="reference internal" href="../loop/backbone.html#promod3.loop.BackboneList" title="promod3.loop.BackboneList"><code class="xref py py-class docutils literal"><span class="pre">BackboneList</span></code></a>) &#8211; Structural data to be set as environment.</li>
-<li><strong>start_resnum</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResNum" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResNum</span></code></a>) &#8211; Res. number defining the position in the SEQRES.</li>
+<li><strong>start_resnum</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a> / <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResNum" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResNum</span></code></a>) &#8211; Res. number defining the position in the SEQRES.</li>
 <li><strong>chain_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Index of chain the structural data belongs to.</li>
 </ul>
 </td>
@@ -280,7 +280,7 @@ providing lists of integers.</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">SEQRES that was set in constructor (one sequence per chain).</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceList" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceList</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceList" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceList</span></code></a></td>
 </tr>
 </tbody>
 </table>
@@ -387,7 +387,7 @@ The constraint functions are built after the principle of QMEANDisCo.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
-<li><strong>seqres</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceHandle</span></code></a>) &#8211; The sequence with which all added structures must match</li>
+<li><strong>seqres</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.SequenceHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.SequenceHandle</span></code></a>) &#8211; The sequence with which all added structures must match</li>
 <li><strong>function_type</strong> (<a class="reference internal" href="#promod3.scoring.PairwiseFunctionType" title="promod3.scoring.PairwiseFunctionType"><code class="xref py py-class docutils literal"><span class="pre">PairwiseFunctionType</span></code></a>) &#8211; Whether you want to assess pairwise distances between CA
 or CB atoms</li>
 </ul>
@@ -402,7 +402,7 @@ or CB atoms</li>
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>aln</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.AlignmentHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.AlignmentHandle</span></code></a>) &#8211; Alignment, where first sequence represent the initial
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>aln</strong> (<a class="reference external" href="https://www.openstructure.org/docs/seq/base/seq/#ost.seq.AlignmentHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.seq.AlignmentHandle</span></code></a>) &#8211; Alignment, where first sequence represent the initial
 SEQRES and the second sequence the actual structural
 info. The second sequence must have a view attached.</td>
 </tr>
@@ -508,7 +508,7 @@ inconsistent with SEQRES you initialized the DiscoContainer with</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/scoring/backbone_scorers.html b/doc/html/scoring/backbone_scorers.html
index 7b8ad9e7b4e2f9a759ccd41078a13c8d9cb4cf1a..5787bc4c9307fa8d0716f96a6d7593a821b593ea 100644
--- a/doc/html/scoring/backbone_scorers.html
+++ b/doc/html/scoring/backbone_scorers.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Backbone Scorers &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Backbone Scorers &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="scoring - Loop Scoring" href="index.html" />
     <link rel="next" title="All Atom Scorers" href="all_atom_scorers.html" />
     <link rel="prev" title="Backbone Score Environment" href="backbone_score_env.html" />
@@ -381,7 +381,7 @@ called for every type of amino acids and for every <em>count</em> &lt;= <em>max_
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; Amino acid for which to set energy.</li>
+<li><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; Amino acid for which to set energy.</li>
 <li><strong>count</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Number of surrounding CB positions for which to set energy.</li>
 <li><strong>energy</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; Energy to set for those parameters.</li>
 </ul>
@@ -515,8 +515,8 @@ SetEnergy(aa2, aa1, bin, energy).</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>aa1</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; Amino acid for first interaction partner.</li>
-<li><strong>aa2</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; Amino acid for second interaction partner.</li>
+<li><strong>aa1</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; Amino acid for first interaction partner.</li>
+<li><strong>aa2</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; Amino acid for second interaction partner.</li>
 <li><strong>bin</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Discrete bin describing the interaction distance.</li>
 <li><strong>energy</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; Energy to set for those parameters.</li>
 </ul>
@@ -695,8 +695,8 @@ SetEnergy(aa2, aa1, dist_bin, beta_bin, alpha_bin, energy).</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>aa1</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; Amino acid for first interaction partner.</li>
-<li><strong>aa2</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; Amino acid for second interaction partner.</li>
+<li><strong>aa1</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; Amino acid for first interaction partner.</li>
+<li><strong>aa2</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; Amino acid for second interaction partner.</li>
 <li><strong>dist_bin</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Discrete bin describing the interaction distance.</li>
 <li><strong>alpha_bin</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Discrete bin describing the alpha angle.</li>
 <li><strong>beta_bin</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Discrete bin describing the beta angle.</li>
@@ -1388,7 +1388,7 @@ of residues to be scored. True by default.</td>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/scoring/index.html b/doc/html/scoring/index.html
index f56b23ba357753d48b79c1708a60c2c588312afe..c4a6177e14b51adb45f06bd050d16a21184d1994 100644
--- a/doc/html/scoring/index.html
+++ b/doc/html/scoring/index.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>scoring - Loop Scoring &mdash; ProMod3 2.0.0 documentation</title>
+    <title>scoring - Loop Scoring &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="Documentation For Users" href="../users.html" />
     <link rel="next" title="Backbone Score Environment" href="backbone_score_env.html" />
     <link rel="prev" title="Subrotamer Optimization" href="../sidechain/subrotamer_optimizer.html" />
@@ -152,7 +152,7 @@ scorers to it and finally score some loops:</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/scoring/other_scoring_functions.html b/doc/html/scoring/other_scoring_functions.html
index 57c6c16db63043d18557fa5de92e3348e1fc74b0..b639d4f79929726ca22d0eb2ff8a075318326e28 100644
--- a/doc/html/scoring/other_scoring_functions.html
+++ b/doc/html/scoring/other_scoring_functions.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Other Scoring Functions &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Other Scoring Functions &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="scoring - Loop Scoring" href="index.html" />
     <link rel="next" title="loop - Loop Handling" href="../loop/index.html" />
     <link rel="prev" title="All Atom Scorers" href="all_atom_scorers.html" />
@@ -159,7 +159,7 @@ construction algorithm <a class="reference internal" href="../references.html#ca
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/search.html b/doc/html/search.html
index 4eb4082b859a1ecc68b3dd78a53e83b6061b6eb1..874ca440df26a4aac33d1d09769355e081d5c63a 100644
--- a/doc/html/search.html
+++ b/doc/html/search.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Search &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Search &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    './',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -25,7 +25,7 @@
     <script type="text/javascript" src="_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
     <script type="text/javascript" src="_static/searchtools.js"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="index.html" />
   <script type="text/javascript">
     jQuery(function() { Search.loadIndex("searchindex.js"); });
   </script>
@@ -87,7 +87,7 @@
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/searchindex.js b/doc/html/searchindex.js
index 7b6f6337667fa0eb0c3269740f31f593b2cd9106..e1c5ff506a9a7a8823d27608488d58c7dd5905d5 100644
--- a/doc/html/searchindex.js
+++ b/doc/html/searchindex.js
@@ -1 +1 @@
-Search.setIndex({envversion:47,filenames:["actions/index","actions/index_dev","buildsystem","changelog","cmake/index","container/docker","container/index","container/singularity","contributing","core/geometry","core/graph_minimizer","core/helper","core/index","core/pm3argparse","core/runtime_profiling","core/setcompoundschemlib","dev_setup","developers","gettingstarted","index","license","loop/all_atom","loop/backbone","loop/index","loop/load_loop_objects","loop/mm_system_creation","loop/structure_db","loop/torsion_sampler","modelling/algorithms","modelling/gap_handling","modelling/index","modelling/loop_candidates","modelling/loop_closing","modelling/model_checking","modelling/monte_carlo","modelling/pipeline","modelling/sidechain_reconstruction","portableIO","references","scoring/all_atom_scorers","scoring/backbone_score_env","scoring/backbone_scorers","scoring/index","scoring/other_scoring_functions","sidechain/disulfid","sidechain/frame","sidechain/graph","sidechain/index","sidechain/loading","sidechain/rotamer","sidechain/rotamer_constructor","sidechain/rotamer_id","sidechain/rotamer_lib","sidechain/subrotamer_optimizer","user_contributions","users"],objects:{"":{"--backbone-independent":[0,7,1,"cmdoption--backbone-independent"],"--energy_function":[0,7,1,"cmdoption--energy_function"],"--keep-sidechains":[0,7,1,"cmdoption--keep-sidechains"],"--no-disulfids":[0,7,1,"cmdoption--no-disulfids"],"--no-subrotamer-optimization":[0,7,1,"cmdoption--no-subrotamer-optimization"],"--rigid-rotamers":[0,7,1,"cmdoption--rigid-rotamers"],"-f":[0,7,1,"cmdoption-f"],"-i":[0,7,1,"cmdoption-i"],"-k":[0,7,1,"cmdoption-k"],"-n":[0,7,1,"cmdoption-n"],"-r":[0,7,1,"cmdoption-r"],"-s":[0,7,1,"cmdoption-s"],"command:add_doc_dependency":[4,0,1,""],"command:add_doc_source":[4,0,1,""],"command:convert_module_data":[4,0,1,""],"command:module":[4,0,1,""],"command:pm_action":[4,0,1,""],"command:promod3_unittest":[4,0,1,""],"command:pymod":[4,0,1,""],test_actions:[1,2,0,"-"]},"promod3.core":{ConstructAtomPos:[9,1,1,""],ConstructCBetaPos:[9,1,1,""],ConstructCTerminalOxygens:[9,1,1,""],EvaluateGromacsPosRule:[9,1,1,""],GraphMinimizer:[10,3,1,""],RotationAroundLine:[9,1,1,""],StaticRuntimeProfiler:[14,3,1,""],StemCoords:[9,3,1,""],StemPairOrientation:[9,3,1,""],helper:[11,2,0,"-"],pm3argparse:[13,2,0,"-"]},"promod3.core.GraphMinimizer":{AStarSolve:[10,4,1,""],AddEdge:[10,4,1,""],AddNode:[10,4,1,""],ApplyDEE:[10,4,1,""],ApplyEdgeDecomposition:[10,4,1,""],MCSolve:[10,4,1,""],NaiveSolve:[10,4,1,""],Prune:[10,4,1,""],Reset:[10,4,1,""],TreeSolve:[10,4,1,""]},"promod3.core.StaticRuntimeProfiler":{Clear:[14,5,1,""],IsEnabled:[14,5,1,""],PrintSummary:[14,5,1,""],Start:[14,5,1,""],StartScoped:[14,5,1,""],Stop:[14,5,1,""]},"promod3.core.StemCoords":{c_coord:[9,6,1,""],ca_coord:[9,6,1,""],n_coord:[9,6,1,""]},"promod3.core.StemPairOrientation":{angle_four:[9,6,1,""],angle_one:[9,6,1,""],angle_three:[9,6,1,""],angle_two:[9,6,1,""],distance:[9,6,1,""]},"promod3.core.helper":{FileExists:[11,1,1,""],FileExtension:[11,1,1,""],FileGzip:[11,1,1,""],MsgErrorAndExit:[11,1,1,""]},"promod3.core.pm3argparse":{PM3ArgumentParser:[13,3,1,""]},"promod3.core.pm3argparse.PM3ArgumentParser":{"__init__":[13,4,1,""],AddAlignment:[13,4,1,""],AddFragments:[13,4,1,""],AddProfile:[13,4,1,""],AddStructure:[13,4,1,""],AssembleParser:[13,4,1,""],Parse:[13,4,1,""],action:[13,6,1,""]},"promod3.loop":{AllAtomEnv:[21,3,1,""],AllAtomEnvPositions:[21,3,1,""],AllAtomPositions:[21,3,1,""],AminoAcidAtom:[21,3,1,""],AminoAcidHydrogen:[21,3,1,""],AminoAcidLookup:[21,3,1,""],BackboneList:[22,3,1,""],CoordInfo:[26,3,1,""],ForcefieldAminoAcid:[25,3,1,""],ForcefieldBondInfo:[25,3,1,""],ForcefieldConnectivity:[25,3,1,""],ForcefieldHarmonicAngleInfo:[25,3,1,""],ForcefieldHarmonicImproperInfo:[25,3,1,""],ForcefieldLJPairInfo:[25,3,1,""],ForcefieldLookup:[25,3,1,""],ForcefieldPeriodicDihedralInfo:[25,3,1,""],ForcefieldUreyBradleyAngleInfo:[25,3,1,""],FragDB:[26,3,1,""],Fragger:[26,3,1,""],FraggerMap:[26,3,1,""],FragmentInfo:[26,3,1,""],LoadFragDB:[24,4,1,""],LoadStructureDB:[24,4,1,""],LoadTorsionSampler:[24,4,1,""],LoadTorsionSamplerCoil:[24,4,1,""],LoadTorsionSamplerExtended:[24,4,1,""],LoadTorsionSamplerHelical:[24,4,1,""],MmSystemCreator:[25,3,1,""],PsipredPrediction:[26,3,1,""],StructureDB:[26,3,1,""],StructureDBDataType:[26,3,1,""],TorsionSampler:[27,3,1,""]},"promod3.loop.AllAtomEnv":{ClearEnvironment:[21,4,1,""],GetAllAtomPositions:[21,4,1,""],GetEnvironment:[21,4,1,""],GetSeqres:[21,4,1,""],SetEnvironment:[21,4,1,""],SetInitialEnvironment:[21,4,1,""]},"promod3.loop.AllAtomEnvPositions":{all_pos:[21,6,1,""],res_indices:[21,6,1,""]},"promod3.loop.AllAtomPositions":{AllAtomPositions:[21,4,1,""],ClearPos:[21,4,1,""],ClearResidue:[21,4,1,""],Copy:[21,4,1,""],Extract:[21,4,1,""],ExtractBackbone:[21,4,1,""],GetAA:[21,4,1,""],GetFirstIndex:[21,4,1,""],GetIndex:[21,4,1,""],GetLastIndex:[21,4,1,""],GetNumAtoms:[21,4,1,""],GetNumResidues:[21,4,1,""],GetOmegaTorsion:[21,4,1,""],GetPhiTorsion:[21,4,1,""],GetPos:[21,4,1,""],GetPsiTorsion:[21,4,1,""],GetSequence:[21,4,1,""],InsertInto:[21,4,1,""],IsAllSet:[21,4,1,""],IsAnySet:[21,4,1,""],IsSet:[21,4,1,""],SetPos:[21,4,1,""],SetResidue:[21,4,1,""],ToEntity:[21,4,1,""]},"promod3.loop.AminoAcidLookup":{GetAA:[21,5,1,""],GetAAA:[21,5,1,""],GetAAH:[21,5,1,""],GetAnchorAtomIndex:[21,5,1,""],GetAtomName:[21,5,1,""],GetAtomNameAmber:[21,5,1,""],GetAtomNameCharmm:[21,5,1,""],GetElement:[21,5,1,""],GetH1Index:[21,5,1,""],GetH2Index:[21,5,1,""],GetH3Index:[21,5,1,""],GetHNIndex:[21,5,1,""],GetHydrogenIndex:[21,5,1,""],GetIndex:[21,5,1,""],GetMaxNumAtoms:[21,5,1,""],GetMaxNumHydrogens:[21,5,1,""],GetNumAtoms:[21,5,1,""],GetNumHydrogens:[21,5,1,""],GetOLC:[21,5,1,""]},"promod3.loop.BackboneList":{"__len__":[22,4,1,""],ApplyTransform:[22,4,1,""],BackboneList:[22,4,1,""],CARMSD:[22,4,1,""],Copy:[22,4,1,""],Extract:[22,4,1,""],GetAA:[22,4,1,""],GetBounds:[22,4,1,""],GetC:[22,4,1,""],GetCA:[22,4,1,""],GetCB:[22,4,1,""],GetN:[22,4,1,""],GetO:[22,4,1,""],GetOLC:[22,4,1,""],GetOmegaTorsion:[22,4,1,""],GetPhiTorsion:[22,4,1,""],GetPsiTorsion:[22,4,1,""],GetSequence:[22,4,1,""],GetTransform:[22,4,1,""],InsertInto:[22,4,1,""],MinCADistance:[22,4,1,""],RMSD:[22,4,1,""],ReconstructCBetaPositions:[22,4,1,""],ReconstructCStemOxygen:[22,4,1,""],ReconstructOxygenPositions:[22,4,1,""],ReplaceFragment:[22,4,1,""],RotateAroundOmegaTorsion:[22,4,1,""],RotateAroundPhiPsiTorsion:[22,4,1,""],RotateAroundPhiTorsion:[22,4,1,""],RotateAroundPsiTorsion:[22,4,1,""],Set:[22,4,1,""],SetAA:[22,4,1,""],SetAroundOmegaTorsion:[22,4,1,""],SetAroundPhiPsiTorsion:[22,4,1,""],SetAroundPhiTorsion:[22,4,1,""],SetAroundPsiTorsion:[22,4,1,""],SetBackrub:[22,4,1,""],SetC:[22,4,1,""],SetCA:[22,4,1,""],SetCB:[22,4,1,""],SetN:[22,4,1,""],SetO:[22,4,1,""],SetOLC:[22,4,1,""],SetSequence:[22,4,1,""],SuperposeOnto:[22,4,1,""],ToDensity:[22,4,1,""],ToEntity:[22,4,1,""],TransOmegaTorsions:[22,4,1,""],append:[22,4,1,""],clear:[22,4,1,""],empty:[22,4,1,""],resize:[22,4,1,""]},"promod3.loop.CoordInfo":{chain_name:[26,6,1,""],id:[26,6,1,""],offset:[26,6,1,""],shift:[26,6,1,""],size:[26,6,1,""],start_resnum:[26,6,1,""]},"promod3.loop.ForcefieldBondInfo":{bond_length:[25,6,1,""],force_constant:[25,6,1,""],index_one:[25,6,1,""],index_two:[25,6,1,""]},"promod3.loop.ForcefieldConnectivity":{harmonic_angles:[25,6,1,""],harmonic_bonds:[25,6,1,""],harmonic_impropers:[25,6,1,""],lj_pairs:[25,6,1,""],periodic_dihedrals:[25,6,1,""],periodic_impropers:[25,6,1,""],urey_bradley_angles:[25,6,1,""]},"promod3.loop.ForcefieldHarmonicAngleInfo":{angle:[25,6,1,""],force_constant:[25,6,1,""],index_one:[25,6,1,""],index_three:[25,6,1,""],index_two:[25,6,1,""]},"promod3.loop.ForcefieldHarmonicImproperInfo":{angle:[25,6,1,""],force_constant:[25,6,1,""],index_four:[25,6,1,""],index_one:[25,6,1,""],index_three:[25,6,1,""],index_two:[25,6,1,""]},"promod3.loop.ForcefieldLJPairInfo":{epsilon:[25,6,1,""],index_one:[25,6,1,""],index_two:[25,6,1,""],sigma:[25,6,1,""]},"promod3.loop.ForcefieldLookup":{GetAA:[25,4,1,""],GetCharges:[25,4,1,""],GetDefault:[25,5,1,""],GetDisulfidConnectivity:[25,4,1,""],GetEpsilons:[25,4,1,""],GetFudgeLJ:[25,4,1,""],GetFudgeQQ:[25,4,1,""],GetHeavyIndex:[25,4,1,""],GetHydrogenIndex:[25,4,1,""],GetInternalConnectivity:[25,4,1,""],GetMasses:[25,4,1,""],GetNumAtoms:[25,4,1,""],GetOXTIndex:[25,4,1,""],GetPeptideBoundConnectivity:[25,4,1,""],GetSigmas:[25,4,1,""],Load:[25,5,1,""],LoadCHARMM:[25,5,1,""],LoadPortable:[25,5,1,""],Save:[25,4,1,""],SavePortable:[25,4,1,""],SetCharges:[25,4,1,""],SetDefault:[25,5,1,""],SetDisulfidConnectivity:[25,4,1,""],SetEpsilons:[25,4,1,""],SetFudgeLJ:[25,4,1,""],SetFudgeQQ:[25,4,1,""],SetInternalConnectivity:[25,4,1,""],SetMasses:[25,4,1,""],SetPeptideBoundConnectivity:[25,4,1,""],SetSigmas:[25,4,1,""]},"promod3.loop.ForcefieldPeriodicDihedralInfo":{force_constant:[25,6,1,""],index_four:[25,6,1,""],index_one:[25,6,1,""],index_three:[25,6,1,""],index_two:[25,6,1,""],multiplicity:[25,6,1,""],phase:[25,6,1,""]},"promod3.loop.ForcefieldUreyBradleyAngleInfo":{angle:[25,6,1,""],angle_force_constant:[25,6,1,""],bond_force_constant:[25,6,1,""],bond_length:[25,6,1,""],index_one:[25,6,1,""],index_three:[25,6,1,""],index_two:[25,6,1,""]},"promod3.loop.FragDB":{AddFragments:[26,4,1,""],GetAngularBinSize:[26,4,1,""],GetDistBinSize:[26,4,1,""],GetNumFragments:[26,4,1,""],GetNumStemPairs:[26,4,1,""],HasFragLength:[26,4,1,""],Load:[26,5,1,""],LoadPortable:[26,5,1,""],MaxFragLength:[26,4,1,""],PrintStatistics:[26,4,1,""],Save:[26,4,1,""],SavePortable:[26,4,1,""],SearchDB:[26,4,1,""]},"promod3.loop.Fragger":{"__getitem__":[26,4,1,""],"__len__":[26,4,1,""],AddSSAgreeParameters:[26,4,1,""],AddSeqIDParameters:[26,4,1,""],AddSeqSimParameters:[26,4,1,""],AddSequenceProfileParameters:[26,4,1,""],AddStructureProfileParameters:[26,4,1,""],AddTorsionProbabilityParameters:[26,4,1,""],Fill:[26,4,1,""],GetFragmentInfo:[26,4,1,""],GetScore:[26,4,1,""]},"promod3.loop.FraggerMap":{"__getitem__":[26,4,1,""],"__setitem__":[26,4,1,""],Contains:[26,4,1,""],Load:[26,4,1,""],LoadBB:[26,4,1,""],Save:[26,4,1,""],SaveBB:[26,4,1,""]},"promod3.loop.FragmentInfo":{chain_index:[26,6,1,""],length:[26,6,1,""],offset:[26,6,1,""]},"promod3.loop.MmSystemCreator":{ExtractLoopPositions:[25,4,1,""],GetCpuPlatformSupport:[25,4,1,""],GetDisulfidBridges:[25,4,1,""],GetForcefieldAminoAcids:[25,4,1,""],GetIndexing:[25,4,1,""],GetLoopLengths:[25,4,1,""],GetLoopStartIndices:[25,4,1,""],GetNumLoopResidues:[25,4,1,""],GetNumResidues:[25,4,1,""],GetSimulation:[25,4,1,""],SetCpuPlatformSupport:[25,4,1,""],SetupSystem:[25,4,1,""],UpdatePositions:[25,4,1,""]},"promod3.loop.PsipredPrediction":{"__len__":[26,4,1,""],Add:[26,4,1,""],Extract:[26,4,1,""],FromHHM:[26,4,1,""],FromHoriz:[26,4,1,""],GetConfidence:[26,4,1,""],GetConfidences:[26,4,1,""],GetPrediction:[26,4,1,""],GetPredictions:[26,4,1,""],PsipredPrediction:[26,4,1,""]},"promod3.loop.StructureDB":{AddCoordinates:[26,4,1,""],GenerateStructureProfile:[26,4,1,""],GetBackboneList:[26,4,1,""],GetCoordIdx:[26,4,1,""],GetCoordInfo:[26,4,1,""],GetDSSPStates:[26,4,1,""],GetDihedralAngles:[26,4,1,""],GetNumCoords:[26,4,1,""],GetResidueDepths:[26,4,1,""],GetSequence:[26,4,1,""],GetSequenceProfile:[26,4,1,""],GetSolventAccessibilitites:[26,4,1,""],GetStructureProfile:[26,4,1,""],GetSubDB:[26,4,1,""],HasData:[26,4,1,""],Load:[26,5,1,""],LoadPortable:[26,5,1,""],PrintStatistics:[26,4,1,""],RemoveCoordinates:[26,4,1,""],Save:[26,4,1,""],SavePortable:[26,4,1,""],SetStructureProfile:[26,4,1,""]},"promod3.loop.TorsionSampler":{Draw:[27,4,1,""],DrawPhiGivenPsi:[27,4,1,""],DrawPsiGivenPhi:[27,4,1,""],ExtractStatistics:[27,4,1,""],GetBinSize:[27,4,1,""],GetBinsPerDimension:[27,4,1,""],GetHistogramIndex:[27,4,1,""],GetHistogramIndices:[27,4,1,""],GetPhiProbabilityGivenPsi:[27,4,1,""],GetProbability:[27,4,1,""],GetPsiProbabilityGivenPhi:[27,4,1,""],Load:[27,5,1,""],LoadPortable:[27,5,1,""],Save:[27,4,1,""],SavePortable:[27,4,1,""],UpdateDistributions:[27,4,1,""]},"promod3.modelling":{AddModellingIssue:[35,1,1,""],AllAtomRelaxer:[32,3,1,""],BackboneRelaxer:[32,3,1,""],BuildFromRawModel:[35,1,1,""],BuildRawModel:[35,1,1,""],BuildSidechains:[35,1,1,""],CCD:[32,3,1,""],CCDCloser:[34,3,1,""],CTerminalCloser:[34,3,1,""],CheckFinalModel:[35,1,1,""],ClearGaps:[29,1,1,""],CloseGaps:[35,1,1,""],CloseLargeDeletions:[35,1,1,""],CloseSmallDeletions:[35,1,1,""],CloserBase:[34,3,1,""],CoolerBase:[34,3,1,""],CountEnclosedGaps:[29,1,1,""],CountEnclosedInsertions:[29,1,1,""],DeNovoCloser:[34,3,1,""],DirtyCCDCloser:[34,3,1,""],ExponentialCooler:[34,3,1,""],FillLoopsByDatabase:[35,1,1,""],FillLoopsByMonteCarlo:[35,1,1,""],FilterCandidates:[33,1,1,""],FilterCandidatesWithSC:[33,1,1,""],FraggerHandle:[28,3,1,""],FragmentSampler:[34,3,1,""],FullGapExtender:[29,3,1,""],GapExtender:[29,3,1,""],GenerateDeNovoTrajectories:[28,1,1,""],GetRingPunches:[33,1,1,""],GetRings:[33,1,1,""],HasRingPunches:[33,1,1,""],InsertLoop:[35,1,1,""],InsertLoopClearGaps:[29,1,1,""],IsAllAtomScoringSetUp:[35,1,1,""],IsBackboneScoringSetUp:[35,1,1,""],KIC:[32,3,1,""],KICCloser:[34,3,1,""],LinearScorer:[34,3,1,""],LoopCandidates:[31,3,1,""],MergeGaps:[29,1,1,""],MergeGapsByDistance:[35,1,1,""],MergeMHandle:[35,1,1,""],MinimizeModelEnergy:[35,1,1,""],ModelTermini:[35,1,1,""],ModellingHandle:[35,3,1,""],ModellingIssue:[35,3,1,""],NTerminalCloser:[34,3,1,""],PhiPsiSampler:[34,3,1,""],ReconstructSidechains:[36,1,1,""],RemoveTerminalGaps:[35,1,1,""],ReorderGaps:[35,1,1,""],ReportMolProbityScores:[33,1,1,""],RigidBlocks:[28,4,1,""],RunMolProbity:[33,1,1,""],RunMolProbityEntity:[33,1,1,""],SampleMonteCarlo:[34,1,1,""],SamplerBase:[34,3,1,""],ScoreContainer:[31,3,1,""],ScorerBase:[34,3,1,""],ScoringGapExtender:[29,3,1,""],ScoringWeights:[31,3,1,""],SetFraggerHandles:[35,1,1,""],SetPsipredPredictions:[35,1,1,""],SetSequenceProfiles:[35,1,1,""],SetupDefaultAllAtomScoring:[35,1,1,""],SetupDefaultBackboneScoring:[35,1,1,""],ShiftExtension:[29,3,1,""],SidechainReconstructionData:[36,3,1,""],SidechainReconstructor:[36,3,1,""],SoftSampler:[34,3,1,""],StructuralGap:[29,3,1,""],StructuralGapList:[29,3,1,""]},"promod3.modelling.AllAtomRelaxer":{GetSystemCreator:[32,4,1,""],Run:[32,4,1,""],UpdatePositions:[32,4,1,""]},"promod3.modelling.BackboneRelaxer":{AddCARestraint:[32,4,1,""],AddCBRestraint:[32,4,1,""],AddCRestraint:[32,4,1,""],AddNRestraint:[32,4,1,""],AddORestraint:[32,4,1,""],GetNonBondedCutoff:[32,4,1,""],Run:[32,4,1,""],SetNonBondedCutoff:[32,4,1,""]},"promod3.modelling.CCD":{CCD:[32,4,1,""],Close:[32,4,1,""]},"promod3.modelling.CCDCloser":{Close:[34,4,1,""]},"promod3.modelling.CTerminalCloser":{Close:[34,4,1,""]},"promod3.modelling.CloserBase":{Close:[34,4,1,""]},"promod3.modelling.CoolerBase":{GetTemperature:[34,4,1,""],Reset:[34,4,1,""]},"promod3.modelling.DeNovoCloser":{Close:[34,4,1,""]},"promod3.modelling.DirtyCCDCloser":{Close:[34,4,1,""]},"promod3.modelling.ExponentialCooler":{GetTemperature:[34,4,1,""],Reset:[34,4,1,""]},"promod3.modelling.FraggerHandle":{Get:[28,4,1,""],GetList:[28,4,1,""],LoadCached:[28,4,1,""],SaveCached:[28,4,1,""]},"promod3.modelling.FragmentSampler":{Initialize:[34,4,1,""],ProposeStep:[34,4,1,""]},"promod3.modelling.FullGapExtender":{Extend:[29,4,1,""]},"promod3.modelling.GapExtender":{Extend:[29,4,1,""]},"promod3.modelling.KIC":{Close:[32,4,1,""],KIC:[32,4,1,""]},"promod3.modelling.KICCloser":{Close:[34,4,1,""]},"promod3.modelling.LinearScorer":{GetScore:[34,4,1,""]},"promod3.modelling.LoopCandidates":{Add:[31,4,1,""],AddFragmentInfo:[31,4,1,""],ApplyCCD:[31,4,1,""],ApplyKIC:[31,4,1,""],CalculateAllAtomScores:[31,4,1,""],CalculateBackboneScores:[31,4,1,""],CalculateSequenceProfileScores:[31,4,1,""],CalculateStemRMSDs:[31,4,1,""],CalculateStructureProfileScores:[31,4,1,""],Extract:[31,4,1,""],FillFromDatabase:[31,5,1,""],FillFromMonteCarloSampler:[31,5,1,""],GetClusteredCandidates:[31,4,1,""],GetClusters:[31,4,1,""],GetFragmentInfo:[31,4,1,""],GetLargestCluster:[31,4,1,""],GetSequence:[31,4,1,""],HasFragmentInfos:[31,4,1,""],Remove:[31,4,1,""]},"promod3.modelling.ModellingHandle":{Copy:[35,4,1,""],all_atom_scorer:[35,6,1,""],all_atom_scorer_env:[35,6,1,""],all_atom_sidechain_env:[35,6,1,""],backbone_scorer:[35,6,1,""],backbone_scorer_env:[35,6,1,""],fragger_handles:[35,6,1,""],gaps:[35,6,1,""],model:[35,6,1,""],modelling_issues:[35,6,1,""],profiles:[35,6,1,""],psipred_predictions:[35,6,1,""],seqres:[35,6,1,""],sidechain_reconstructor:[35,6,1,""]},"promod3.modelling.ModellingIssue":{Severity:[35,3,1,""],is_major:[35,4,1,""],residue_list:[35,6,1,""],severity:[35,6,1,""],text:[35,6,1,""]},"promod3.modelling.ModellingIssue.Severity":{MAJOR:[35,6,1,""],MINOR:[35,6,1,""]},"promod3.modelling.NTerminalCloser":{Close:[34,4,1,""]},"promod3.modelling.PhiPsiSampler":{Initialize:[34,4,1,""],ProposeStep:[34,4,1,""]},"promod3.modelling.SamplerBase":{Initialize:[34,4,1,""],ProposeStep:[34,4,1,""]},"promod3.modelling.ScoreContainer":{Contains:[31,4,1,""],Copy:[31,4,1,""],Extend:[31,4,1,""],Extract:[31,4,1,""],Get:[31,4,1,""],GetNumCandidates:[31,4,1,""],IsEmpty:[31,4,1,""],LinearCombine:[31,4,1,""],Set:[31,4,1,""]},"promod3.modelling.ScorerBase":{GetScore:[34,4,1,""]},"promod3.modelling.ScoringGapExtender":{Extend:[29,4,1,""]},"promod3.modelling.ScoringWeights":{GetAllAtomScoringKeys:[31,5,1,""],GetAllAtomWeights:[31,5,1,""],GetBackboneScoringKeys:[31,5,1,""],GetBackboneWeights:[31,5,1,""],GetSequenceProfileScoresKey:[31,5,1,""],GetStemRMSDsKey:[31,5,1,""],GetStructureProfileScoresKey:[31,5,1,""],GetWeights:[31,5,1,""],SetAllAtomScoringKeys:[31,5,1,""],SetBackboneScoringKeys:[31,5,1,""],SetSequenceProfileScoresKey:[31,5,1,""],SetStemRMSDsKey:[31,5,1,""],SetStructureProfileScoresKey:[31,5,1,""],SetWeights:[31,5,1,""]},"promod3.modelling.ShiftExtension":{Extend:[29,4,1,""]},"promod3.modelling.SidechainReconstructionData":{disulfid_bridges:[36,6,1,""],env_pos:[36,6,1,""],is_c_ter:[36,6,1,""],is_n_ter:[36,6,1,""],loop_lengths:[36,6,1,""],loop_start_indices:[36,6,1,""],rotamer_res_indices:[36,6,1,""]},"promod3.modelling.SidechainReconstructor":{AttachEnvironment:[36,4,1,""],Reconstruct:[36,4,1,""]},"promod3.modelling.SoftSampler":{Initialize:[34,4,1,""],ProposeStep:[34,4,1,""]},"promod3.modelling.StructuralGap":{Copy:[29,4,1,""],ExtendAtCTerm:[29,4,1,""],ExtendAtNTerm:[29,4,1,""],GetChain:[29,4,1,""],GetChainIndex:[29,4,1,""],GetChainName:[29,4,1,""],GetLength:[29,4,1,""],IsCTerminal:[29,4,1,""],IsNTerminal:[29,4,1,""],IsTerminal:[29,4,1,""],ShiftCTerminal:[29,4,1,""],after:[29,6,1,""],before:[29,6,1,""],full_seq:[29,6,1,""],length:[29,6,1,""],seq:[29,6,1,""]},"promod3.scoring":{AllAtomClashScorer:[39,3,1,""],AllAtomInteractionScorer:[39,3,1,""],AllAtomOverallScorer:[39,3,1,""],AllAtomPackingScorer:[39,3,1,""],AllAtomScorer:[39,3,1,""],BackboneOverallScorer:[41,3,1,""],BackboneScoreEnv:[40,3,1,""],BackboneScorer:[41,3,1,""],CBPackingScorer:[41,3,1,""],CBetaScorer:[41,3,1,""],ClashScorer:[41,3,1,""],ConstraintFunction:[40,3,1,""],ContactFunction:[40,3,1,""],DiscoContainer:[40,3,1,""],HBondScorer:[41,3,1,""],LoadAllAtomInteractionScorer:[39,1,1,""],LoadAllAtomPackingScorer:[39,1,1,""],LoadCBPackingScorer:[41,1,1,""],LoadCBetaScorer:[41,1,1,""],LoadDefaultAllAtomOverallScorer:[39,1,1,""],LoadDefaultBackboneOverallScorer:[41,1,1,""],LoadHBondScorer:[41,1,1,""],LoadReducedScorer:[41,1,1,""],LoadSSAgreementScorer:[41,1,1,""],LoadTorsionScorer:[41,1,1,""],PairwiseFunction:[40,3,1,""],PairwiseFunctionType:[40,3,1,""],PairwiseScorer:[41,3,1,""],ReducedScorer:[41,3,1,""],SCWRL3DisulfidScore:[43,4,1,""],SCWRL3PairwiseScore:[43,4,1,""],SSAgreementScorer:[41,3,1,""],TorsionScorer:[41,3,1,""]},"promod3.scoring.AllAtomClashScorer":{DoExternalScores:[39,4,1,""],DoInternalScores:[39,4,1,""],DoNormalize:[39,4,1,""]},"promod3.scoring.AllAtomInteractionScorer":{DoExternalScores:[39,4,1,""],DoInternalScores:[39,4,1,""],DoNormalize:[39,4,1,""],Load:[39,5,1,""],LoadPortable:[39,5,1,""],Save:[39,4,1,""],SavePortable:[39,4,1,""],SetEnergy:[39,4,1,""]},"promod3.scoring.AllAtomOverallScorer":{"__getitem__":[39,4,1,""],"__setitem__":[39,4,1,""],AttachEnvironment:[39,4,1,""],CalculateLinearCombination:[39,4,1,""],Contains:[39,4,1,""],Get:[39,4,1,""]},"promod3.scoring.AllAtomPackingScorer":{DoNormalize:[39,4,1,""],Load:[39,5,1,""],LoadPortable:[39,5,1,""],Save:[39,4,1,""],SavePortable:[39,4,1,""],SetEnergy:[39,4,1,""]},"promod3.scoring.AllAtomScorer":{AttachEnvironment:[39,4,1,""],CalculateScore:[39,4,1,""],CalculateScoreProfile:[39,4,1,""]},"promod3.scoring.BackboneOverallScorer":{"__getitem__":[41,4,1,""],"__setitem__":[41,4,1,""],AttachEnvironment:[41,4,1,""],Calculate:[41,4,1,""],CalculateLinearCombination:[41,4,1,""],Contains:[41,4,1,""],Get:[41,4,1,""]},"promod3.scoring.BackboneScoreEnv":{AddPairwiseFunction:[40,4,1,""],ApplyPairwiseFunction:[40,4,1,""],ClearEnvironment:[40,4,1,""],Copy:[40,4,1,""],GetSeqres:[40,4,1,""],Pop:[40,4,1,""],SetEnvironment:[40,4,1,""],SetInitialEnvironment:[40,4,1,""],SetPsipredPrediction:[40,4,1,""],Stash:[40,4,1,""]},"promod3.scoring.BackboneScorer":{AttachEnvironment:[41,4,1,""],CalculateScore:[41,4,1,""],CalculateScoreProfile:[41,4,1,""]},"promod3.scoring.CBPackingScorer":{DoNormalize:[41,4,1,""],Load:[41,5,1,""],LoadPortable:[41,5,1,""],Save:[41,4,1,""],SavePortable:[41,4,1,""],SetEnergy:[41,4,1,""]},"promod3.scoring.CBetaScorer":{DoExternalScores:[41,4,1,""],DoInternalScores:[41,4,1,""],DoNormalize:[41,4,1,""],Load:[41,5,1,""],LoadPortable:[41,5,1,""],Save:[41,4,1,""],SavePortable:[41,4,1,""],SetEnergy:[41,4,1,""]},"promod3.scoring.ClashScorer":{DoExternalScores:[41,4,1,""],DoInternalScores:[41,4,1,""],DoNormalize:[41,4,1,""]},"promod3.scoring.DiscoContainer":{AddStructuralInfo:[40,1,1,""],AttachConstraints:[40,1,1,""]},"promod3.scoring.HBondScorer":{DoExternalScores:[41,4,1,""],DoInternalScores:[41,4,1,""],DoNormalize:[41,4,1,""],Load:[41,5,1,""],LoadPortable:[41,5,1,""],Save:[41,4,1,""],SavePortable:[41,4,1,""],SetEnergy:[41,4,1,""]},"promod3.scoring.PairwiseFunction":{Score:[40,4,1,""]},"promod3.scoring.PairwiseScorer":{DoExternalScores:[41,4,1,""],DoInternalScores:[41,4,1,""],DoNormalize:[41,4,1,""]},"promod3.scoring.ReducedScorer":{DoExternalScores:[41,4,1,""],DoInternalScores:[41,4,1,""],DoNormalize:[41,4,1,""],Load:[41,5,1,""],LoadPortable:[41,5,1,""],Save:[41,4,1,""],SavePortable:[41,4,1,""],SetEnergy:[41,4,1,""]},"promod3.scoring.SSAgreementScorer":{DoNormalize:[41,4,1,""],Load:[41,5,1,""],LoadPortable:[41,5,1,""],Save:[41,4,1,""],SavePortable:[41,4,1,""],SetScore:[41,4,1,""]},"promod3.scoring.TorsionScorer":{DoNormalize:[41,4,1,""],Load:[41,5,1,""],LoadPortable:[41,5,1,""],Save:[41,4,1,""],SavePortable:[41,4,1,""],SetEnergy:[41,4,1,""]},"promod3.sidechain":{AAToRotID:[51,4,1,""],BBDepRotamerLib:[52,3,1,""],CreateSCWRL4Particle:[49,4,1,""],DihedralConfiguration:[52,3,1,""],DisulfidScore:[44,4,1,""],FRMRotamer:[49,3,1,""],FRMRotamerGroup:[49,3,1,""],Frame:[45,3,1,""],FrameResidue:[45,3,1,""],GetDihedralConfiguration:[52,4,1,""],GetRotamericConfiguration:[52,4,1,""],LoadBBDepLib:[48,4,1,""],LoadLib:[48,4,1,""],PScoringFunction:[49,3,1,""],Particle:[49,3,1,""],RRMRotamer:[49,3,1,""],RRMRotamerGroup:[49,3,1,""],ReadDunbrackFile:[48,4,1,""],ResolveCysteins:[44,4,1,""],RotamerConstructor:[50,3,1,""],RotamerGraph:[46,3,1,""],RotamerID:[51,3,1,""],RotamerLib:[52,3,1,""],RotamerLibEntry:[52,3,1,""],SCWRL4ParticleType:[49,3,1,""],SCWRL4RotamerConstructor:[50,3,1,""],SubrotamerOptimizer:[53,4,1,""],TLCToRotID:[51,4,1,""]},"promod3.sidechain.BBDepRotamerLib":{AddRotamer:[52,4,1,""],Load:[52,5,1,""],LoadPortable:[52,5,1,""],MakeStatic:[52,4,1,""],QueryLib:[52,4,1,""],Save:[52,4,1,""],SavePortable:[52,4,1,""],SetInterpolate:[52,4,1,""]},"promod3.sidechain.FRMRotamer":{"__getitem__":[49,4,1,""],"__len__":[49,4,1,""],AddFrameEnergy:[49,4,1,""],AddSubrotamerDefinition:[49,4,1,""],ApplyOnResidue:[49,4,1,""],GetActiveSubrotamer:[49,4,1,""],GetFrameEnergy:[49,4,1,""],GetInternalEnergy:[49,4,1,""],GetInternalEnergyPrefactor:[49,4,1,""],GetNumSubrotamers:[49,4,1,""],GetProbability:[49,4,1,""],GetSelfEnergy:[49,4,1,""],GetSubrotamerDefinition:[49,4,1,""],GetTemperature:[49,4,1,""],SetActiveSubrotamer:[49,4,1,""],SetFrameEnergy:[49,4,1,""],SetInternalEnergy:[49,4,1,""],SetInternalEnergyPrefactor:[49,4,1,""],SetProbability:[49,4,1,""],SetTemperature:[49,4,1,""],ToFrameResidue:[49,4,1,""],ToRRMRotamer:[49,4,1,""]},"promod3.sidechain.FRMRotamerGroup":{"__getitem__":[49,4,1,""],"__len__":[49,4,1,""],AddFrameEnergy:[49,4,1,""],ApplyOnResidue:[49,4,1,""],ApplySelfEnergyThresh:[49,4,1,""],Merge:[49,4,1,""],SetFrameEnergy:[49,4,1,""]},"promod3.sidechain.FrameResidue":{"__getitem__":[45,4,1,""],"__len__":[45,4,1,""]},"promod3.sidechain.Particle":{GetCollisionDistance:[49,4,1,""],GetName:[49,4,1,""],GetPos:[49,4,1,""],GetScoringFunction:[49,4,1,""],PairwiseScore:[49,4,1,""]},"promod3.sidechain.RRMRotamer":{"__getitem__":[49,4,1,""],"__len__":[49,4,1,""],AddFrameEnergy:[49,4,1,""],ApplyOnResidue:[49,4,1,""],GetFrameEnergy:[49,4,1,""],GetInternalEnergy:[49,4,1,""],GetInternalEnergyPrefactor:[49,4,1,""],GetProbability:[49,4,1,""],GetSelfEnergy:[49,4,1,""],SetFrameEnergy:[49,4,1,""],SetInternalEnergy:[49,4,1,""],SetInternalEnergyPrefactor:[49,4,1,""],SetProbability:[49,4,1,""],ToFrameResidue:[49,4,1,""]},"promod3.sidechain.RRMRotamerGroup":{"__getitem__":[49,4,1,""],"__len__":[49,4,1,""],AddFrameEnergy:[49,4,1,""],ApplyOnResidue:[49,4,1,""],ApplySelfEnergyThresh:[49,4,1,""],Merge:[49,4,1,""],SetFrameEnergy:[49,4,1,""]},"promod3.sidechain.RotamerConstructor":{AssignInternalEnergies:[50,4,1,""],ConstructBackboneFrameResidue:[50,4,1,""],ConstructRRMRotamerGroup:[50,4,1,""],ConstructSidechainFrameResidue:[50,4,1,""]},"promod3.sidechain.RotamerGraph":{CreateFromFRMList:[46,5,1,""],CreateFromRRMList:[46,5,1,""]},"promod3.sidechain.RotamerLib":{AddRotamer:[52,4,1,""],Load:[52,5,1,""],LoadPortable:[52,5,1,""],MakeStatic:[52,4,1,""],QueryLib:[52,4,1,""],Save:[52,4,1,""],SavePortable:[52,4,1,""]},"promod3.sidechain.RotamerLibEntry":{FromResidue:[52,5,1,""],IsSimilar:[52,4,1,""],SimilarDihedral:[52,4,1,""],chi1:[52,6,1,""],chi2:[52,6,1,""],chi3:[52,6,1,""],chi4:[52,6,1,""],probability:[52,6,1,""],sig1:[52,6,1,""],sig2:[52,6,1,""],sig3:[52,6,1,""],sig4:[52,6,1,""]},"promod3.sidechain.SCWRL4RotamerConstructor":{AssignInternalEnergies:[50,4,1,""],ConstructFrameResidue:[50,4,1,""],ConstructFrameResidueHeuristic:[50,4,1,""]},"test_actions.ActionTestCase":{RunAction:[1,4,1,""],RunExitStatusTest:[1,4,1,""],pm_action:[1,6,1,""],pm_bin:[1,6,1,""],testPMExists:[1,4,1,""]},promod3:{SetCompoundsChemlib:[15,1,1,""],core:[12,2,0,"-"],loop:[23,2,0,"-"],modelling:[30,2,0,"-"],scoring:[42,2,0,"-"],sidechain:[47,2,0,"-"]},test_actions:{ActionTestCase:[1,3,1,""]}},objnames:{"0":["cmake","command","CMake command"],"1":["py","function","Python function"],"2":["py","module","Python module"],"3":["py","class","Python class"],"4":["py","method","Python method"],"5":["py","staticmethod","Python static method"],"6":["py","attribute","Python attribute"],"7":["std","option","option"]},objtypes:{"0":"cmake:command","1":"py:function","2":"py:module","3":"py:class","4":"py:method","5":"py:staticmethod","6":"py:attribute","7":"std:option"},terms:{"10a":36,"1aki":26,"1crn":[21,23,25,26,30,31,32,34,35,36,42,47],"1crn_cut":[30,31,35],"1crna":[26,31],"1ey":8,"1eye_rec":8,"20a":36,"2jlp":0,"30a":36,"3x3":9,"655a":26,"__doc__":[11,13],"__getitem__":[26,39,41,45,49],"__init__":[1,8,13,16],"__len__":[22,26,45,49],"__main__":[1,8],"__name__":[1,8],"__setitem__":[26,39,41],"_data":37,"_name":4,"_run":[1,4],"_xml":4,"abstract":[34,50],"boolean":[11,13,35],"break":[3,4,8,16],"byte":[10,37],"case":[0,1,5,8,13,16,22,26,27,29,32,34,35,36,37,41,44,47,49,50,52],"catch":26,"char":[22,37],"class":[0,1,3,5,8,9,10,12,13,14,17,20],"const":37,"default":[0,1,2,3,4,5,8,10,13,14,15,18,21,22,25,26,27,28,30,31,32,34],"enum":[26,51],"export":[8,21],"final":[8,18,26,28,30,31,35,40,42,44,46,47,49],"float":[9,10,21,22,25,26,27,28,29,31,32,33,34,35,36,37,39,40,41,43,44,49,50,52,53],"function":[0,1,3],"import":[0,1,5,8,11,13,16,18,20,21,22,23,25,26,27,30,31,32,34,35,36,42,47,49,50],"int":[1,9,10,11,14,21,22,24,25,26,27,28,29,31,32,33,34,35,36,37,39,40,41,45,49,50,52,53],"long":35,"new":[1,3,7,8,13,16,17,21,22,25,26,29,31,32,34,35,36,37,47,49],"null":26,"public":[8,37],"return":[1,8,9,10,11,13,14,15,21,22,24,25,26,27,28,29,31,32,33,34,35,36,37,39,40,41,43,44,45,48,49,50,51,52],"s\u00f6ding":38,"short":[8,16,37],"static":[8,14,21,25,26,27,31,36,37,39,41,46,48,52],"super":47,"switch":[8,16,40],"throw":[1,37,47,48],"true":[1,11,13,14,21,22,23,25,26,29,31,32,33,34,35,36,37,39,41,44,47,50],"try":[1,8,18,29,35,37,52],"void":37,"while":[1,4,8,14,20,21,25,35,37],a3m:[0,13],a3mtoprofil:[0,13],aa1:41,aa2:41,aa_aft:26,aa_befor:26,aa_clash:[35,39],aa_interact:[35,39],aa_pack:[35,39],aa_packing_scor:37,aa_relax_test:32,aa_res_idx:50,aa_scor:37,aa_with_rotam:47,aaa1:39,aaa2:39,aaa:[21,39],aaaaaaaa:22,aaaaggggggggggggggggggggaaaaaa:35,aafrequ:26,aafrequenciesstruct:26,aah:21,aatorotid:51,abcdefghijklmnopqrstuvwxyz0123456789abcdefghijklmnopqrstuvwxyz:35,abil:16,abl:[2,8],abort:[8,10,32,35],about:[1,4,8,10,26,35],abov:[0,1,5,8,13,16,20,22,29,31,35,37,51,52],absolut:[4,5,34],academ:8,accept:[10,13,20,31,32,34,35,36,37],acceptor:[41,50],access:[4,5,8,21,22,26,27,31,35,39,40,41,49,51],accessor:26,accord:[0,5,10,16,21,22,25,26,27,28,29,31,34,35,36,39,44,47,49,50,52],accordingli:[26,40],account:[8,54],accur:28,accuraci:[0,28,35],achiev:[10,16],acknowledg:8,across:[1,52],act:[20,32],acta:38,action_nam:16,action_unit_test:1,actiontest:1,activ:[13,14,16,35,44,49,53],active_internal_energi:53,actual:[3,8,13,16,22,26,34,35,36,40,41,42,50,52],actual_posit:34,actual_step:34,adapt:[8,25,26,32,34,35,38],add:[1,2,4,6,8,10,13,18,20,21,26,27,31,32,35,36,39,40,41,44,47,49,50,54],add_argu:11,add_custom_target:8,add_doc_depend:4,add_doc_sourc:[4,8],add_subdirectori:8,addalign:13,addcarestraint:32,addcbrestraint:32,addcoordin:26,addcrestraint:32,addedg:10,addendum:20,addfrag:[13,26],addfragmentinfo:31,addframeenergi:49,addharmonicangl:25,addharmonicbond:25,addharmonicimprop:25,addit:[3,4,11,13,14,16,20,22,23,25,26,33,35,37],addition:[1,4,16,21,25,26],addljpair:25,addmodellingissu:35,addnod:10,addnrestraint:32,addorestraint:32,addpairwisefunct:40,addperiodicdihedr:25,addperiodicimprop:25,addprofil:13,address:37,addrotam:52,addseqidparamet:26,addseqsimparamet:[23,26],addsequenceprofileparamet:26,addssagreeparamet:26,addstructur:13,addstructuralinfo:40,addstructureprofileparamet:26,addsubrotamerdefinit:49,addtorsionprobabilityparamet:26,addureybradleyangl:25,admir:8,advanc:28,advantag:25,advic:[8,16],advis:20,affect:[8,22,35,50,51],after:[1,2,4,5,8,10,13,16,21,22,25,26,27,29,31,32,34,35,37,40,52],after_c_stem:22,afterward:[8,26,35],again:[2,3,8,26,28],against:[20,39],agg:27,agglom:31,ago:1,agre:20,agreement:[13,20,26,28,41],agress:[2,10],aim:19,ala:[22,27,32,47,50,51,52],ala_cb:21,ala_h1:21,ala_h:21,alanin:[3,51],alg:[23,26,35],algorithm:[3,10,19,22,23,26],alia:29,align:[0,13,18,26,28,30,35,38,40],alignedcuboid:22,alignmenthandl:[28,35,40],alignmentlist:[0,13,35],all:[0,1,2,3,4,8,10,13,14,16,18,19,20],all_atom:[21,22,25,49],all_atom_env:21,all_atom_po:[21,50],all_atom_scor:35,all_atom_scorer_env:35,all_atom_sidechain_env:35,all_po:[21,25,32],all_scor:31,allatom:[32,35,36],allatomclashscor:35,allatominteractionscor:[35,37],allatomoverallscor:[31,35],allatompackingscor:[35,37],allatomrelax:[25,32],alleg:20,alloc:26,allow:[0,2,3,5,8,11,16,22,26,27,28,31,34,35,37,39,41,46,52],allow_multitempl:13,allow_prepro_ci:22,almost:[4,32,35],aln:[0,28,30,31,35,40],aln_sourc:13,alon:[11,20],along:[1,8,20],alongsid:20,alot:8,alpha:[9,22,41,47],alpha_bin:41,alreadi:[1,4,8,10,16,22,25,26,28,31,35,36,39,40,41,49,50,52,53],also:[1,2,4,8,11,16,20,26,27,28,31,32,33,34,35,36,44,45,46,50,52],alter:[31,34],altern:[4,5,8,31,34,35,48,50],alwai:[0,1,7,8,16,29,34,35,37],amber:[21,35],ambig:52,ambigu:[0,13,52],aminoacid:[21,22,25,27,41,51,52],aminoacidatom:[21,39],aminoacidhydrogen:21,aminoacidlookup:[21,25],among:31,amount:[18,28,52],analysi:[32,33,38],analyt:[31,52],anchor:[9,21],ancient:15,angl:[0,9,21,22,23,25,26],angle_bin:41,angle_bin_s:26,angle_force_const:25,angle_four:9,angle_on:9,angle_thre:9,angle_two:9,angstrom:[26,32],ani:[0,1,4,5,8,10,13,14,15,18,20,21,22,25,26,27,29,31,33,34,35,36,37,39,40,41,45,47,49,50],anneal:[10,31,34],annot:20,announc:[1,8],anoth:[4,14,22,29,32,35,36,44],anymor:[3,10],anyon:[8,16],anyth:[0,2,5,8,13,14,15,31,32,36,39,41],anywai:8,anywher:16,apach:[3,20],apart:[1,31,35,36,39,41],app:7,appear:20,append:[0,13,22,26,27,35,47],appendix:20,appli:[3,7,10,11,15,16,20,22,26,29,31,32,34,35,36,38,40,44,47,49,52],applic:[1,20,32,50],applyccd:31,applyde:10,applyedgedecomposit:10,applyk:31,applyonresidu:[47,49],applypairwisefunct:[40,41],applysd:25,applyselfenergythresh:[47,49],applytransform:22,approach:[0,2,10,26,28,35,37,44,47,50],appropri:[10,20,27,35,37,50],approx:35,approxim:25,arbitrari:[3,21,26,44],arbitrarili:34,archiv:20,arendal:38,arg:[1,4,13,51],arg_ca:21,arg_hd3:21,arg_sorted_scor:31,arginin:51,argpars:13,argument:[0,1,2,4,11,12],argumentpars:13,argv:13,aris:20,around:[1,4,8,9,16,22,31,32,35,39,40,41,52],arrai:[0,8,37],artifici:26,ascend:29,ask:8,asn:[51,52],asn_c:21,asn_hb2:21,asp:[21,49,51,52],asp_ha:21,asp_o:21,asparagin:51,aspart:[51,52],ass:34,assembl:13,assemblepars:13,assert:20,assertequ:8,assess:[39,40],assign:[3,10,22,26,31,34,39,41,50,53],assigninternalenergi:50,assignsecstruct:35,associ:[20,26,29,45],assum:[1,4,5,7,8,20,25,26,32,35,37,40,41,44],assur:44,astar:3,astarsolv:10,atom:[3,8,9],atom_idx:[21,25],atom_nam:[21,25],attach:[0,4,8,13,20,21,25,28,29,31,35,36,39,40,41,42],attach_view:13,attachconstraint:40,attachenviron:[31,32,34,36,39,41,42],attachview:[30,31,35],attent:[1,16],attribut:[8,13,20,26,35,36,52],author:20,authorship:20,autom:[2,4],automat:[1,8,10,11,14,16,26,30,31,37,52],automatis:8,avaibl:50,avail:[1,2,3,5,7,8,15,16,18,20,25,26,31,34,35,40,47,49],availab:20,availabl:8,averag:[31,40,44],avg:26,avg_sampling_per_posit:28,avoid:[0,3,6,11,13,15,26,32,34],awai:[16,36,49],awar:[0,3,8,35,50],awesom:[1,8],axi:[9,22],back:[1,16,25,34],backbon:[0,3,9,18,21,22,26,27,28,29,30,31],backbone_scor:35,backbone_scorer_env:35,backbonelist:[18,21],backboneoverallscor:[28,31,34,35],backbonerelax:[32,35],backbonescor:8,backbonescoreenv:[8,28,31,34,35],backbonescoreenvlisten:8,background:[2,36],backrub:[22,38],backward:37,bad:[25,35],base:[0,3,4,5,9,11,13,19,20,22,23],base_target:4,basel:[8,54],bashrc:8,basi:[4,8,16,20,32,34,48],basic:[1,2,8,11,16,27,34,35,47,49,52],bb_dep_lib:37,bb_list:[18,21,22,23,26,29,31,32,34,35,40],bb_list_on:28,bb_list_two:28,bb_score:31,bbdeprotamerlib:[35,36,37,48,50,52],becaus:[8,16,21,35,40],becom:[10,52],been:[2,3,10,16,20,24,26,31,32,35,39,41,44,52],befor:[0,1,4,7,8,13,16,22,25,26,27,29,31,32,34,35,36,37,50],begin:[1,8,21,22,34,40],behalf:20,behav:[1,52],behaviour:[0,13,39,40,50,52],behind:8,believ:54,bell:8,belong:[3,4,16,21,22,26,29,31,34,35,36,39,40,41,45,49,50],belov:26,below:[0,8,20,21,25,26,28,31,32,36,37,39,41,44,49],below_thre:26,benefici:20,besid:[2,4,10,13,26],best:[4,31,35,44],best_candid:31,beta:[9,22,33,41],beta_bin:41,better:[25,31,34,35,39,41],between:[1,3,10,13,22,25,26,28,29,31,32,34,35,36,37,39,40,41,42,43,44,45,49,52],beyond:13,biasini2013:[19,38],biasini:38,bienert:38,big:[25,37],bilinearli:52,bin:[1,8,16,18,26,27,39,41,52],bin_siz:52,binari:[1,4,8,16,17,25,26,27],bind:[0,13,20],bins_per_dimens:27,bioinformat:38,biol:38,biologi:[19,38],biophi:38,biopolym:38,bit:[1,8,16,31,35],bitwis:26,blank:8,block:3,blosum62:[13,23,26,28,40],boilerpl:20,bond:[0,3,9,22,25,26,32,33,35,36,38,41],bond_force_const:25,bond_length:[9,25],bool:[1,8,10,11,13,14,21,22,25,26,29,31,32,33,34,35,36,37,39,41,44,49,50,52],boost:[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],boost_librari:4,boost_root:2,bootstrap:[6,7],bore:34,both:[3,21,26,29,35,44,47,52],bound:[21,25,28,31,49],bracket:20,bradlei:25,branch:[4,8],branchnam:16,brew:4,bridg:[24,25,32,35,36],briefli:16,bring:8,broken:1,broyden:35,bsd:20,bug:[3,8,16],build_disulfid:36,builder:2,buildfromrawmodel:[30,35],buildrawmodel:[0,30,31,35],buildsidechain:35,buildup:[47,49],built:[4,7,25,26,40,45],bunch:[1,13,16],bundl:20,bytecod:1,c_coord:9,c_num:29,c_po:[9,22,41],c_stem:[9,23,26,29,31,32,34],c_stem_psi:34,c_str:37,c_ter:[32,50],ca_coord:9,ca_pairwise_funct:40,ca_po:[9,22],ca_pos_on:[43,44],ca_pos_two:[43,44],ca_posit:44,ca_rmsd:[23,26],cach:[2,26,28],calcul:[8,22,26,27,28,31,32,34,39,40,41,42,44,45,46,47,49,50],calculateallatomscor:31,calculatebackbonescor:31,calculatelinearcombin:[31,34,39,41],calculatescor:[39,41,42],calculatescoreprofil:[39,41],calculatesequenceprofilescor:31,calculatestemrmsd:31,calculatestructureprofilescor:31,call:[1,2,4,8,11,13,14,15,16,21,25,26,27,29,31,34,35,36,37,39,40,41,49,50,52],callabl:[13,16],calpha:35,calul:27,came:8,can:[0,1,2,3,4,5,7,8,9,10,11,13,14,15,16,18,19,21,22,23,25,26,27,28,29,30,31,32,34,35,36,37,39,40,41,42,44,45,46,47,48,49,50],cand:35,candid:[3,30],cannot:[0,8,13,20,25,26,27,29,35,37,39,41,48,50,51,52],canutescu2003:[32,38],canutescu2003b:[38,39,41,43,44],canutescu:38,cap:10,capabl:[24,30,34],captur:1,carbon:[9,22,43,49,50],carbonyl:[49,50],care:[0,8,10,31,32,35,37,41],carlo:[0,3,10,28,31,34,35,46],carmsd:[22,23,26],carri:[8,11,20],cast:37,categori:4,caus:[16,20,33],caution:21,caviti:26,cb_in_sidechain:50,cb_pack:[28,35,41],cb_packing_scor:37,cb_pairwise_funct:40,cb_po:22,cb_pos_on:[43,44],cb_pos_two:[43,44],cb_posit:44,cbeta:[28,31,34,35,41,42],cbeta_scor:[37,42],cbetaenvlisten:8,cbetascor:[8,35,37],cbpackingscor:[8,35,37],ccd:[3,30,31],ccdcloser:34,center:33,central:[22,27,41],centroid:31,certain:[1,2,4,8,10,16,26,27,28,29,35,37,39,40,41],certainli:1,ch1particl:49,ch2particl:49,ch3particl:49,ch_name:26,chain:[0,8,13,21,22,23,24],chain_idx:[8,21,31,34,35,36,39,40,41],chain_idx_list:36,chain_idx_on:40,chain_idx_two:40,chain_index:[26,34,39],chain_indic:40,chain_nam:[26,35],chainhandl:[21,22,29],chainid:0,chakravarti:38,chakravarty1999:[26,38],chanact:35,chanc:[8,10,35],chang:[1,3,4,5,8,10,16,20,21,27,28,29,32,34,35,36,39],change_frequ:[10,34],chapter:[29,33],charact:[13,20],charg:[8,20,21,25,32,49,50],charmm:[21,25,35],check:[0,1,2,3,5,8,11,13,14,16,22,25,26,30,32],check_io:37,check_xml:8,checkbasetyp:37,checkfinalmodel:35,checkmagicnumb:37,checkout:[8,16],checktypes:37,chemdict_tool:[5,7],chemic:[5,15,21,35,39],chemistri:[35,38],chemlib:[5,7],chi1:52,chi2:52,chi3:52,chi4:52,chi:52,child:13,childclass:1,chmod:8,choos:[20,31,34],chose:5,chosen:[0,13,34,35],cif:[0,5,7,13],ciiipgatcpgdyan:35,circumv:50,claim:20,clash:[3,28,31,32,34,35,39,41,42,44,47],clash_scor:42,clash_thresh:35,clashscor:[31,33,34,35],classic:48,claus:20,clean:[2,8,16],cleanli:37,clear:[14,21,22,31,35,40],clearenviron:[21,40],cleargap:29,clearpo:21,clearresidu:21,clip:13,clone:[8,18],close:[16,18,22,26,31,32,34,35,36,44],closed_posit:34,closegap:35,closelargedelet:35,closer:[3,26,30,31],closerbas:34,closesmalldelet:[32,35],closur:[32,35,38],clustal:[0,13],cluster:[3,31,37,40],cluster_thresh:[28,40],clutter:[1,8,26],cmake:0,cmake_support:[4,8,16,20],cmakecach:2,cmakelist:[1,2,4,8,16],coars:8,code:[0,1,2,3,4,5,6,7,8,11,13,14,15,16,17,18,19,20,21,22,26,27,33,35],codetest:[4,8],coil:[24,28],collect:[11,14,21,28,40],collis:49,column:[26,28],combin:[20,25,26,27,28,31,34,35,38,39,41,44,52],come:[1,4,8,11,13,35,36,42,46,52],command:[0,1,7,8,11,12],commandlin:13,comment:[16,20],commerci:[8,20],commit:[8,16],common:[8,13,20,28],commonli:[8,18,30,31,41],commun:20,comp_lib:50,compar:[3,8,22,23,26,31,32,52],comparison:[35,38,52],compat:[16,25,37],compensatori:22,compil:[1,2,3,4,8,14,16,18,20,37,55],complain:1,complaint:16,complet:[14,16,22,25,32,34,35,36,52],complex:[8,16,36,44,49,53],compli:20,complianc:20,complib_dir_contain:[5,7],complib_dir_localhost:[5,7],compon:[5,7,10,15,26,33,41,50],compoundlib:[5,50],compress:[11,26],comput:[3,8,19,20,31,33,38,39,41],concaten:21,concept:8,concern:8,condit:[8,20,27],conf:[2,8],confid:[26,41],config:[4,8],config_head:4,configur:[2,8,10,16,20,31,47],conflict:16,conform:[26,32,34,38,46,52],connect:[4,5,10,16,21,25,26,31],connectivi:5,conop:[5,21,22,25,27,41,50,51],conquer:8,consecut:[26,27,41],consequenti:20,conserv:[18,29],consid:[0,4,8,10,13,14,16,21,22,26,27,28,31,32,34,35,36,39,40,41,44,47,49,50,52,54],consider_all_nod:10,consider_hydrogen:49,consider_ligand:36,consist:[3,8,20,21,25,28,29,31,32,34,35,36,37,40,44,49,52],conspicu:20,constant:[3,25,32,39,41,53],constitut:20,constraint:[13,26,32,34,40],constraintfunct:40,constru:20,construct:[0,3,9,21,22,26,28,29,34,37],constructatompo:9,constructbackboneframeresidu:[47,50],constructcbetapo:9,constructcterminaloxygen:9,constructetd:10,constructframeresidu:50,constructframeresidueheurist:50,constructfrmrotamergroup:[47,50],constructor:[21,25,29,32,34,37,40,41,47,49],constructrrmrotamergroup:50,constructsidechainframeresidu:50,contact:[40,54],contactfunct:40,contain:[0,1,2,3,4,5],content:[8,12,17,20,23,26,42,47,55],contigu:[25,36,37],continu:[1,21,29,32,47],contract:20,contrast:45,contribut:4,contributor:20,contributori:20,control:[0,3,8,10,20,31,34,36,40,49,50,52,53],conveni:[1,7,8,18,28,31,34,35],convent:[1,51],converg:[28,31,32,34],convers:[20,37],convert:[4,5,22,25,26,27,35,37,39,41,52,53],convert_module_data:4,convertbasetyp:37,cooler:[3,30,31],coolerbas:34,cooling_factor:[10,34],coord:[26,31],coord_idx:26,coord_info:26,coordin:[3,9,26,31,32,34,35,38,39,47],coordinfo:26,cope:16,copi:[2,3,4,8,16,18,20,21,22,29,31,34,35,40],copyright:20,copyright_cmak:20,core:[0,8,9,10,11],correct:[5,25],correctli:35,correspond:[0,10,16,21,22,25,26,27,31,37,49,52],corrupt:[21,40],cotain:26,could:[1,4,5,8,13,16,25,26,35],couldn:35,count:[14,29,34,35,39,41],countenclosedgap:29,countenclosedinsert:29,counter:34,counterclaim:20,counterpart:[31,41,50],coupl:[1,8,16,35],cours:8,coutsia:38,coutsias2005:[32,38],cover:[0,1,8,12,13,14,21,25,26,28,30,34,35],coverag:[0,3,35],cparticl:49,cpp:4,cpr:[51,52],cpu:[18,25,35],cpu_platform_support:25,crambin:[26,31,34],crash:47,createalign:[31,35],createentityfromview:[36,47],createfromfrmlist:[46,47],createfromrrmlist:46,createfullview:[30,31,35],createscwrl4particl:49,createsequ:[26,31,35],creation:[25,32,49],creator:[25,32],criteria:36,criterion:[10,34],criterium:31,croak:16,cross:20,crucial:8,crude:[0,35],cryst:38,cterminalclos:34,cumul:50,current:[2,4,5,8,10,14,16,21,22,25,26,31,34,35,37,40,41,42,49,50,53],custom:[8,26,34,35,36,37,48,51],customari:20,cutoff:[24,25,31,32,36,39,41],cycl:29,cyclic:[31,32,38],cyd:[51,52],cyh:[51,52],cys_hb3:21,cys_sg:21,cystein:[25,36,44,47,51],d_bin:41,dai:11,damag:20,dampen:25,danc:38,dare:4,dat:[26,37],data1:4,data2:4,data:[0,1,3,4,8,16,17,21,23,24,25],data_:37,data_gener:[3,37,48],data_to_stor:26,data_typ:26,databas:[0,9,23,24],databs:26,datatyp:26,date:[5,7,16,20],davi:38,davis2006:[22,38],dbg:8,dcmake_install_prefix:2,deactiv:10,dead:[10,38],deal:[35,36],debug:[8,10,21],decent:15,decid:[3,8,32],decis:27,declar:[4,8,16],decod:13,decompos:[3,10],decomposit:[10,28,46],decreas:34,dedic:[4,8,16],dee:10,deep:[22,35],def:[1,8,21,35],def_angl:21,defend:20,defin:[1,4,8,9,13,14,15,20,21,22,23,24,25],definem:8,degre:[22,26,27],delet:[0,2,8,22,35,49],deliber:20,deliv:[1,26,34,35],delta_scor:34,demand:35,demonstr:26,denovoclos:34,densiti:[22,32,38],dep1:4,dep2:4,dep:4,depend:0,dependency1:4,dependency2:4,depends_on:4,depth:[26,38],deriv:[1,20,26,38,43,44],descend:35,descent:[31,32,38],describ:[0,4,7,8,10,11,17,20,21,22,26,29,30,32,33,37,39,41,44,47,48,49,52,55],descript:[0,5,13,16,20,34,35,52],descriptor:26,descsrib:10,design:[1,3,19,20],desir:[9,18,25,31,32,34,35,39,40,41],despit:3,detail:[0,9,13,16,20,25,26,27,31,33,34,35,39,41,48,52],detect:[0,11,28,30],determin:[8,11,20,25,26,31,34,40,41],determinist:28,deuterium:35,develop:[1,3,8,16],deviat:[22,33,34,52],devot:12,dict:[4,28,31,33,34,39,41],dictionari:[4,5,13,15,33,38],did:[8,26,31,35],didn:7,didnt:5,differ:[1,2,4,8,10,15,16,20,21,26,28,29,31,35,39,41,47,51,52],differenti:49,dihedr:[9,18,22,23,25,26],dihedral_angl:22,dihedral_bin:41,dihedral_idx:52,dihedral_pair:27,dihedralconfigur:52,dill:38,dimens:27,dir:[4,8,18],direct:[8,20,22,24,26,41,49,50],directli:[8,10,18,26,31,35,36,40,44,49,51,52,54],directori:[1,2,4,5,7,8],dirti:1,dirtyccdclos:34,disabl:[1,16],disable_doctest:2,disable_document:2,disable_linkcheck:2,discard:26,disclaim:20,discocontain:40,disconnect:3,discret:[39,41],discuss:[20,26],disk:[8,25,28,39,41,52],displai:[11,13,14,20],dissimilar:28,dist:41,dist_bin:41,dist_bin_s:26,distanc:[9,22,26,28,31,35,36,39,40,41,43,49],distance_thresh:28,distant:40,distinct:[21,36,52],distinguish:3,distribut:[1,8,20,25,26,27,34,37,39,41,48,52],disulfid:[0,25,32,36,43],disulfid_bridg:[25,36],disulfid_score_thresh:36,disulfidscor:[36,44],dive:[16,35],diverg:8,divers:[26,28],dng:18,do_it:[39,41],doc:[2,4,8,16,20],docker:3,dockerfil:[5,7],docstr:13,doctest:[2,8,16],document:[1,2],doe:[1,3,4,8,9,10,11,13,15,16,20,22,26,30,31,34,35,37,40,48],doesn:[8,16,29,32,34,35,52],doesnt:52,doexternalscor:[39,41],dointernalscor:[39,41],domain:28,domin:10,don:[2,10,20,31,35,50],done:[1,8,11,13,16,23,25,27,31,34,35,37],donor:41,donorm:[39,41],dont:[0,34],dont_write_bytecod:1,dost_root:2,doubt:13,down:[13,22,26,34],download:5,dpm3_runtime_profiling_level:14,draw:[22,27,34],drawback:8,drawn:[27,34],drawphigivenpsi:27,drawpsigivenphi:27,drop:8,dssp:[3,26,41],dssp_state:41,due:[0,26,31,32,35,44],dump:52,dunbrack:[3,38,48],duplic:6,dure:[1,21,32,35,37,45,52],dynam:52,dynamicspatialorgan:3,e_cut:10,e_thresh:[10,35],e_tresh:10,each:[0,8,10,13,14,20,21,22,25,26,27,28,29,31,32,33,34,35,36,37,39,41],earli:3,earlier:2,easi:8,easier:[1,8,20],easili:[4,16,35],echo:8,edg:10,edge_idx:10,editor:1,editori:20,educ:8,effect:[4,8,10,25,36,44],effici:[21,28,34,38,42],egg:26,eigen3_include_dir:2,eigen:[2,3],either:[0,8,13,16,20,21,22,27,29,31,32,34,35,36,37,39,40,41,45,49,51,52],elabor:[8,20],electron:20,electrostat:[25,32],element:[1,10,21,22,26,28,31,33,37,40,44],elimin:[10,38],els:[8,16,36,37],emerg:1,empir:[43,44],emploi:16,empti:[8,11,13,22,26,28,31,35,49],enabl:[1,2,3,11,13,15,25,26],enable_mm:2,enable_ss:2,enclos:[20,29,35],encod:0,encount:[29,34],end:[0,1,2,4,8,10,11,13,16,20,21,22,26,28,29,31,35,38],end_resnum:35,end_transl:4,endian:37,energi:[0,3,8,10,18,25,32,34,35,36,39,41,44,45,46,47,49,50,53],energy_funct:[0,36],enforc:[0,3,21,31,34,35,36,39,40,41],engin:19,enough:[8,16,25,26,35,37],ensur:[2,8,18,31,35,37],ent:[0,13,21,25,26,33,36,42],ent_seq:42,enter:[35,45],entiti:[8,13,14,20,21,22,26,33,35,42,47],entityhandl:[13,21,22,33,35,36,40],entityview:[26,27,28,33,35],entri:[0,3,8,14,25,26,31,32,33,36,41,47,50],enumer:[8,10,21,25,26,31,35,40,47,50,51,52],env:[8,18,21,25,28,32,33,35,36,39,40,41,42],env_po:[32,36],env_structur:[21,40],environ:[1,3,8,21,28,29,31,32,34,35,36,37,39],epsilon:[10,25,36,53],equal:[34,39,41,44,50],equidist:52,equival:[35,39,41],error:[0,11,13,14,26,32,35,37],especi:28,estim:[10,33,34,38,41,44,52],etc:[1,3,8,16,22,26,31,40],evalu:[4,8,32,35,39,40,41],evaluategromacsposrul:9,even:[2,8,10,20,22,25,29,35],event:[20,28],eventu:13,ever:[16,34],everi:[0,1,8,10,13,21,22,26,27,28,31,32,34,35,36,39,40,41,44,46,49,50,52,53],everyth:[1,2,3,7,8],evolut:38,evolv:42,exact:[0,7,10,13,37],exactli:[2,10,26,28,31,35,40,44,51],exampl:[0,1,2,3,8,11,13,16,17,18,20,21,23,25,26,27,28,30],example_reconstruct:47,exce:[39,41],exceed:[26,29],except:[0,3,13,20,26,29,34,35],exclud:[8,20,26],exclus:[1,8,20,25],exec:7,execut:0,exercis:20,exisit:17,exist:[0,1,2,4,8,10,11,13,14,16,21,22,26,31,32,33,34,35,37,39,40,41,48,49,51,52],exit:[0,1,11,13],exit_cod:1,exit_statu:11,exot:8,exp:34,expect:[1,7,21,25,26,35,36,40,44,53],expens:26,experiment:35,explain:[1,8],explan:8,explicit:2,explicitli:20,explor:38,exponenti:34,exponentialcool:34,expos:26,express:[20,44],ext:11,extend:[1,4,8,16,17,24,26,28],extendatcterm:29,extendatnterm:29,extended_search:[31,35],extens:[0,3,11,13,29,35],extension_penalti:29,extent:26,extern:[3,4,5,8,34],external_script:[3,8],extra:[2,3,8,16,22,37,48],extra_bin:26,extra_force_field:35,extract:[8,9,21,22,23,25,26,27,28,30,31,32,34,35,36,39,40,41,44,50],extractbackbon:21,extractloopposit:25,extractstatist:27,extrem:22,f_i:26,f_idx:40,facilit:28,factor:[10,25,34,49],fail:[0,1,8,11,14,22,31,32,35],failur:[0,8,11,13,20,35,52],fall:32,fallback:52,fals:[1,8,10,11,13,22,25,26,29,31,34,35,36,44,47,49,50],fantast:8,far:[31,35],fast:[0,9,18,19,21,25,26,27,37,39,40,41,52],fasta:[0,13,30,35],faster:[10,25,26,32,33,40],fastest:[32,35],favor:33,favourit:1,fed:[4,16],fedora:8,fee:20,feed:[4,21,31],feel:[8,16],fellow:8,fetch:[13,16,18],few:[2,8,16,25,37,42],ff_aa:25,ff_aa_on:25,ff_aa_two:25,ff_ala:25,ff_arg:25,ff_asn:25,ff_asp:25,ff_cy:25,ff_cys2:25,ff_gln:25,ff_glu:25,ff_gly:25,ff_hisd:25,ff_hise:25,ff_ile:25,ff_leu:25,ff_lookup:[25,32,35],ff_lookup_charmm:37,ff_ly:25,ff_met:25,ff_phe:25,ff_pro:25,ff_ser:25,ff_thr:25,ff_trp:25,ff_tyr:25,ff_val:25,ff_xxx:25,field:[20,35,37,52],fifti:20,figur:16,file:[0,1,2,3,4,5,8],filecheck:16,fileexist:11,fileextens:11,filegzip:11,filenam:[0,8,11,13,25,26,27,28,37,39,41,48,52],filenotfound:33,fill:[4,8,13,16,23,26,29,30,31,33,35],fillfromdatabas:[31,35],fillfrommontecarlosampl:[31,35],fillloopsbydatabas:35,fillloopsbymontecarlo:35,filo:40,filtercandid:33,filtercandidateswithsc:33,final_model:[30,35],find:[4,7,8,10,16,21,23],findchain:42,findeigen3:20,findwithin:8,fine:8,finish:53,fire:[1,7],first:[0,1,8,10,13,16,18,21,22,25,26,27,28,29,31,32,34,35,36,39,40,41,43,44,47,49,52],fit:[16,20,22,26,30,31],fix:[3,8,11,16,25,32,36,37,39,41],fix_cterm:32,fix_nterm:32,fix_surrounding_hydrogen:25,flag1:4,flag2:4,flag:[0,2,4,8,10,11,13,22,26,35,36,49,50],flanking_rot_angle_on:22,flanking_rot_angle_two:22,fletch:[26,47],fletcher:35,flexibl:[0,19,36,44,47,49,50,53],flip:52,flood:26,flush:[1,16],fold:38,folder:[2,4,8,16,18,37],follow:[0,1,2,4,5,8,10,11,16,18,20,22,23,25,26,28,29,30,31,35,36,37,39,41,47,49,50,51,52],fontsiz:27,forbidden:8,forc:[25,32,35],force_const:[25,32],forcefield:23,forcefieldaminoacid:25,forcefieldbondinfo:25,forcefieldconnect:25,forcefieldharmonicangleinfo:25,forcefieldharmonicimproperinfo:25,forcefieldljpairinfo:25,forcefieldlookup:[25,32,35,37],forcefieldperiodicdihedralinfo:25,forcefieldureybradleyangleinfo:25,forg:16,forget:[1,8],form:[14,20,24,25,26,30,35,40,52],formal:[31,32,49,52],format:[0,5,13,20,26,48],formula:33,forward:16,found:[1,3,4,8,11,13,16,19,21,23,26,28,31,32,33,34,35,36,44,46,52],foundat:1,four:[9,34],fraction:[26,28,32,34],frag_db:[23,26,31,37],frag_info:26,frag_length:[23,26,28],frag_map:26,frag_po:[23,26,28],frag_residu:[23,26],frag_seq:[23,26],frag_siz:26,fragdb:[23,24,26,31,35,37],fragger:[13,23,26,28,34,35],fragger_handl:[13,35],fragger_map:26,fraggerhandl:[0,13,26,28,35],fraggermap:[26,28],fragment:[0,3,9,13,22,23,24],fragment_db:35,fragment_handl:28,fragment_info:26,fragment_length:[26,28],fragmentinfo:[26,31],fragments_per_posit:28,fragmentsampl:34,frame:[3,16,35,36],frame_energi:49,frame_residu:[45,47],frameresidu:[45,49,50],framework:[8,19,38],free:[0,8,20,35,51,52],frequenc:[26,34],frm:36,frmrotam:[44,49,53],frmrotamergroup:[44,46,49,50],from:[0,1,2,3,4,5,6,7,8,9,10,11,13,16,18,20,21,22,23,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42],fromhhm:26,fromhoriz:26,fromresidu:52,front:[1,11,16],fstream:37,fudg:25,fulfil:[26,52],full:[0,1,3,8,10,21,25,26,29,30,31,34,35,36,47,49,50],full_seq:[29,31],fullgapextend:[29,35],fulli:[8,16,21,22,26,29,30,36],function_typ:40,functions_specific_to_your_act:8,fundament:37,funni:[2,8],further:[10,28,29,35,36,37],furthermor:37,futur:[3,25,26],gamma:[40,41,44],gamma_bin:41,gap:[0,3,9,18,24,25],gapextend:[29,35],gapfre:26,gapless:[0,13],gather:[4,12,16,26,28,47,49,52],gauc:52,gauch:52,gauche_minu:52,gauche_plu:52,gciiipgatcpgdyan:[31,35],gener:[0,1,2,3,5,8,10,13,14,16,18,19,20,23,24],generatedenovotrajectori:28,generatestructureprofil:26,geom:[21,22,25,26,28,32,35,44,49],geometr:[9,23],geoom:43,get:[0,1,2,7,8,16],getaa:[21,22,25],getaaa:21,getaah:21,getactivesubrotam:49,getallatomposit:[21,32,36],getallatomscoringkei:31,getallatomweight:31,getanchoratomindex:21,getangl:47,getangularbins:26,getatomcount:8,getatomnam:21,getatomnameamb:21,getatomnamecharmm:21,getaveragescor:31,getbackbonelist:[23,26],getbackbonescoringkei:31,getbackboneweight:31,getbins:27,getbinsperdimens:27,getbound:22,getc:22,getca:22,getcb:22,getchain:29,getchainindex:29,getchainnam:29,getchains:8,getcharg:25,getclust:31,getclusteredcandid:31,getcollisiondist:49,getconfid:26,getcoordidx:26,getcoordinfo:26,getcpuplatformsupport:25,getcreationd:5,getdefault:[25,32,35],getdefaultlib:5,getdihedralangl:26,getdihedralconfigur:52,getdistbins:26,getdisulfidbridg:25,getdisulfidconnect:25,getdsspstat:26,getel:21,getenviron:21,getenvsetdata:8,getepsilon:25,getfirstindex:21,getforcefieldaminoacid:25,getfragmentinfo:[26,31],getframeenergi:49,getfudgelj:25,getfudgeqq:25,geth1index:21,geth2index:21,geth3index:21,getheavyindex:25,gethistogramindex:[22,27],gethistogramindic:27,gethnindex:21,gethydrogenindex:[21,25],getindex:[21,25],getinternalconnect:25,getinternalenergi:49,getinternalenergyprefactor:49,getlargestclust:31,getlastindex:21,getlength:29,getlist:28,getlooplength:25,getloopstartindic:25,getmass:25,getmaxnumatom:21,getmaxnumhydrogen:21,getn:22,getnam:[47,49],getnonbondedcutoff:32,getnum:31,getnumatom:[21,25],getnumb:31,getnumcandid:31,getnumchain:8,getnumcoord:26,getnumfrag:26,getnumhydrogen:21,getnumloopresidu:25,getnumresidu:[8,21,25],getnumstempair:26,getnumsubrotam:49,geto:22,getolc:[21,22],getomegators:[21,22],getoxtindex:25,getpeptideboundconnect:25,getphiprobabilitygivenpsi:27,getphitors:[21,22,47],getpo:[21,49],getpotentialenergi:25,getpredict:26,getprob:[27,49],getpsiprobabilitygivenphi:27,getpsitors:[21,22,47],getr:33,getresiduedepth:26,getringpunch:33,getrotamericconfigur:52,getscor:[26,34],getscoringfunct:49,getselfenergi:49,getseqr:[21,40],getsequ:[21,22,26,31],getsequenceprofil:26,getsequenceprofilescoreskei:31,getsigma:25,getsimul:25,getsolventaccessibilitit:26,getstemrmsdskei:31,getstructureprofil:26,getstructureprofilescoreskei:31,getsubdb:26,getsubrotamerdefinit:49,getsystemcr:32,gettemperatur:[34,49],gettransform:22,getversionnumb:37,getweight:[28,31],ggg:35,gggaggg:35,gggggggggggggggggggg:35,git:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15],gitignor:8,gitlab:54,give:[4,8,16,20,23,31,34,35,49],given:[0,1,3,4,8,9,10,11,13,14,21,22,25,26,27,28,29,30,31,32,33,34,35,36,37,39,40,41,44,47,49,50,52],glass:38,gln:[51,52],gln_ne2:21,global:[15,26,31,35,37],glu:[21,49,51,52],glu_oe1:21,glutam:51,glutamin:51,gly:[35,36,47,50,51],gly_n:21,glycin:[3,22,26,32,36,51],goal:[1,10,30],goe:[2,8,14,16,35,52],goldfarb:35,goldstein1994:[10,38],goldstein:[10,38],good:[4,8,18,25,26,35],goodwil:20,got:2,govern:20,grain:8,grant:20,graph:3,graph_initial_epsilon:36,graph_intial_epsilon:36,graph_max_complex:36,graphminim:[10,46],greatest:5,grep:2,grid:26,gromac:9,grossli:20,group:[4,14,24,26,27,41,44,45,46,47],group_definit:[27,41],group_idx:41,guarante:[26,28,31,34,36,37],gui:[8,27],guid:32,guidelin:[8,37],gzip:[0,5,11,13],haa:38,hand:[0,2,4,13,49],handl:[3,8,9,13,19],handler:28,happen:[1,8,25,26,28,29,34,35,49],hard:43,hardwar:18,harmless:20,harmon:[25,32],harmonic_angl:25,harmonic_bond:25,harmonic_improp:25,hasattr:35,hasdata:26,hasfraglength:26,hasfragmentinfo:31,hash:26,hasringpunch:33,have:0,hbond:[28,35,41,50,51],hbond_scor:37,hbondscor:[35,37],hdrogen:49,headach:8,header1:4,header2:4,header3:4,header4:4,header:[0,2,4,16,17],header_output_dir:4,headlin:8,heavi:[21,25,36,39,50],heavili:[26,47],helic:[22,24,25,28,35,41],helix:[18,22,34,47],hello:37,hello_world:8,hellyeah:18,help:[0,1,2,4,7,8,13,16,18,25,41],helpactiontest:1,helper:4,hen:26,henc:[8,14,21,26,37],here:[0,1,2,4,8,11,13,14,16,18,19,21,22,25,26,27,28,30,31,32,34,35,37,39,41,44,48,52],herebi:20,herein:20,het:35,heurist:[35,50],heuristicprocessor:21,hgfhvhefgdntngcmssgphfnpygkehgapvdenrhlg:0,hhblit:[0,13],hhm:[0,13,26,31],hhsearch:26,hidden:49,hide:[8,16],hierarch:[31,40],hierarchi:15,high:[3,8,16,30,35],high_resolut:22,higher:[31,40,41],highest:15,highli:[2,8],hint:13,histidin:[25,51],histogram:[27,34],histori:16,hit:[1,10,16,27,32],hmm:38,hold:20,home:[4,5],homo:[0,13],homolog:[0,12,18,19,35,38],homologu:26,honor:35,honour:35,hook:8,horiz:26,host:[4,7,8,16],hotfix:16,how:[1,7],howev:[5,20,26],hparticl:49,hpp:37,hsd:[51,52],hse:[51,52],html:[2,8,16],http:[7,8,18,19,20,54],hybrid:52,hydrogen:[3,21,22,25,35,38,41,49,50],hyphen:1,i_loop:[25,36],id_:37,idea:[1,8,21,23,25,26,35,40,49,53],ideal:[22,32,53],ident:[3,26,27,41,52],identif:20,identifi:[0,13,14,20,26,31,35,36,39,41,50,52],idx:[10,21,22,25,26,28,32,40,49],idx_ca_res_37:21,idxhandl:8,iff:[26,29,33],ifstream:37,ignor:[0,25,32,35],iii:20,illustr:26,image_nam:[5,7],imagehandl:22,imagin:8,imaginari:1,img:[7,22],immedi:[1,8,15,16],impact:[0,25,26],implement:[3,16,19,26,28,29,32,34,35,37,43,44,46,47,50,51,54],impli:20,implicit:2,improp:25,improv:[3,20,25,35,38,44],in_dir:4,in_fil:8,in_path:4,in_stream:37,in_stream_:37,inabl:20,inaccur:25,inaccurate_pot_energi:25,inact:53,inactive_internal_energi:53,incident:20,incl:[25,26,35],includ:[2,3,8,11,16,18,20,21,25,26,29,31,33,35,37,39,41,47],include_ligand:35,inclus:[20,35],incompat:[31,32],incomplet:[35,48],inconsist:[10,13,21,22,25,26,29,31,32,36,40,49],inconveni:16,incorpor:20,increas:[0,10,28,31,32,35,50],incur:20,indemn:20,indemnifi:20,independ:[0,3,25,36,48],index:[8,10,21,22,25,26,27,28,29,31,32,33,34,35,39,40,41,45,49,50,52],index_four:25,index_on:25,index_thre:25,index_two:25,indic:[8,10,11,13,20,21,22,25,26,27,28,29,31,32,35,36,40,44,47,49],indirect:20,individu:[20,39,41],inf:[10,32,35],infin:32,infinit:32,influenc:[13,28,40],info:[26,31,35,40],inform:[0,5,7,8,13,16,20,22,23,26,28,29,31,34,35,38,40,41,42,54],infring:20,inherit:[1,39,40,41,46],init:16,init_bb_list:34,init_frag:34,initi:[3,10,21,22,26,28,31,32,34,35,36,39,40,41,46,49,50,52],initial_bb:31,initial_epsilon:[10,53],initialis:1,inlin:37,inner:14,input:[0,1,3,13,16,18,25,26,27,28,32,34,35,36,39,40,41,44,48,53],insert:[21,22,29,31,34,35,53],insertinto:[21,22,31],insertloop:[29,35],insertloopcleargap:[29,31,35],insid:[1,4],insight:16,instanc:[3,8,13,24,25,37,54],instead:[0,1,2,3,4,8,11,26,28,29,31,34,35,50],institut:20,instruct:2,int16_t:37,int32_t:37,int_32_t:37,integ:[8,13,21,40],intend:[1,8,34],intent:26,intention:20,interact:[3,8,25,32,39,40,41,43,44,45,49],intercept:[39,41],interest:[1,10,25,26,34,37,49,52],interfac:[0,3,4,8,20,50],intermedi:8,intern:[0,1,3,4,5,8,16,21,24,25,26,27,28,31,32,34,35,36,37,38,39,40,41,46,49,50,53],internal_e_prefac:50,internal_e_prefactor:49,internal_energi:49,internet:8,interpl:52,interpol:[40,52],interpret:[8,11],intervent:8,intrins:2,introduc:[1,3,4,8,16,32,35],invalid:[8,21,25,26,29,32,35,36,39,40,41,45,49,51,52],invok:[2,4,8,15,16],involv:[16,30,44],iostream:37,irrevoc:20,is_c_ter:[25,36],is_cter:25,is_major:35,is_n_ter:[25,36],is_nter:25,isallatomscoringsetup:[31,35],isallset:21,isanyset:21,isbackbonescoringsetup:35,isctermin:29,isempti:31,isen:14,isntermin:29,isoleucin:51,isset:21,issimilar:52,issourc:37,issu:3,istermin:29,isvalid:47,item:[1,8,16,21,22,25,26,35,40],iter:[10,26,27,28,31,32,34,35,49],itself:[3,4,8,16,26,34,36,37,39,41,49],januari:20,job:[8,26,34,35],johner:38,join:[8,21,23,26,31,32,34,36],jone:38,jones1999:[26,38],journal:38,json:[0,13],jupyt:7,just:[1,2,8,13,15,16,23,25,26,29,31,35,50],kabsch1983:[26,38],kabsch:38,keep:[0,1,2,4,5,8,13,16,30],keep_non_converg:31,keep_sidechain:[8,36],kei:[0,13,26,28,31,34,35,39,40,41],kept:[8,16,25,31,32,36,45],kernel:38,keyword:27,kic:[30,31],kicclos:34,kick:13,kill_electrostat:25,kind:[1,8,20],kinemat:32,know:[2,52],knowledg:52,known:[4,11,21,40,50],krivov2009:[10,38,47],krivov:38,kwarg:1,l_e:49,lab:48,label:[16,25],lack:35,languag:[4,20],larg:[5,27,32,35],larger:[10,14,22,26,35,50],largest:[28,31,44],last:[1,4,21,22,25,29,31,32,34,35,40,41,48],last_psi:22,later:[1,8,10,21,47],latest:[2,5,7,8],latter:[0,5,16,35],launcher:[4,8],law:20,lawsuit:20,layer:44,layout:[26,37],lazi:49,lbfg:35,leach1998:[10,38],leach:38,lead:[0,8,9,11,22,25,31,32,36,39,41,48],least:[0,2,4,8,10,16,20,22,25,26,35,39,41,44],leav:1,left:[11,32],legal:[8,20],lemon:38,len:[22,23,25,26,28,31,35,36,41,47],length:[0,9,10,21,24,25,26,27,28,29,31,32,34,35,36,37,39,40,44],length_dep_weight:35,length_depend:31,less:[0,10,16,22,25,26,27,31,35,39,41,52],let:[1,7,8,22,26,31,47],letter:[3,5,21,22,26,27,34,51],leu:51,leu_h:21,leucin:51,level:[2,3,8,14,15,16,30,35,49],lexicograph:35,liabil:20,liabl:20,lib64:8,lib:[5,7,37],libexec:[4,8],libpromod3_nam:4,librari:[0,3,4],library1:4,library2:4,licenc:48,licens:3,licensor:20,life:16,ligand:[3,35,36,50],like:[0,1,4,7,8,16,35,37,48],limit:[0,3,20,26,32,35],line:[0,1,7,8,9,12],linear:[26,28,31,34,39,40,41],linear_weight:[31,34,39,41],linearcombin:31,linearscor:34,link:[0,2,4,8,16,20,21,25,26,28,34,36,39,40,41,42],link_cmd:4,linkcheck:[2,8,16],linker:[4,35],linker_length:35,list:[0,1,2,3,4,8,9,10,11,13,20,21,22,25,26,27,28,29,30,31,32,33,34,35,36,37,39,40,41,44,45,46,47,49,50,52,53],listen:8,literalinclud:8,litig:20,littl:[4,8,16,37],live:[4,8],lj_pair:25,load:[1,8,13,15,21,23],loadalign:[30,35],loadallatominteractionscor:39,loadallatompackingscor:39,loadamberforcefield:35,loadbb:26,loadbbdeplib:[0,36,47,48],loadcach:28,loadcbetascor:[31,34,41,42],loadcbpackingscor:41,loadcharmm:25,loadcharmmforcefield:35,loaddefaultallatomoverallscor:39,loaddefaultbackboneoverallscor:41,loadent:[0,13],loadfragdb:[23,24,31,35],loadhbondscor:41,loadlib:[0,36,48],loadpdb:[8,21,23,25,26,30,31,32,34,35,36,42,47],loadport:[25,26,27,37,39,41,52],loadreducedscor:41,loadsequenceprofil:[13,26,31],loadssagreementscor:41,loadstructuredb:[23,24,26,31,35],loadtorsionsampl:[22,24,27,34],loadtorsionsamplercoil:[24,31,35],loadtorsionsamplerextend:24,loadtorsionsamplerhel:24,loadtorsionscor:41,local:[2,5,7,25,26,27,39,41,52],localhost:7,locat:[2,3,4,5,10,22,24,26,29,37,39,41,49],log:[11,16,33,35,49,50],logic:0,loginfo:33,lone:49,lone_pair:49,longest:26,look:[5,8,11,16,22,26,36,40,50],lookup:[9,21,23],looooooong:10,loop:[0,3,8,13,18,19,21],loop_candid:31,loop_length:[25,26,31,36],loop_main:8,loop_po:25,loop_seq:31,loop_start_indic:[25,36],loopcandid:[28,30],loss:[16,20],lossi:26,lost:[1,16],lot:[1,8,13,16],low:[1,8,10,50],lower:[31,34,35,39,41],lowest:[31,34,49],lowest_energy_conform:34,lysin:51,machin:[25,26,27,37,39,41,52],macro:[4,8],made:[4,20,52],magic:[8,37],mai:[0,1,2,4,8,11,13,16,20,21,25,29,32,35],mail:20,main:[8,35,37,52],mainli:[21,34],maintain:[8,16],maintin:34,major:[16,35],makefil:[2,8],makestat:52,malfunct:20,malici:16,man:[2,8],manag:[4,8,20,42],mani:[11,13,26,32,33,35,50],manipul:22,manner:[8,10,34],manual:[1,2,5,8,9,16,26,31,34,35,37,49],map:[0,13,21,22,26,28,33,36],mariani:38,mark:[4,20,50],mass:25,massiv:28,master:[8,16],mat3:9,mat4:[9,22,28,35],match:[0,4,13,22,25,26,27,31,32,34,35,40,41],materi:[1,8],math:33,mathemat:[31,32],matplotlib:27,matric:38,matrix:[9,26],matter:[4,7,54],max:[9,10,21,29,33,35,36,41,52,53],max_alpha:41,max_beta:41,max_complex:[10,53],max_count:[39,41],max_d:41,max_dev:34,max_dist:[31,40],max_extens:35,max_gamma:41,max_iter:[28,31,35],max_iter_lbfg:35,max_iter_sd:35,max_length:29,max_loops_to_search:35,max_n:10,max_num_all_atom:35,max_p:50,max_prob:49,max_res_extens:35,max_step:32,max_to_show:14,max_visited_nod:10,maxfraglength:26,maxim:[10,26,28,31,32,34,35,38,40,41],maximum:[10,26,31,32,34,49,50],mc_closer:34,mc_cooler:34,mc_num_loop:35,mc_sampler:34,mc_scorer:34,mc_step:[10,35],mcsolv:10,mean:[4,8,13,16,20,21,25,32,35,36],meaning:[26,31],meant:[18,21,26,33,35,50],measur:28,mechan:[18,20,31,32,34,35,40],meddl:[7,35],media:20,medium:20,meet:20,member:[8,13,31,35],memori:[10,26,35,37],mention:[1,2],merchant:20,mere:20,merg:[16,25,28,29,31,35,36,40,49],merge_dist:35,mergegap:29,mergegapsbydist:35,mergemhandl:35,mess:[8,16,40],messi:16,met:51,methionin:[35,51],method:[0,1,10,13,21,25,26,27,32,35,36,37,50],metric:40,metropoli:[10,31,34],mhandl:[29,30,31,35],middl:16,might:[10,25,26,31,32,34,40,49,50,53],min:[31,41],min_alpha:41,min_beta:41,min_candid:31,min_d:41,min_dist:40,min_gamma:41,min_loops_requir:35,min_scor:31,mincadist:22,mind:[1,8],minim:3,minimizemodelenergi:35,minimum:[22,26,28,44],minor:[3,25,35],mirror:37,miser:14,mismatch:[21,35,40],miss:[0,11,13,25,35],mix:[0,4],mkdir:[2,8],mm_sy:[25,32],mm_sys_output:25,mm_system_cr:32,mmcif:[5,11],mmsystemcr:[25,32],mod:8,mode:[1,52],model_termini:35,modelling_issu:35,modellinghandl:[3,29,31,35],modellingissu:35,modeltermini:35,modif:[20,35],modifi:[8,16,20,22,31,35],modified_crambin:31,modul:[1,3],modular:19,module_data:4,mol:[8,9,18,21,22,23],molecular:[18,32,35],molprob:30,molprobity_bin:33,molprobity_execut:33,moment:8,monitor:1,monolith:8,mont:[0,3,10,28,31,34,35,46],montecarlo:3,mood:8,more:[1,2,4,7,8,10,13,14,16,20,28,35,44,49,54],most:[0,3,4,5,8,22,25,26,27,28,31,32,35,39,41,48,50],mostli:[4,16,49],motion:[22,38],mount:[5,7],movabl:25,move:[2,3,8,16,25,31,32,34,35,37],movement:28,mpscore:33,msg:11,msgerrorandexit:11,msm:3,msse4:2,much:[10,26,35],multi:18,multipl:[0,2,3,4,8,13,14,18,25,28,31,35,36,39,41],multipli:[10,34],multitempl:13,must:0,mutlipl:13,my_db_on:26,my_db_two:26,my_script:7,myclass:37,myclassptr:37,mytrg:0,n_coord:9,n_num:29,n_po:[9,22,41],n_stem:[9,23,26,29,31,32,34],n_stem_phi:34,n_ter:[32,50],naivesolv:10,name:[0,1,3,4,5,7,8,11,13,14,20,21,25,26,27,29,31,33,35,44,48,49,51,52],name_pymod:4,namespac:[7,13,37],nan:[32,35,52],nativ:37,necessari:[8,22,34,40],necessarili:[20,53],need:[1,2,3,4,5,8,11,13,15,16,22,25,26,27,28,31,32,35,36,37,39,40,41,47],need_config_head:4,neg:[1,10,25,32,40],negelect:[0,35],neglect:[28,32,45,49],neglect_size_on:31,neglig:20,neighbor:[8,21,35],neighbour:[35,52],network:[22,44],never:[13,16,26,31,35,36,37,39,41],nevertheless:[8,49],new_default:25,new_env_po:21,new_po:21,new_res_nam:49,new_siz:22,newli:[5,21,34],next:[1,8,16,22,27,28,29,37],next_aa:34,nglview:7,nice:8,nitrogen:[9,22,32,43,49,50],nobodi:1,node:10,node_idx:10,node_idx_on:10,node_idx_two:10,non:[0,4,10,13,16,20,24,25,27,28,29,31,32,35,37,47,48,50],non_rotamer:52,nonbonded_cutoff:[25,32],none:[13,26,28,33,34,35,36,49],nonredund:26,nonzero:52,norm:41,normal:[20,39,41],normalis:40,notabl:26,note:[0,2,8,13,14,21,22,25,26,28,31,32,34,35,36,37,39,40,41,47,50,51],notebook:7,noth:[0,4,8,13,14,20,34,49],notic:[1,4,16,20],notwithstand:20,novel:[19,38],novo:3,now:[3,8,14,16,18,22,26],nparticl:49,nterminalclos:34,null_model:31,num:[23,28,31,32,36],num_frag:[26,35],num_gap_extens:29,num_loop:31,num_residu:[21,25,34,36,39,40,41],num_residues_list:36,num_trajectori:28,number:[0,1,8,9,10,13,14,18,21,22,24,25,26,27,28,29,31,32,34,35,36,37,39,40,41,42,44,45,49,52],numer:35,numpi:[27,34],o_po:22,object:[0,3,8,13,14,20,21,22,23],oblig:20,observ:[10,26,32,50,53],obtain:[10,18,20,23,35],obviou:16,occupi:[45,50],occur:[21,28,35,40,41],ocparticl:49,odd:26,off:[1,8,14,35],offend:33,offer:[6,20,24,30,49,52],offset:[0,3,13,26,31,35],ofstream:37,often:[8,11,13,32],olc:22,old:[33,35],oligom:[0,13,30],oligomer:3,omega:[21,22],onc:[1,3,8,16,25,28,31,32,34,46,52,53],one_letter_cod:[21,23,26,31,32,34,36],onli:[0,1,2,4,8,10,11,13,14,15,16,20,21,22,25,26,28,29,31,33,34,35,36,37,39,41,44,47,48,50],only_longest_stretch:26,onto:[1,22,26,28],oparticl:49,open:[13,25,26,27,37,39,41,52,54],openmm:[2,18,25,32],openstructur:[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],oper:[3,10,16,18,21,26,40],opt:[11,13,16],optim:[0,2,3,10,13,25,26,27,31,35,39,41,44,47,48,52],optimis:8,optimize_subrotam:[36,44],option:[0,2,3,5,7,13,26,31,32,35,52],order:[0,5,13,21,25,26,29,31,35,37,40],org:20,organ:[8,26,52],orient:[9,32,41],orig_indic:[31,33],origin:[5,7,9,13,16,20,22,26,31,34,35,40,53],ost:[0,1,2,3,4],ost_complib:[5,7],ost_double_precis:2,ost_ent:33,ost_librari:4,ost_root:[2,8],other:[0,1,2,3,4,8,10,14,16,20,21,22,31,32,35,36,39,41,42],other_index:22,other_particl:49,other_res_index:21,otherwis:[1,4,8,10,14,16,20,21,22,25,26,28,29,31,32,34,39,40,41,49,52],our:[4,5,8,16,26,31],out:[0,1,2,4,8,14,16,20,21,25,26,27,28,29,31,34,47,52],out_path:4,out_po:25,out_stream:37,out_stream_:37,outdat:[5,7],outer:[14,26],outlier:33,output:0,output_dir:4,outsid:[8,40],outstand:20,over:[2,4,13,16,26,32,34,35,49],overal:[10,34,40,46],overhead:25,overlap:[25,34,35,36],overli:16,overload:37,overrid:[2,5,25,50],overridden:4,overriden:5,overview:[8,16],overwrit:31,overwritten:25,own:[1,3,4,5],owner:20,ownership:20,oxt:[9,21,25],oxygen:[22,35,43,49,50],pack:21,packag:[4,8,16],pad:[22,37],page:[2,8,20],pai:1,pair:[9,25,26,27,28,32,34,36,37,39,40,41,44,49,52],pairwis:[3,8,10,22,28,31,35,39],pairwise_energi:10,pairwisefunct:[40,41],pairwisefunctiontyp:40,pairwisescor:[8,35],paper:[43,44,47,49],paragraph:[1,8],parallel:26,paramet:[1,4,8,9,10,11,13,14,15,21,22,24,25,26,27,28,29,31,32,33,34,35,36,38,39,40,41,43,44,45,46,48,49,50,51,52,53],parameter_index:26,parametr:[32,35,36,49,50],parent:35,pars:[0,11,12],parser:12,part:[0,1,8,16,18,20,21,26,34,35,40,44,46,47,49],partial:29,particip:[36,44],particl:[3,25,26,32,41,43,44,45,47],particle_typ:49,particular:[8,10,20,26,31,32,34,49,52],partner:[39,40,41],pass:[13,16,21,25,26,28,29,32,34,44,45,49,50],past:[8,16,22,29],patent:20,path:[1,2,4,5,8,11,16,18,25,26,27,33,39,41,52],path_to_chemlib:15,path_to_dockerfile_dir:5,path_to_promod3_checkout:6,pattern:38,paus:14,pdb:[0,5,8,11,13,18,21,22,23,24,25,26,30,31,32,33,34,35,36,42,47],penal:[29,35],penalti:[29,35],penultim:3,peopl:16,pep:[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],peptid:[3,21,23,25,26,35,36,47],per:[4,8,10,12,16,21,27,31,34,35,39,40,41,44],percent:20,percentag:33,perfect:8,perfectli:8,perform:[0,10,16,18,19,20,25,28,31,32,33,34,35,37,40,44],period:25,periodic_dihedr:25,periodic_improp:25,permiss:[8,20],permut:10,perpetu:20,pertain:20,phase:25,phe:[51,52],phenix:33,phenylalanin:51,phi:[21,22,26,27,32,34,41,47,50,52],phi_bin:[41,52],phi_handl:47,philippsen:38,phipsisampl:34,phosphoserin:35,phrase:8,pick:[31,34],pictur:8,piec:[8,28],pipelin:[0,3,14],pivot:[31,32,34],pivot_on:[31,32],pivot_thre:[31,32],pivot_two:[31,32],place:[1,2,4,8,11,13,16,20,26],plain:[0,13],plan:16,plane:33,platform:[18,25],playground:7,pleas:[2,8,16,28,31,32,35,54],plot:27,plt:27,plu:[8,13,15,26,44,49],pm3_csc:16,pm3_openmm_cpu_thread:[18,25,35],pm3_runtime_profiling_level:14,pm3argpars:[0,11,12],pm3argumentpars:[0,11,13],pm_action:[1,4,8],pm_action_init:8,pm_bin:1,png:27,point:[2,7,8,13,15,21,26,28,34,35,40,52],pointer:[2,8,37],polar:[49,50],polar_direct:49,polici:8,pop:[16,31,34,40],popul:[2,16],port_str_db:26,portabl:[4,17,25,26,27],portable_binary_seri:37,portable_fil:4,portablebinarydatasink:37,portablebinarydatasourc:37,pos_end:28,pos_on:28,pos_start:28,pos_two:28,posit:[3,8,9],possibl:[0,3,8,10,13,16,20,22,25,26,27,29,31,32,34,35,36,37,39,40,41,44,46,49,51,52],post:13,postprocess:36,pot:25,pot_:32,potenti:[10,23,25,26,31,32,35,36,37,38,41],power:20,pqhpg:0,practic:[4,8,25,26],pre:[8,16],pre_commit:[8,16],preceed:36,precis:[2,31,35],precomput:23,pred:40,predefin:[4,18,25,35,39,41],predict:[13,26,28,35,38,40,41],prefactor:49,prefer:[2,4,20,26,52,53],prefilt:35,prefix:[1,4,8,11],prepar:[8,20,35],present:[22,28,32,36,49,50,52],prev_aa:34,prevent:[1,8],previous:[25,26,31,36,40],primary_rot_angl:22,principl:[34,40],print:[1,2,5,20,22,23,25,26,31,32,33,35,42],printstatist:26,printsummari:14,prior:35,privat:[1,37],pro:[21,27,51,52],probabilist:[26,50],probability_cutoff:50,probabl:[4,8,10,13,16,26,27,28,31,32,34,49,50,52],problem:[3,7,10,13,16,26,31,32,34,35,40,42,44,46,48,53],problemat:[3,5,28],proce:42,procedur:[10,28,34,36],process:[1,3,13,16,21,25,28,32,34,35,37,40,45,49,52],processor:5,produc:[0,1,2,4,8,10,26,29,33,35],product:[1,3,16,20],prof:[0,26,31],prof_dir:26,prof_path:26,profil:[0,3,12,13],profiledb:26,profilehandl:[13,26,28,31,35],prog:13,program:[4,5,8,12],project:[3,4,8,16],prolin:[22,33,51],promin:[0,20],promod3_mod:4,promod3_nam:4,promod3_name_head:4,promod3_path:8,promod3_root:8,promod3_shared_data_path:[8,37],promod3_unittest:[1,4,8],promod:[5,7],promot:8,propag:[8,22],proper:[16,26],properli:[1,35,39,41,50],properti:[21,22,35,52],propos:[29,31,32,34,44],proposed_posit:34,proposestep:34,prot:[8,23,26,32,34,36,47],prot_rec:8,protein:[0,18,19,24,25],proton:[21,25,51,52],prototyp:19,provid:[0,1,2,3,4,5,7,8,13,16,20,21,22,23,25,26,28,29,31,32,33,34,35,36,37,40,48,49,50,52],prune:[10,53],pscoringfunct:49,pseudo:[34,35,39,41],psi:[21,22,26,27,32,34,41,47,50,52],psi_bin:[41,52],psi_handl:47,psipr:[13,26,28,40,41],psipred_confid:41,psipred_pr:28,psipred_predict:[26,28,35],psipred_st:41,psipredpredict:23,pssm:[0,13],publicli:20,pull:[7,8,16,18],punch:[1,3,30],pure:0,purpos:[8,10,20,35,52],push:[7,16],pushverbositylevel:13,put:[1,4,8,11,13,35],pwd:5,py_run:[1,4,8],pyc:1,pylint:16,pylintrc:16,pymod:[4,8,16],pyplot:27,pytest:8,python2:8,python:[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],python_root:2,pythonpath:8,qmean:2,qmeandisco:40,qualiti:35,quantum:38,queri:[26,52],querylib:52,question:[3,27],quickli:[5,8,32],quit:[8,13],rackovski:38,radian:[9,22,25,27],radii:[33,43],radiu:[8,33,39,41],raihvhqfgdlsqgcestgphynplavph:0,rais:[0,9,10,13,21,22,25,26,27,28,29,31,32,33,34,35,36,39,40,41,44,45,49,50,52],rama_iffi:33,ramachandran:33,random:[10,22,24,27,31,32,34],random_se:31,randomized_frag:22,randomli:[27,34],rang:[8,9,21,22,23,25,26,27,28,29,32,34,35,39,40,41,52],rank:31,rapid:38,rare:8,rather:[5,7,8,11,16,34,52],raw:[7,18,25,26,27,30,31],rawmodel:[3,8],reach:[0,29,32],read:[0,8,11,13,16,25,26,27,29,36,37,39,41,48,52],readabl:[0,8,13,20,52],readdunbrackfil:48,reader:[16,18],readi:[2,52],readm:[2,8,48],real:[8,13,37],realli:[1,2,8,11,16],reappear:16,reason:[8,16,20,32,34,53],rebas:16,rebuild:[2,8],recalcul:27,receiv:20,recent:[3,16],recip:[3,6,7],recipi:20,recoginz:51,recogn:[0,13],recognis:[1,8,16],recognit:38,recommend:[2,5,8,20,25,35],reconstruct:[0,3,8,18,21,22,25,30,32,35],reconstructcbetaposit:22,reconstructcstemoxygen:22,reconstructor:[32,35,36],reconstructoxygenposit:22,reconstructsidechain:[0,8,35,36],reconstructtest:8,record:[1,35],recreat:16,redistribut:20,reduc:[3,25,28,35,41],reduced_scor:37,reducedscor:[35,37],redund:[24,31],ref_backbon:[23,26],ref_fil:8,refactor:3,refer:[1,4,8,18,19,21,22,23,25,26,34],referenc:8,refresh:31,regard:[20,32,44],region:[0,25,28,29,32,34,35,45,50],regist:[4,8],registri:7,regress:38,regularli:5,reinterpret_cast:37,reject:[31,32,34],rel:[4,5,9,10,26,28,32,41],relat:[4,8,13,26,28,37,38,49],relax:30,relev:[2,3,4,7,25,36,49],reli:5,remain:[20,30,34,35],rememb:[1,8,34],remodel:[31,36],remodel_cutoff:36,remov:[2,3,10,22,25,26,29,31,33,35,36,40,47,49],removecoordin:26,removeterminalgap:35,renumb:[26,35],reorder:35,reordergap:35,replac:[3,20,21,22,34,35],replacefrag:22,report:[1,8,35],reportmolprobityscor:33,repositori:[1,4,8,16,54],repres:[10,20,21],represent:[22,23,25,26,27,37,39,41,49,52],reproduc:[3,20,35],reproduct:20,request:[26,28,48,52],requir:[0,2,3,5,8,13,16,19,20,21,22,26,27,28,31,32,35,36,37,42,49,50,51,52],reread:26,res_depth:26,res_idx:49,res_index:21,res_indic:[21,25,36],res_list:[21,25,32,36],res_num:21,resembl:16,reserv:11,reset:[10,21,25,32,34,40,49],resid:5,residu:[0,3,8,9,21,22,23,24,25,26,27,28,29,31,32,33,34,35,36,38,39,40,41,42,44,45,47,49],residue_depth:26,residue_index:[45,49,50],residue_list:35,residuedepth:26,residuehandl:[9,21,22,26,29,31,32,33,34,35,49,50,52],residuehandlelist:21,residueview:35,resiz:[22,37],resnum:[21,22,29,31,35,36,40],resnum_on:40,resnum_rang:35,resnum_two:40,resolut:[22,32],resolv:[16,21,32],resolvecystein:44,resort:35,respect:[9,25,35],respons:[8,16,20],rest:[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],restart:7,restor:[22,31,34,40],restraint:[26,32],restrict:[8,16,29],restructuredtext:[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],result:[0,2,8,10,20,25,27,28,31,32,33,34,35,36,38,44,52],resum:14,retain:20,reus:[35,36],review:[16,54],revis:20,reviv:16,rewrit:1,richardson:38,ridig:36,right:[1,2,8,13,20],rigid:[0,3],rigid_frame_cutoff:36,rigidblock:28,rij:43,ring:[3,30],ring_punch_detect:35,risk:20,rmsd:[22,23,26,28,31,32],rmsd_cutoff:[26,31,32],rmsd_thresh:[26,28],rnum:40,robot:38,role:13,root:[2,4,8,16],rosetta:41,rot:36,rot_constructor:47,rot_group:[47,50],rot_lib:50,rot_lib_entri:50,rota_out:33,rotam:[0,3,33,36,38,44,45],rotamer:[48,52],rotamer_group:[44,46,47],rotamer_id:47,rotamer_librari:[3,35,36,48],rotamer_model:36,rotamer_on:44,rotamer_res_indic:36,rotamer_two:44,rotamerconstructor:[3,49,50],rotamergraph:[36,46,47,49,53],rotamergroup:49,rotamerid:[47,50],rotamerlib:[35,36,37,48,50,52],rotamerlibentri:[50,52],rotat:[9,22],rotatearoundomegators:22,rotatearoundphipsitors:22,rotatearoundphitors:22,rotatearoundpsitors:22,rotationaroundlin:9,roughli:24,round:52,routin:[1,18,31],royalti:20,rrm:36,rrmrotam:[44,49],rrmrotamergroup:[44,46,49,50],rst1:4,rst2:4,rst:[4,8,16],rsync:8,rule:[5,8,9,16],run:0,runact:1,runexitstatustest:1,runmolprob:33,runmolprobityent:33,runnabl:8,runner:1,runtest:[1,8],runtim:[0,3,10,12],runtimeerror:[9,10,21,22,25,26,27,29,31,32,34,35,36,39,40,41,44,45,48,49,50,52],runtimeexcept:27,s_id:26,safe:[2,8],said:4,same:[0,1,2,4,7,8,10,13,14,20,21,25,26,28,31,32,34,35,36,37,39,40,41,42,45,48,49,50,52],samiti:35,sampl:[0,3,8,22,23],sampled_frag:34,samplemontecarlo:[3,34],sampler:[3,23,24,26],samplerbas:34,sampling_start_index:34,sander:38,saniti:2,sanity_check:2,satisfi:51,save:[16,22,25,26,27,28,31,34,37,39,40,41,52],savebb:26,savecach:28,savefig:27,savepdb:[18,21,22,25,26,30,31,32,34,35,36,47],saveport:[25,26,27,37,39,41,52],sc_data:32,sc_rec:[32,36],sc_rec_test:36,sc_result:32,scale:22,scatter:27,scheme:[1,8,13,21,26,29,34],schenk:38,schmidt:38,schwede:[8,18,19,38,54],sci:38,scicor:[8,18,19,54],scondari:35,scope:14,score:[0,3,8,13,19,23,26,28,29,30],score_contain:31,score_env:[31,34,42],score_threshold:44,score_vari:35,scorecontain:31,scorer:3,scorer_env:[28,31,34],scorerbas:34,scoring_weight:28,scoringgapextend:[29,35],scoringweight:[28,31,35],scratch:[26,34],scriptnam:11,scriptpath:8,scwrl3:[36,42],scwrl3disulfidscor:[43,44],scwrl3pairwisescor:43,scwrl4:[0,36,38,44,47],scwrl4particletyp:49,scwrl4rotamerconstructor:[3,47,50],scwrlrotamerconstructor:3,seamlessli:16,search:[0,2,3,8,21,26,28,31,33,35,36,41,44,49,50],searchdb:[23,26],second:[8,10,22,25,26,28,31,32,35,39,40,41,43,44],secondari:[3,13,26,28,38,41],secondli:8,section:[1,4,7,17,20,54,55],see:[0,1,8,9,10,11,13,16,18,20,21,25,26,27,29,31,33,34,35,37,39,40,41,52],seed:[10,24,27,31,32,34],seem:16,segment:22,select:[3,10,26,28,34,35,36,47],selenium:35,self:[1,8,10,44,47,49],self_energi:[10,49],sell:20,send:11,sensibl:35,sent:20,seok:38,separ:[1,3,8,10,20,25,27,35,39,41,44],seq:[13,21,23,26,28,29,31,35,40,42],seq_idx_on:28,seq_idx_two:28,seq_one_idx:28,seq_sep:[39,41],seq_tpl:[31,35],seq_trg:[31,35],seq_two_idx:28,seqid:[24,26],seqprof:13,seqr:[0,21,23,26,28,29,31,34,35,36,39,40,41],seqres_str:[21,32,36],seqsim:26,sequenc:[0,3,8,13,18,21,22,23],sequencefromchain:42,sequencehandl:[21,26,28,29,35,40],sequencelist:[21,35,40],sequenceprofil:26,sequenti:[22,35],ser:51,serial:[26,37],serializ:37,serin:51,serv:[1,13,26,28,31,34],servic:[16,20],set:[1,2,4,8,10,11,13,15,16,18,21,22,25,26,28,31,32,33,34,35,36,37,39,40,41,44,47,49,50,52,53],setaa:22,setactivesubrotam:49,setallatomscoringkei:31,setaroundomegators:22,setaroundphipsitors:22,setaroundphitors:22,setaroundpsitors:22,setbackbonescoringkei:31,setbackrub:22,setc:22,setca:22,setcb:22,setcharg:25,setcpuplatformsupport:25,setdefault:25,setdisulfidconnect:25,setenergi:[39,41],setenviron:[21,32,36,40],setepsilon:25,setfraggerhandl:35,setframeenergi:[47,49],setfudgelj:25,setfudgeqq:25,setinitialenviron:[21,31,32,34,36,40,42],setinternalconnect:25,setinternalenergi:49,setinternalenergyprefactor:49,setinterpol:52,setmass:25,setn:22,setnonbondedcutoff:32,seto:22,setolc:22,setpeptideboundconnect:25,setphitors:22,setpo:21,setprob:49,setpsipredpredict:[35,40,41],setpsitors:22,setresidu:21,setscor:41,setsequ:22,setsequenceoffset:35,setsequenceprofil:35,setsequenceprofilescoreskei:31,setsigma:25,setstemrmsdskei:31,setstructureprofil:26,setstructureprofilescoreskei:31,settemperatur:49,setup:[0,2,5,7,8,13],setupdefaultallatomscor:[31,35],setupdefaultbackbonescor:[31,35],setupsystem:25,setweight:31,sever:[0,2,3,5,8,10,13,24,26,27,28,31,32,35,36,40,41,42,44,48,49,52,53],sg_pos_on:43,sg_pos_two:43,shake:34,shall:20,shanno:35,shapovalov2011:[38,48],shapovalov:38,shared_ptr:37,shebang:8,sheet:35,shelenkov:38,shell:[1,2,8,11],shift:[22,26,29],shiftctermin:29,shiftextens:29,ship:[5,48],shorten:35,shorter:35,shortest:31,shortli:8,should:[1,2,4,5,7,8,10,11,13,16,18,20,22,23,26,27,28,31,32,34,35,36,37,40,45,47,49],show:[1,8,13,14,31,34,47,50],showcas:[1,21,25,27],shown:[8,14,35],shrink:22,shrug:38,side:[8,35,38],sidechain_pymod:8,sidechain_reconstructor:35,sidechain_rst:8,sidechain_test_data:8,sidechain_test_orig:36,sidechain_test_rec:36,sidechain_unit_test:8,sidechainparticl:50,sidechainreconstructiondata:[30,32],sidechainreconstructor:[25,30,32,35],sidenot:[26,36],sig1:52,sig2:52,sig3:52,sig4:52,sigma:25,silent:1,sim:25,similar:[1,2,13,16,23,26,28,40,41,52],similardihedr:52,similarli:[2,25,35],simpl:[0,9,22,26,34,35,39,40,41,52],simpler:[25,35],simplest:[5,8,30],simpli:[21,22,31,32,34,35,50,51,52],simplic:[23,26],simplif:13,simplifi:[3,22,25,26],simul:[10,25,31,32,34],sinc:[1,2,4,8,10,11,16,18,22,25,26,27,28,51],singl:[2,4,8,10,21,22,25,26,28,31,32,34,35,36,40,41,45,48,49,50,53],singleton:25,singular:[3,6],singularity_nohttp:7,sink:37,sit:8,site:[5,8],size:[8,21,22,26,27,32,34,37,39,40,41],sizeof:37,skip:[0,1,8,16,26,35,50],slide:28,slight:35,slightli:35,slow:37,slower:[18,25,26,27,35,39,41,52],small:[8,26,32,35,36],smaller:[22,26,28,32,41],smallest:47,smallish:[2,8],smart:16,smng:3,smooth:38,smtl:35,soding2005:[26,38],softsampl:34,softwar:[8,20,38],sol:47,sole:[1,16,20],soli:38,solis2006:[24,38],solut:[8,10,28,31,32,34,35,36,46,47],solv:[10,16,47,53],solvent:26,solventaccess:26,solver:3,some:[1,2,4,5,6,7,8,13,16,21,23,26,30,33,34,35,36,37,40,42,47,50,52],somedata:37,someth:[1,7,8,11,16,26],sometim:16,somewher:4,soon:[10,32,41,47,52],sort:[1,4,10,14,31,34,52],sound:16,sourc:[1,2,4,8,13,16,18,19,20,26,28,31,32,33,35,37,52],source1:[4,16],source2:[4,16],source3:4,source4:4,source_chain_idx:35,source_mhandl:35,sp3:52,space:[10,34,38],span:35,sparticl:49,spatial:[8,42],spawn:[1,8],spdbv:35,spdbv_style:35,special:[1,2,4,8,20,25,34,50,51,52],specif:[1,8,20,25,26,27,28,31,34,38,40,48,49,50,52],specifi:[0,2,4,5,9,10,22,26,27,31,32,35,36,40,49,52],specimen:11,speed:[3,25,35],spent:[14,18],sphere:43,sphinx:[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],spin:38,spit:[29,34],split:42,sport:8,squar:26,src:[8,16],ss_agreement:41,ss_agreement_scor:37,ssagre:26,ssagreementscor:37,sse:2,sstream:37,stabil:38,stabl:16,stack:16,stage:[1,2,4,8],stai:[1,8,10,16,34],standalon:7,standard:[2,8,12,13,16,21,27,37,41,52],start:[0,1,2,4,7],start_idx:31,start_resnum:[21,22,26,31,34,35,36,39,40,41],start_resnum_list:36,start_rnum:40,start_temperatur:[10,34],starter:1,startscop:14,stash:[16,31,34,40],state:[1,2,8,20,21,26,31,34,40,41,44,51,52],statement:20,staticruntimeprofil:14,statist:[14,26,38],statu:[1,8],std:37,stderr:1,stdout:1,steadili:[10,34],steepest:[32,35],stem:[9,22,25,26,29,31,32,34,35,36],stemcoord:9,stempairorient:9,step:[8,10,14,16,18,19,28,29,30,31,32,34],stereo:35,stereo_chemical_problem_backbon:35,stereochem:[3,35],steric:52,still:[8,14,25,26,35,37],stop:[1,8,14,29,32],stop_criterion:32,stoppag:20,storabl:26,storag:[8,21,25,39,41],store:[0,1,3,8,9,16,18,21,22,25,26,27,28,29,31,32,34,35,36,37,47],stori:8,str:[1,11,13,14,15,21,22,25,26,27,28,29,31,32,33,34,35,36,37,39,40,41,49,51,52],str_len:37,straight:16,strategi:52,stream:37,stretch:[21,26,31,34,35,40,41],strict:16,strictli:3,string:[0,3,11,13,26,27,29,37],stringstream:37,strip:[0,35],struc:5,struct:[5,26,37],struct_db:23,structral:[21,40],structur:[0,3,8,13],structural_db:31,structuralgap:[29,33],structuralgaplist:[29,35],structure_db:[26,28,31,35,37],structure_db_on:26,structure_db_two:26,structure_dir:26,structure_id:26,structure_path:26,structure_sourc:13,structuredb:[3,13,24,26,28,31,35,37],structuredbdatatyp:26,structureprofil:26,studer:38,stuff:[26,39],style:[35,40,41],sub:[8,26],sub_frag:22,sub_res_list:26,subdir:8,subfold:8,subject:[8,20],sublicens:20,submiss:20,submit:20,submodul:8,submodule1:16,subpart:28,subrotam:[0,3,44,47,49],subrotameroptim:[36,53],subsequ:[10,20,22,35],subset:[0,13,25,26,28,31,32,35,36],subst:26,subst_matrix:26,substitut:26,substweightmatrix:26,subtre:[4,8],succeed:29,success:[10,11,34],successfulli:5,sudo:[5,7],suffici:26,suffix:11,sugar:6,suggest:[5,8,43],suit:[1,8,26],sulfur:[43,44,49,50],sum:[14,29,35,36,43,44,49],summari:[14,26],superpos:[22,26,28,31,32,34],superpose_stem:22,superposed_rmsd:[22,31],superposeonto:22,superposit:[3,28,31,34],superpost:28,supersed:20,supervis:1,support:[0,1,3,8,11,13,18,20,25,32,35],suppos:[16,34],sure:[2,7,8,13,16,26],surfac:26,surotam:49,surround:[25,26,32,36,39,41],symmetr:[26,40,52],symmetri:[39,41],sync:8,syntax:20,system:[1,2,4,8,16,20,23],t_sampler:27,tabl:26,tag:[5,7],tail:22,tailor:[21,35],take:[8,10,21,26,27,28,31,32,34,35,37,41,44,50,53],taken:[0,21,25,32,34,35,50],talk:1,target:[0,1,2,4,8,13,18,26,28,30,31,32,34,35,40],target_chain_idx:35,target_mhandl:35,target_pdb:33,target_sequ:26,task:[8,16,32,35,37,40],techniqu:10,tell:[1,8,11,13,16,26],temperatur:[10,31,34,49],templat:[0,1,3,13,18,30,35,37,40],temporari:[26,35],temporarili:16,term:[8,20,26,49,51,52,53],termin:[0,1,9,11,18,20,21,22,25,29,31,32,34,35,36,50],terminal_len:34,terminal_seqr:34,termini:[0,3,29,34,35],terminu:[26,34,35],test_:8,test_action_:1,test_action_do_awesom:1,test_action_help:1,test_awesome_featur:8,test_check_io:37,test_cod:8,test_doctest:8,test_foo:4,test_portable_binari:37,test_reconstruct_sidechain:8,test_sidechain_reconstruct:8,test_submodule1:16,test_suite_:4,test_suite_your_module_run:8,test_your_modul:16,testcas:[1,8],testcasenam:8,testexit0:1,testpmexist:1,testreconstruct:8,testutil:[1,8],text:[1,13,20,35],than:[4,8,13,14,16,21,22,26,28,31,32,33,35,36,41,44],thei:[2,5,8,16,21,22,25,26,27,31,32,33,34,35,44,49,50,51,52,54],them:[4,8,16,22,25,26,27,28,29,31,35,36,40,45],themselv:25,theoret:34,theori:[20,38],therefor:[5,8,22,24,26,28,32,34,35,52],thereof:[20,25],thi:[0,1,2,3,4,5,7,8,10,11,12,13,14,15,16,17,18,20,21,22,23,25,26,27,28,29,30,31,32,33,34,35,36,37,39,40,41,42,44,47,49,50,51,52,53,55],thing:[1,2,8,16,26,28,35,52],think:10,thoroughli:16,those:[0,1,2,4,8,10,13,16,20,25,31,35,36,37,39,41,47,52],though:[25,35,37],thr:51,thread:[18,25,35,38],three:[1,4,16,21,22,27,31,33,34,41,51,52],threonin:51,thresh:[22,49,52],threshold:[10,26,28,32,35,36,40,52],through:[1,8,9,20,22,26,29,35,39,41],throughout:[13,16,24,25],thrown:26,thu:[5,11,49],tidi:16,tightli:16,time:[1,5,8,13,14,16,18,28,35],timer:14,tini:[16,35],titl:[20,27],tlc:[21,51],tlc_an:21,tlctorotid:[47,51],tmp_buf:37,todens:22,toentiti:[18,21,22,25,26,32,34,36],toframeresidu:49,togeth:[8,16,26,44],too:[13,16,31,32,35,37,49],tool:[3,4,23,37,42,47],toolbox:16,top:[2,6,7,8,14,15,16,32,35],topic:[1,8,16],topolog:[25,32],torrmrotam:49,torsion:[0,13,21,22,23,24,26],torsion_angl:47,torsion_bin:41,torsion_plot:27,torsion_sampl:[22,26,31,32,34,35,37],torsion_sampler_coil:[28,37],torsion_sampler_extend:[28,37],torsion_sampler_hel:37,torsion_sampler_helix:28,torsion_sampler_list:26,torsion_scor:37,torsionprob:26,torsionsampl:[22,24,26,27,28,31,32,34,35,37,41],torsionscor:[35,37],tort:20,total:[10,14,26,28],touch:[1,8,25,32],toward:[0,3,8,13,26,29,32,35,39,41,47,49,50,53],tpl:[0,30,31,35],tpr:[51,52],trace:35,track:[3,11,20,30],trade:20,trademark:20,tradition:11,trail:0,train:[24,31,35],trajectori:[28,34],tran:[22,51,52],transfer:20,transform:[9,20,22,28,34,35,52],translat:[4,8,20,26,51,52],transomegators:22,treat:[3,8,25,35,36,37,52],treatment:50,tree:[1,4,8,10,16,46,47],treepack:3,treesolv:[10,36,47],trg:[0,13,31,35],tri:[10,28,29,35,44,52],trick:[1,7,16],trigger:[1,4,8,48],tripeptid:27,tripl:11,triplet:23,trp:[51,52],trustworthi:16,tryptophan:51,ttccpsivarsnfnvcrlpgtpea:[31,35],ttccpsivarsnfnvcrlpgtpeaicatgytciiipgatcpgdyan:35,ttccpsivarsnfnvcrlpgtpeaicatytgciiipgatcpgdyan:[31,35],tupl:[9,10,11,22,25,26,28,29,33,35,36,44],turn:[0,1,11,14,16,35],tutori:8,tweak:35,twice:[14,40],two:[1,7,8,10,16,21,22,25,26,28,29,31,32,35,36,37,39,40,41,43,44,47,49,51,52],txt:[1,2,4,8,16,20],type:[0,1,8,9,10,11,13,14,20,21,22,24,25,26,27,29,31,32,33,34,35,36,37,39,40,41,43,47,48,49,50],typedef:37,typenam:37,typic:[22,28,34,47,52],tyr:[51,52],tyrosin:51,uint32_t:37,uint:37,ultra:26,uncertain:8,uncharg:50,unclos:35,undefin:25,under:[4,8,20],undergo:[28,32,34,36],underli:[29,31,49],underscor:1,understand:16,understood:0,undo:10,unexpect:2,unfavor:[22,32],unfavour:[32,34,44],unfortun:16,unhandl:[0,13],uniba:[8,18,19,54],uniform:32,union:20,uniqu:[0,13,28,31,34,52],unittest:[1,8,16],univers:[8,54],unix:16,unknown:25,unless:[13,20,21,22,25,31,39,41],unlik:47,unrecognis:11,unset:[21,25,36],unsupport:[13,37],until:[8,10,32,35,40,50],untouch:22,untrack:1,unus:16,upat:5,updat:[3,5,7,8,16,21,25,29,31,32,35,36,40,42],updatedistribut:27,updateposit:[25,32],upon:[26,32,34],urei:25,urey_bradley_angl:25,usabl:16,usag:[0,3,10,13,24,26,31,32,36],use_amber_ff:35,use_bbdep_lib:36,use_frm:36,use_full_extend:35,use_scoring_extend:35,user:[1,5,8,19,54],userlevel:1,usr:[2,5,7,8],usual:[1,2,4,8,13,14,16,22,31,35,39],utilis:[8,16],v_size:37,val:[27,51],valid:[0,10,16,22,26,29,34,35,36,48,52],valin:51,valu:[2,10,11,13,21,22,25,26,28,31,34,35,37,39,40,41,44,47,49,50,51,52,53],valueerror:[28,35],vanish:40,varadarajan:38,vari:[4,37],variabl:[1,2,8,14,18,25,33,35,37],variant:[25,31],variou:[1,2,4,16,30],vec3:[9,21,22,26,32,33,43,44,49],vec3list:[28,49],vector:[25,27,31,37],verbal:20,verbos:1,veri:[1,8,11,16,25,28,35,37],verif:13,verifi:[1,11,16],version:[2,3,5,8,16,20,26,35,37,48,51],via:[1,5,8,13,15,25],view:[13,16,27,35,40],virtual:8,visibl:36,visual:18,volum:5,wai:[1,2,4,5,8,16,22,23,25,31,41,47,51],wait:8,walk:[1,8],want:[1,2,3,8,15,16,22,26,28,31,32,35,40,49,50,52,53,54],warn:[8,16,35],warranti:20,watch:8,web:[2,8],weight:[3,26,28,31,34,35,39,41],weird:[28,32,47],well:[0,4,16,21,27,28,29,31,35,37,41,47,52],went:[0,8],were:[16,26,31,35],wester:38,wether:10,what:[1,8,11,13,16,23,26,36,40],when:[1,3,4,5,8,10,13,14,21,22,25,26,27,28,29,31,34,35,36,37,38,40,41,44,47,48,49,50,52],whenev:[8,21,31,40],where:[0,1,3,4,5,8,10,11,13,14,16,20,21,22,25,26,27,31,35,37,39,40,41,48,49,50,52],wherea:26,wherev:20,whether:[3,5,8,10,11,13,20,22,25,26,31,32,34,36,39,40,41,49,50,52],which:[0,1,4,8,9,11,12,13,16,18,20,21,22,25,26,27,28,29,31,32,33,34,35,36,37,39,40,41,49,50,52],whistl:8,whitespac:0,who:[10,47],whole:[1,2,8,16,20,22,26,35,49],whom:20,why:[1,16],width:[10,37,47],wild:4,window:28,window_length:28,wise:4,wish:[2,17,27,35],with_aa:31,with_db:31,within:[2,3,4,8,14,16,20,21,25,28,29,33,35,36,39,41,52],without:[0,1,3,4,8,11,13,20,25,29,32,35,40,52],won:[0,35,36,50],word:4,work:[1,2,4,5,7,8,14,16,18,20,25,29,35,37],worldwid:20,worst:16,worth:54,would:[1,2,8,11,22,26,27,44],wrap:26,wrapper:[1,4,8,15,35],write:0,writebasetyp:37,writemagicnumb:37,writetypes:37,writeversionnumb:37,written:[8,20,37],wrong:[2,13],wwpdb:5,www:20,xlabel:27,xlim:27,xml:8,xxx:[22,51],xxx_num_atom:21,xxx_num_hydrogen:21,year:1,yet:[26,31,35],ylabel:27,ylim:27,you:[0,1,2,3,4,5,7,8,10,11,13,14,15,16,18,20,21,22,23,25,26,27,28,30,31,32,34,35,36,37,39,40,41,47,48,49,50,52,53,54],your:[1,2,4,5,7],your_modul:[8,16],yourself:[2,8,10,16,35,50],yyyi:20,zero:[0,26,35,52],zhou2005:[26,38],zhou:38,zip:[26,47]},titles:["ProMod3 Actions","<code class=\"docutils literal\"><span class=\"pre\">test_actions</span></code> - Testing Actions","Building ProMod3","Changelog","ProMod3&#8216;s Share Of CMake","Docker","ProMod3 and Containers","Singularity","Contributing","Geometry functions","Graph Minimizer","<code class=\"docutils literal\"><span class=\"pre\">helper</span></code> - Shared Functionality For the Everything","<code class=\"docutils literal\"><span class=\"pre\">core</span></code> - ProMod3 Core Functionality","<code class=\"docutils literal\"><span class=\"pre\">pm3argparse</span></code> - Parsing Command Lines","Runtime profiling","<code class=\"docutils literal\"><span class=\"pre\">SetCompoundsChemlib()</span></code>","ProMod3 Setup","Documentation For Developers","Getting Started","ProMod3","License","Handling All Atom Positions","Representing Loops","<code class=\"docutils literal\"><span class=\"pre\">loop</span></code> - Loop Handling","Loading Precomputed Objects","Generate <code class=\"docutils literal\"><span class=\"pre\">ost.mol.mm</span></code> systems","Structural Data","Sampling Dihedral Angles","Modelling Algorithms","Handling Gaps","<code class=\"docutils literal\"><span class=\"pre\">modelling</span></code> - Protein Modelling","Handling Loop Candidates","Fitting Loops Into Gaps","Model Checking","Generating Loops De Novo","Modelling Pipeline","Sidechain Reconstruction","Using Binary Files In ProMod3","References","All Atom Scorers","Backbone Score Environment","Backbone Scorers","<code class=\"docutils literal\"><span class=\"pre\">scoring</span></code> - Loop Scoring","Other Scoring Functions","Disulfid Bond Evaluation","Frame","Rotamer Graph","<code class=\"docutils literal\"><span class=\"pre\">sidechain</span></code> - Sidechain Modelling","Loading Rotamer Libraries","Rotamers","Rotamer Constructor","RotamerID","Rotamer Library","Subrotamer Optimization","Contributing","Documentation For Users"],titleterms:{"class":[21,22,26,27,29,31,36,39,40,41],"default":35,"function":[4,9,11,12,29,36,40,43,49],acid:[21,25,27],action:[0,1,4,5,7,8],actiontestcas:1,algorithm:28,all:[21,32,39],allatomclashscor:39,allatomenv:21,allatomenvposit:21,allatominteractionscor:39,allatomoverallscor:39,allatompackingscor:39,allatomposit:21,allatomscor:39,amino:[21,25,27],angl:27,api:1,argument:13,atom:[21,32,39],backbon:[32,40,41,52],backbonelist:22,backboneoverallscor:41,backbonescor:41,backbonescoreenv:40,base:[26,39,41],binari:37,block:[28,49],bond:44,branch:16,build:[0,2,5,7,35,49],can:51,candid:31,cbetascor:41,cbpackingscor:41,ccd:32,chain:26,changelog:3,check:33,clashscor:41,closer:34,cmake:[1,2,4,16],code:37,command:13,compound:[5,7],configur:52,construct:[40,50],constructor:50,contain:6,contribut:[8,54],conveni:40,cooler:34,core:12,creat:[1,25],data:[26,37],databas:26,defin:[26,27],definit:4,depend:[2,52],detect:33,develop:17,dihedr:27,directori:16,distinguish:21,disulfid:44,docker:5,document:[4,8,17,19,55],entri:52,environ:40,evalu:44,everyth:11,exampl:[31,37],execut:1,exisit:37,extend:29,featur:[8,26],file:[11,37],find:26,fit:32,forcefield:25,fragment:26,frame:[45,50],from:43,gap:[29,32],gener:[25,34],geometr:26,geometri:9,get:[18,51],git:16,graph:[10,46],group:49,handl:[21,23,29,31,35],have:1,hbondscor:41,header:37,helper:11,hook:16,how:[8,51],imag:[5,7],instal:2,integr:1,introduct:[4,11,13],issu:8,keep:31,kic:32,librari:[5,7,48,52],licens:[8,20],line:13,load:[24,48],lookup:25,loop:[22,23,25,31,32,34,42],loopcandid:31,mainten:4,make:[1,2],messag:11,minim:10,model:[0,18,28,30,31,33,35,47],modul:[4,8],mol:25,molprob:33,must:1,non:52,novo:[28,34],object:[24,34,45],optim:53,ost:[5,7,25],other:43,output:1,own:8,pairwis:40,pairwisescor:41,pars:13,parser:13,parti:8,particl:49,pipelin:[18,35],pm3argpars:13,portabl:37,posit:21,precomput:24,profil:14,promod3:[0,2,4,6,8,12,16,18,19,37],protein:30,psipredpredict:26,punch:33,quick:8,raw:35,reconstruct:36,reducedscor:41,refer:38,relax:32,releas:3,repres:22,residu:50,rigid:28,ring:33,rotam:[46,48,49,50,52],rotamerid:51,run:[1,2,5,7,18],runtim:14,sampl:27,sampler:[27,34],score:[31,40,42,43,49],scorer:[8,34,39,41],script:[1,5,7,8],scwrl3:43,scwrl4:49,sequenc:26,setcompoundschemlib:15,setup:16,share:[4,8,11],sidechain:[0,36,47],sidechainreconstructiondata:36,sidechainreconstructor:36,singular:7,smallest:49,ssagreementscor:41,stage:16,start:[8,18],step:35,structur:[16,26],subclass:1,subrotam:53,system:25,test:[1,4,8,11],test_act:1,third:8,torsion:27,torsionscor:41,track:31,triplet:27,type:52,unit:[1,4,8],user:55,write:8,your:8}})
\ No newline at end of file
+Search.setIndex({envversion:47,filenames:["actions/index","actions/index_dev","buildsystem","changelog","cmake/index","container/docker","container/index","container/singularity","contributing","core/geometry","core/graph_minimizer","core/helper","core/index","core/pm3argparse","core/runtime_profiling","core/setcompoundschemlib","dev_setup","developers","gettingstarted","index","license","loop/all_atom","loop/backbone","loop/index","loop/load_loop_objects","loop/mm_system_creation","loop/structure_db","loop/torsion_sampler","modelling/algorithms","modelling/gap_handling","modelling/index","modelling/loop_candidates","modelling/loop_closing","modelling/model_checking","modelling/monte_carlo","modelling/pipeline","modelling/sidechain_reconstruction","portableIO","references","scoring/all_atom_scorers","scoring/backbone_score_env","scoring/backbone_scorers","scoring/index","scoring/other_scoring_functions","sidechain/disulfid","sidechain/frame","sidechain/graph","sidechain/index","sidechain/loading","sidechain/rotamer","sidechain/rotamer_constructor","sidechain/rotamer_lib","sidechain/subrotamer_optimizer","user_contributions","users"],objects:{"":{"--backbone-independent":[0,7,1,"cmdoption--backbone-independent"],"--energy_function":[0,7,1,"cmdoption--energy_function"],"--keep-sidechains":[0,7,1,"cmdoption--keep-sidechains"],"--no-disulfids":[0,7,1,"cmdoption--no-disulfids"],"--no-subrotamer-optimization":[0,7,1,"cmdoption--no-subrotamer-optimization"],"--rigid-rotamers":[0,7,1,"cmdoption--rigid-rotamers"],"-f":[0,7,1,"cmdoption-f"],"-i":[0,7,1,"cmdoption-i"],"-k":[0,7,1,"cmdoption-k"],"-n":[0,7,1,"cmdoption-n"],"-r":[0,7,1,"cmdoption-r"],"-s":[0,7,1,"cmdoption-s"],"command:add_doc_dependency":[4,0,1,""],"command:add_doc_source":[4,0,1,""],"command:convert_module_data":[4,0,1,""],"command:module":[4,0,1,""],"command:pm_action":[4,0,1,""],"command:promod3_unittest":[4,0,1,""],"command:pymod":[4,0,1,""],test_actions:[1,2,0,"-"]},"promod3.core":{ConstructAtomPos:[9,1,1,""],ConstructCBetaPos:[9,1,1,""],ConstructCTerminalOxygens:[9,1,1,""],EvaluateGromacsPosRule:[9,1,1,""],GraphMinimizer:[10,3,1,""],RotationAroundLine:[9,1,1,""],StaticRuntimeProfiler:[14,3,1,""],StemCoords:[9,3,1,""],StemPairOrientation:[9,3,1,""],helper:[11,2,0,"-"],pm3argparse:[13,2,0,"-"]},"promod3.core.GraphMinimizer":{AStarSolve:[10,4,1,""],AddEdge:[10,4,1,""],AddNode:[10,4,1,""],ApplyDEE:[10,4,1,""],ApplyEdgeDecomposition:[10,4,1,""],MCSolve:[10,4,1,""],NaiveSolve:[10,4,1,""],Prune:[10,4,1,""],Reset:[10,4,1,""],TreeSolve:[10,4,1,""]},"promod3.core.StaticRuntimeProfiler":{Clear:[14,5,1,""],IsEnabled:[14,5,1,""],PrintSummary:[14,5,1,""],Start:[14,5,1,""],StartScoped:[14,5,1,""],Stop:[14,5,1,""]},"promod3.core.StemCoords":{c_coord:[9,6,1,""],ca_coord:[9,6,1,""],n_coord:[9,6,1,""]},"promod3.core.StemPairOrientation":{angle_four:[9,6,1,""],angle_one:[9,6,1,""],angle_three:[9,6,1,""],angle_two:[9,6,1,""],distance:[9,6,1,""]},"promod3.core.helper":{FileExists:[11,1,1,""],FileExtension:[11,1,1,""],FileGzip:[11,1,1,""],MsgErrorAndExit:[11,1,1,""]},"promod3.core.pm3argparse":{PM3ArgumentParser:[13,3,1,""]},"promod3.core.pm3argparse.PM3ArgumentParser":{"__init__":[13,4,1,""],AddAlignment:[13,4,1,""],AddFragments:[13,4,1,""],AddProfile:[13,4,1,""],AddStructure:[13,4,1,""],AssembleParser:[13,4,1,""],Parse:[13,4,1,""],action:[13,6,1,""]},"promod3.loop":{AllAtomEnv:[21,3,1,""],AllAtomEnvPositions:[21,3,1,""],AllAtomPositions:[21,3,1,""],AminoAcidAtom:[21,3,1,""],AminoAcidHydrogen:[21,3,1,""],AminoAcidLookup:[21,3,1,""],BackboneList:[22,3,1,""],CoordInfo:[26,3,1,""],ForcefieldAminoAcid:[25,3,1,""],ForcefieldBondInfo:[25,3,1,""],ForcefieldConnectivity:[25,3,1,""],ForcefieldHarmonicAngleInfo:[25,3,1,""],ForcefieldHarmonicImproperInfo:[25,3,1,""],ForcefieldLJPairInfo:[25,3,1,""],ForcefieldLookup:[25,3,1,""],ForcefieldPeriodicDihedralInfo:[25,3,1,""],ForcefieldUreyBradleyAngleInfo:[25,3,1,""],FragDB:[26,3,1,""],Fragger:[26,3,1,""],FraggerMap:[26,3,1,""],FragmentInfo:[26,3,1,""],LoadFragDB:[24,4,1,""],LoadStructureDB:[24,4,1,""],LoadTorsionSampler:[24,4,1,""],LoadTorsionSamplerCoil:[24,4,1,""],LoadTorsionSamplerExtended:[24,4,1,""],LoadTorsionSamplerHelical:[24,4,1,""],MmSystemCreator:[25,3,1,""],PsipredPrediction:[26,3,1,""],StructureDB:[26,3,1,""],StructureDBDataType:[26,3,1,""],TorsionSampler:[27,3,1,""]},"promod3.loop.AllAtomEnv":{ClearEnvironment:[21,4,1,""],GetAllAtomPositions:[21,4,1,""],GetEnvironment:[21,4,1,""],GetSeqres:[21,4,1,""],SetEnvironment:[21,4,1,""],SetInitialEnvironment:[21,4,1,""]},"promod3.loop.AllAtomEnvPositions":{all_pos:[21,6,1,""],res_indices:[21,6,1,""]},"promod3.loop.AllAtomPositions":{AllAtomPositions:[21,4,1,""],ClearPos:[21,4,1,""],ClearResidue:[21,4,1,""],Copy:[21,4,1,""],Extract:[21,4,1,""],ExtractBackbone:[21,4,1,""],GetAA:[21,4,1,""],GetFirstIndex:[21,4,1,""],GetIndex:[21,4,1,""],GetLastIndex:[21,4,1,""],GetNumAtoms:[21,4,1,""],GetNumResidues:[21,4,1,""],GetOmegaTorsion:[21,4,1,""],GetPhiTorsion:[21,4,1,""],GetPos:[21,4,1,""],GetPsiTorsion:[21,4,1,""],GetSequence:[21,4,1,""],InsertInto:[21,4,1,""],IsAllSet:[21,4,1,""],IsAnySet:[21,4,1,""],IsSet:[21,4,1,""],SetPos:[21,4,1,""],SetResidue:[21,4,1,""],ToEntity:[21,4,1,""]},"promod3.loop.AminoAcidLookup":{GetAA:[21,5,1,""],GetAAA:[21,5,1,""],GetAAH:[21,5,1,""],GetAnchorAtomIndex:[21,5,1,""],GetAtomName:[21,5,1,""],GetAtomNameAmber:[21,5,1,""],GetAtomNameCharmm:[21,5,1,""],GetElement:[21,5,1,""],GetH1Index:[21,5,1,""],GetH2Index:[21,5,1,""],GetH3Index:[21,5,1,""],GetHNIndex:[21,5,1,""],GetHydrogenIndex:[21,5,1,""],GetIndex:[21,5,1,""],GetMaxNumAtoms:[21,5,1,""],GetMaxNumHydrogens:[21,5,1,""],GetNumAtoms:[21,5,1,""],GetNumHydrogens:[21,5,1,""],GetOLC:[21,5,1,""]},"promod3.loop.BackboneList":{"__len__":[22,4,1,""],ApplyTransform:[22,4,1,""],BackboneList:[22,4,1,""],CARMSD:[22,4,1,""],Copy:[22,4,1,""],Extract:[22,4,1,""],GetAA:[22,4,1,""],GetBounds:[22,4,1,""],GetC:[22,4,1,""],GetCA:[22,4,1,""],GetCB:[22,4,1,""],GetN:[22,4,1,""],GetO:[22,4,1,""],GetOLC:[22,4,1,""],GetOmegaTorsion:[22,4,1,""],GetPhiTorsion:[22,4,1,""],GetPsiTorsion:[22,4,1,""],GetSequence:[22,4,1,""],GetTransform:[22,4,1,""],InsertInto:[22,4,1,""],MinCADistance:[22,4,1,""],RMSD:[22,4,1,""],ReconstructCBetaPositions:[22,4,1,""],ReconstructCStemOxygen:[22,4,1,""],ReconstructOxygenPositions:[22,4,1,""],ReplaceFragment:[22,4,1,""],RotateAroundOmegaTorsion:[22,4,1,""],RotateAroundPhiPsiTorsion:[22,4,1,""],RotateAroundPhiTorsion:[22,4,1,""],RotateAroundPsiTorsion:[22,4,1,""],Set:[22,4,1,""],SetAA:[22,4,1,""],SetAroundOmegaTorsion:[22,4,1,""],SetAroundPhiPsiTorsion:[22,4,1,""],SetAroundPhiTorsion:[22,4,1,""],SetAroundPsiTorsion:[22,4,1,""],SetBackrub:[22,4,1,""],SetC:[22,4,1,""],SetCA:[22,4,1,""],SetCB:[22,4,1,""],SetN:[22,4,1,""],SetO:[22,4,1,""],SetOLC:[22,4,1,""],SetSequence:[22,4,1,""],SuperposeOnto:[22,4,1,""],ToDensity:[22,4,1,""],ToEntity:[22,4,1,""],TransOmegaTorsions:[22,4,1,""],append:[22,4,1,""],clear:[22,4,1,""],empty:[22,4,1,""],resize:[22,4,1,""]},"promod3.loop.CoordInfo":{chain_name:[26,6,1,""],id:[26,6,1,""],offset:[26,6,1,""],shift:[26,6,1,""],size:[26,6,1,""],start_resnum:[26,6,1,""]},"promod3.loop.ForcefieldBondInfo":{bond_length:[25,6,1,""],force_constant:[25,6,1,""],index_one:[25,6,1,""],index_two:[25,6,1,""]},"promod3.loop.ForcefieldConnectivity":{harmonic_angles:[25,6,1,""],harmonic_bonds:[25,6,1,""],harmonic_impropers:[25,6,1,""],lj_pairs:[25,6,1,""],periodic_dihedrals:[25,6,1,""],periodic_impropers:[25,6,1,""],urey_bradley_angles:[25,6,1,""]},"promod3.loop.ForcefieldHarmonicAngleInfo":{angle:[25,6,1,""],force_constant:[25,6,1,""],index_one:[25,6,1,""],index_three:[25,6,1,""],index_two:[25,6,1,""]},"promod3.loop.ForcefieldHarmonicImproperInfo":{angle:[25,6,1,""],force_constant:[25,6,1,""],index_four:[25,6,1,""],index_one:[25,6,1,""],index_three:[25,6,1,""],index_two:[25,6,1,""]},"promod3.loop.ForcefieldLJPairInfo":{epsilon:[25,6,1,""],index_one:[25,6,1,""],index_two:[25,6,1,""],sigma:[25,6,1,""]},"promod3.loop.ForcefieldLookup":{GetAA:[25,4,1,""],GetCharges:[25,4,1,""],GetDefault:[25,5,1,""],GetDisulfidConnectivity:[25,4,1,""],GetEpsilons:[25,4,1,""],GetFudgeLJ:[25,4,1,""],GetFudgeQQ:[25,4,1,""],GetHeavyIndex:[25,4,1,""],GetHydrogenIndex:[25,4,1,""],GetInternalConnectivity:[25,4,1,""],GetMasses:[25,4,1,""],GetNumAtoms:[25,4,1,""],GetOXTIndex:[25,4,1,""],GetPeptideBoundConnectivity:[25,4,1,""],GetSigmas:[25,4,1,""],Load:[25,5,1,""],LoadCHARMM:[25,5,1,""],LoadPortable:[25,5,1,""],Save:[25,4,1,""],SavePortable:[25,4,1,""],SetCharges:[25,4,1,""],SetDefault:[25,5,1,""],SetDisulfidConnectivity:[25,4,1,""],SetEpsilons:[25,4,1,""],SetFudgeLJ:[25,4,1,""],SetFudgeQQ:[25,4,1,""],SetInternalConnectivity:[25,4,1,""],SetMasses:[25,4,1,""],SetPeptideBoundConnectivity:[25,4,1,""],SetSigmas:[25,4,1,""]},"promod3.loop.ForcefieldPeriodicDihedralInfo":{force_constant:[25,6,1,""],index_four:[25,6,1,""],index_one:[25,6,1,""],index_three:[25,6,1,""],index_two:[25,6,1,""],multiplicity:[25,6,1,""],phase:[25,6,1,""]},"promod3.loop.ForcefieldUreyBradleyAngleInfo":{angle:[25,6,1,""],angle_force_constant:[25,6,1,""],bond_force_constant:[25,6,1,""],bond_length:[25,6,1,""],index_one:[25,6,1,""],index_three:[25,6,1,""],index_two:[25,6,1,""]},"promod3.loop.FragDB":{AddFragments:[26,4,1,""],GetAngularBinSize:[26,4,1,""],GetDistBinSize:[26,4,1,""],GetNumFragments:[26,4,1,""],GetNumStemPairs:[26,4,1,""],HasFragLength:[26,4,1,""],Load:[26,5,1,""],LoadPortable:[26,5,1,""],MaxFragLength:[26,4,1,""],PrintStatistics:[26,4,1,""],Save:[26,4,1,""],SavePortable:[26,4,1,""],SearchDB:[26,4,1,""]},"promod3.loop.Fragger":{"__getitem__":[26,4,1,""],"__len__":[26,4,1,""],AddSSAgreeParameters:[26,4,1,""],AddSeqIDParameters:[26,4,1,""],AddSeqSimParameters:[26,4,1,""],AddSequenceProfileParameters:[26,4,1,""],AddStructureProfileParameters:[26,4,1,""],AddTorsionProbabilityParameters:[26,4,1,""],Fill:[26,4,1,""],GetFragmentInfo:[26,4,1,""],GetScore:[26,4,1,""]},"promod3.loop.FraggerMap":{"__getitem__":[26,4,1,""],"__setitem__":[26,4,1,""],Contains:[26,4,1,""],Load:[26,4,1,""],LoadBB:[26,4,1,""],Save:[26,4,1,""],SaveBB:[26,4,1,""]},"promod3.loop.FragmentInfo":{chain_index:[26,6,1,""],length:[26,6,1,""],offset:[26,6,1,""]},"promod3.loop.MmSystemCreator":{ExtractLoopPositions:[25,4,1,""],GetCpuPlatformSupport:[25,4,1,""],GetDisulfidBridges:[25,4,1,""],GetForcefieldAminoAcids:[25,4,1,""],GetIndexing:[25,4,1,""],GetLoopLengths:[25,4,1,""],GetLoopStartIndices:[25,4,1,""],GetNumLoopResidues:[25,4,1,""],GetNumResidues:[25,4,1,""],GetSimulation:[25,4,1,""],SetCpuPlatformSupport:[25,4,1,""],SetupSystem:[25,4,1,""],UpdatePositions:[25,4,1,""]},"promod3.loop.PsipredPrediction":{"__len__":[26,4,1,""],Add:[26,4,1,""],Extract:[26,4,1,""],FromHHM:[26,4,1,""],FromHoriz:[26,4,1,""],GetConfidence:[26,4,1,""],GetConfidences:[26,4,1,""],GetPrediction:[26,4,1,""],GetPredictions:[26,4,1,""],PsipredPrediction:[26,4,1,""]},"promod3.loop.StructureDB":{AddCoordinates:[26,4,1,""],GenerateStructureProfile:[26,4,1,""],GetBackboneList:[26,4,1,""],GetCoordIdx:[26,4,1,""],GetCoordInfo:[26,4,1,""],GetDSSPStates:[26,4,1,""],GetDihedralAngles:[26,4,1,""],GetNumCoords:[26,4,1,""],GetResidueDepths:[26,4,1,""],GetSequence:[26,4,1,""],GetSequenceProfile:[26,4,1,""],GetSolventAccessibilitites:[26,4,1,""],GetStructureProfile:[26,4,1,""],GetSubDB:[26,4,1,""],HasData:[26,4,1,""],Load:[26,5,1,""],LoadPortable:[26,5,1,""],PrintStatistics:[26,4,1,""],RemoveCoordinates:[26,4,1,""],Save:[26,4,1,""],SavePortable:[26,4,1,""],SetStructureProfile:[26,4,1,""]},"promod3.loop.TorsionSampler":{Draw:[27,4,1,""],DrawPhiGivenPsi:[27,4,1,""],DrawPsiGivenPhi:[27,4,1,""],ExtractStatistics:[27,4,1,""],GetBinSize:[27,4,1,""],GetBinsPerDimension:[27,4,1,""],GetHistogramIndex:[27,4,1,""],GetHistogramIndices:[27,4,1,""],GetPhiProbabilityGivenPsi:[27,4,1,""],GetProbability:[27,4,1,""],GetPsiProbabilityGivenPhi:[27,4,1,""],Load:[27,5,1,""],LoadPortable:[27,5,1,""],Save:[27,4,1,""],SavePortable:[27,4,1,""],UpdateDistributions:[27,4,1,""]},"promod3.modelling":{AddModellingIssue:[35,1,1,""],AllAtomRelaxer:[32,3,1,""],BackboneRelaxer:[32,3,1,""],BuildFromRawModel:[35,1,1,""],BuildRawModel:[35,1,1,""],BuildSidechains:[35,1,1,""],CCD:[32,3,1,""],CCDCloser:[34,3,1,""],CTerminalCloser:[34,3,1,""],CheckFinalModel:[35,1,1,""],ClearGaps:[29,1,1,""],CloseGaps:[35,1,1,""],CloseLargeDeletions:[35,1,1,""],CloseSmallDeletions:[35,1,1,""],CloserBase:[34,3,1,""],CoolerBase:[34,3,1,""],CountEnclosedGaps:[29,1,1,""],CountEnclosedInsertions:[29,1,1,""],DeNovoCloser:[34,3,1,""],DirtyCCDCloser:[34,3,1,""],ExponentialCooler:[34,3,1,""],FillLoopsByDatabase:[35,1,1,""],FillLoopsByMonteCarlo:[35,1,1,""],FilterCandidates:[33,1,1,""],FilterCandidatesWithSC:[33,1,1,""],FindMotifs:[28,4,1,""],FraggerHandle:[28,3,1,""],FragmentSampler:[34,3,1,""],FullGapExtender:[29,3,1,""],GapExtender:[29,3,1,""],GenerateDeNovoTrajectories:[28,1,1,""],GetRingPunches:[33,1,1,""],GetRings:[33,1,1,""],HasRingPunches:[33,1,1,""],InsertLoop:[35,1,1,""],InsertLoopClearGaps:[29,1,1,""],IsAllAtomScoringSetUp:[35,1,1,""],IsBackboneScoringSetUp:[35,1,1,""],KIC:[32,3,1,""],KICCloser:[34,3,1,""],LinearScorer:[34,3,1,""],LoopCandidates:[31,3,1,""],MergeGaps:[29,1,1,""],MergeGapsByDistance:[35,1,1,""],MergeMHandle:[35,1,1,""],MinimizeModelEnergy:[35,1,1,""],ModelTermini:[35,1,1,""],ModellingHandle:[35,3,1,""],ModellingIssue:[35,3,1,""],MotifMatch:[28,3,1,""],MotifQuery:[28,3,1,""],NTerminalCloser:[34,3,1,""],PhiPsiSampler:[34,3,1,""],ReconstructSidechains:[36,1,1,""],RemoveTerminalGaps:[35,1,1,""],ReorderGaps:[35,1,1,""],ReportMolProbityScores:[33,1,1,""],RigidBlocks:[28,4,1,""],RunMolProbity:[33,1,1,""],RunMolProbityEntity:[33,1,1,""],SampleMonteCarlo:[34,1,1,""],SamplerBase:[34,3,1,""],ScoreContainer:[31,3,1,""],ScorerBase:[34,3,1,""],ScoringGapExtender:[29,3,1,""],ScoringWeights:[31,3,1,""],SetFraggerHandles:[35,1,1,""],SetPsipredPredictions:[35,1,1,""],SetSequenceProfiles:[35,1,1,""],SetupDefaultAllAtomScoring:[35,1,1,""],SetupDefaultBackboneScoring:[35,1,1,""],ShiftExtension:[29,3,1,""],SidechainReconstructionData:[36,3,1,""],SidechainReconstructor:[36,3,1,""],SoftSampler:[34,3,1,""],StructuralGap:[29,3,1,""],StructuralGapList:[29,3,1,""]},"promod3.modelling.AllAtomRelaxer":{GetSystemCreator:[32,4,1,""],Run:[32,4,1,""],UpdatePositions:[32,4,1,""]},"promod3.modelling.BackboneRelaxer":{AddCARestraint:[32,4,1,""],AddCBRestraint:[32,4,1,""],AddCRestraint:[32,4,1,""],AddNRestraint:[32,4,1,""],AddORestraint:[32,4,1,""],GetNonBondedCutoff:[32,4,1,""],Run:[32,4,1,""],SetNonBondedCutoff:[32,4,1,""]},"promod3.modelling.CCD":{CCD:[32,4,1,""],Close:[32,4,1,""]},"promod3.modelling.CCDCloser":{Close:[34,4,1,""]},"promod3.modelling.CTerminalCloser":{Close:[34,4,1,""]},"promod3.modelling.CloserBase":{Close:[34,4,1,""]},"promod3.modelling.CoolerBase":{GetTemperature:[34,4,1,""],Reset:[34,4,1,""]},"promod3.modelling.DeNovoCloser":{Close:[34,4,1,""]},"promod3.modelling.DirtyCCDCloser":{Close:[34,4,1,""]},"promod3.modelling.ExponentialCooler":{GetTemperature:[34,4,1,""],Reset:[34,4,1,""]},"promod3.modelling.FraggerHandle":{Get:[28,4,1,""],GetList:[28,4,1,""],LoadCached:[28,4,1,""],SaveCached:[28,4,1,""]},"promod3.modelling.FragmentSampler":{Initialize:[34,4,1,""],ProposeStep:[34,4,1,""]},"promod3.modelling.FullGapExtender":{Extend:[29,4,1,""]},"promod3.modelling.GapExtender":{Extend:[29,4,1,""]},"promod3.modelling.KIC":{Close:[32,4,1,""],KIC:[32,4,1,""]},"promod3.modelling.KICCloser":{Close:[34,4,1,""]},"promod3.modelling.LinearScorer":{GetScore:[34,4,1,""]},"promod3.modelling.LoopCandidates":{Add:[31,4,1,""],AddFragmentInfo:[31,4,1,""],ApplyCCD:[31,4,1,""],ApplyKIC:[31,4,1,""],CalculateAllAtomScores:[31,4,1,""],CalculateBackboneScores:[31,4,1,""],CalculateSequenceProfileScores:[31,4,1,""],CalculateStemRMSDs:[31,4,1,""],CalculateStructureProfileScores:[31,4,1,""],Extract:[31,4,1,""],FillFromDatabase:[31,5,1,""],FillFromMonteCarloSampler:[31,5,1,""],GetClusteredCandidates:[31,4,1,""],GetClusters:[31,4,1,""],GetFragmentInfo:[31,4,1,""],GetLargestCluster:[31,4,1,""],GetSequence:[31,4,1,""],HasFragmentInfos:[31,4,1,""],Remove:[31,4,1,""]},"promod3.modelling.ModellingHandle":{Copy:[35,4,1,""],all_atom_scorer:[35,6,1,""],all_atom_scorer_env:[35,6,1,""],all_atom_sidechain_env:[35,6,1,""],backbone_scorer:[35,6,1,""],backbone_scorer_env:[35,6,1,""],fragger_handles:[35,6,1,""],gaps:[35,6,1,""],model:[35,6,1,""],modelling_issues:[35,6,1,""],profiles:[35,6,1,""],psipred_predictions:[35,6,1,""],seqres:[35,6,1,""],sidechain_reconstructor:[35,6,1,""]},"promod3.modelling.ModellingIssue":{Severity:[35,3,1,""],is_major:[35,4,1,""],residue_list:[35,6,1,""],severity:[35,6,1,""],text:[35,6,1,""]},"promod3.modelling.ModellingIssue.Severity":{MAJOR:[35,6,1,""],MINOR:[35,6,1,""]},"promod3.modelling.MotifMatch":{alignment:[28,6,1,""],mat:[28,6,1,""],query_idx:[28,6,1,""]},"promod3.modelling.MotifQuery":{GetIdentifiers:[28,4,1,""],GetN:[28,4,1,""],GetPositions:[28,4,1,""],Load:[28,5,1,""],Save:[28,4,1,""]},"promod3.modelling.NTerminalCloser":{Close:[34,4,1,""]},"promod3.modelling.PhiPsiSampler":{Initialize:[34,4,1,""],ProposeStep:[34,4,1,""]},"promod3.modelling.SamplerBase":{Initialize:[34,4,1,""],ProposeStep:[34,4,1,""]},"promod3.modelling.ScoreContainer":{Contains:[31,4,1,""],Copy:[31,4,1,""],Extend:[31,4,1,""],Extract:[31,4,1,""],Get:[31,4,1,""],GetNumCandidates:[31,4,1,""],IsEmpty:[31,4,1,""],LinearCombine:[31,4,1,""],Set:[31,4,1,""]},"promod3.modelling.ScorerBase":{GetScore:[34,4,1,""]},"promod3.modelling.ScoringGapExtender":{Extend:[29,4,1,""]},"promod3.modelling.ScoringWeights":{GetAllAtomScoringKeys:[31,5,1,""],GetAllAtomWeights:[31,5,1,""],GetBackboneScoringKeys:[31,5,1,""],GetBackboneWeights:[31,5,1,""],GetSequenceProfileScoresKey:[31,5,1,""],GetStemRMSDsKey:[31,5,1,""],GetStructureProfileScoresKey:[31,5,1,""],GetWeights:[31,5,1,""],SetAllAtomScoringKeys:[31,5,1,""],SetBackboneScoringKeys:[31,5,1,""],SetSequenceProfileScoresKey:[31,5,1,""],SetStemRMSDsKey:[31,5,1,""],SetStructureProfileScoresKey:[31,5,1,""],SetWeights:[31,5,1,""]},"promod3.modelling.ShiftExtension":{Extend:[29,4,1,""]},"promod3.modelling.SidechainReconstructionData":{disulfid_bridges:[36,6,1,""],env_pos:[36,6,1,""],is_c_ter:[36,6,1,""],is_n_ter:[36,6,1,""],loop_lengths:[36,6,1,""],loop_start_indices:[36,6,1,""],rotamer_res_indices:[36,6,1,""]},"promod3.modelling.SidechainReconstructor":{AttachEnvironment:[36,4,1,""],Reconstruct:[36,4,1,""]},"promod3.modelling.SoftSampler":{Initialize:[34,4,1,""],ProposeStep:[34,4,1,""]},"promod3.modelling.StructuralGap":{Copy:[29,4,1,""],ExtendAtCTerm:[29,4,1,""],ExtendAtNTerm:[29,4,1,""],GetChain:[29,4,1,""],GetChainIndex:[29,4,1,""],GetChainName:[29,4,1,""],GetLength:[29,4,1,""],IsCTerminal:[29,4,1,""],IsNTerminal:[29,4,1,""],IsTerminal:[29,4,1,""],ShiftCTerminal:[29,4,1,""],after:[29,6,1,""],before:[29,6,1,""],full_seq:[29,6,1,""],length:[29,6,1,""],seq:[29,6,1,""]},"promod3.scoring":{AllAtomClashScorer:[39,3,1,""],AllAtomInteractionScorer:[39,3,1,""],AllAtomOverallScorer:[39,3,1,""],AllAtomPackingScorer:[39,3,1,""],AllAtomScorer:[39,3,1,""],BackboneOverallScorer:[41,3,1,""],BackboneScoreEnv:[40,3,1,""],BackboneScorer:[41,3,1,""],CBPackingScorer:[41,3,1,""],CBetaScorer:[41,3,1,""],ClashScorer:[41,3,1,""],ConstraintFunction:[40,3,1,""],ContactFunction:[40,3,1,""],DiscoContainer:[40,3,1,""],HBondScorer:[41,3,1,""],LoadAllAtomInteractionScorer:[39,1,1,""],LoadAllAtomPackingScorer:[39,1,1,""],LoadCBPackingScorer:[41,1,1,""],LoadCBetaScorer:[41,1,1,""],LoadDefaultAllAtomOverallScorer:[39,1,1,""],LoadDefaultBackboneOverallScorer:[41,1,1,""],LoadHBondScorer:[41,1,1,""],LoadReducedScorer:[41,1,1,""],LoadSSAgreementScorer:[41,1,1,""],LoadTorsionScorer:[41,1,1,""],PairwiseFunction:[40,3,1,""],PairwiseFunctionType:[40,3,1,""],PairwiseScorer:[41,3,1,""],ReducedScorer:[41,3,1,""],SCWRL3DisulfidScore:[43,4,1,""],SCWRL3PairwiseScore:[43,4,1,""],SSAgreementScorer:[41,3,1,""],TorsionScorer:[41,3,1,""]},"promod3.scoring.AllAtomClashScorer":{DoExternalScores:[39,4,1,""],DoInternalScores:[39,4,1,""],DoNormalize:[39,4,1,""]},"promod3.scoring.AllAtomInteractionScorer":{DoExternalScores:[39,4,1,""],DoInternalScores:[39,4,1,""],DoNormalize:[39,4,1,""],Load:[39,5,1,""],LoadPortable:[39,5,1,""],Save:[39,4,1,""],SavePortable:[39,4,1,""],SetEnergy:[39,4,1,""]},"promod3.scoring.AllAtomOverallScorer":{"__getitem__":[39,4,1,""],"__setitem__":[39,4,1,""],AttachEnvironment:[39,4,1,""],CalculateLinearCombination:[39,4,1,""],Contains:[39,4,1,""],Get:[39,4,1,""]},"promod3.scoring.AllAtomPackingScorer":{DoNormalize:[39,4,1,""],Load:[39,5,1,""],LoadPortable:[39,5,1,""],Save:[39,4,1,""],SavePortable:[39,4,1,""],SetEnergy:[39,4,1,""]},"promod3.scoring.AllAtomScorer":{AttachEnvironment:[39,4,1,""],CalculateScore:[39,4,1,""],CalculateScoreProfile:[39,4,1,""]},"promod3.scoring.BackboneOverallScorer":{"__getitem__":[41,4,1,""],"__setitem__":[41,4,1,""],AttachEnvironment:[41,4,1,""],Calculate:[41,4,1,""],CalculateLinearCombination:[41,4,1,""],Contains:[41,4,1,""],Get:[41,4,1,""]},"promod3.scoring.BackboneScoreEnv":{AddPairwiseFunction:[40,4,1,""],ApplyPairwiseFunction:[40,4,1,""],ClearEnvironment:[40,4,1,""],Copy:[40,4,1,""],GetSeqres:[40,4,1,""],Pop:[40,4,1,""],SetEnvironment:[40,4,1,""],SetInitialEnvironment:[40,4,1,""],SetPsipredPrediction:[40,4,1,""],Stash:[40,4,1,""]},"promod3.scoring.BackboneScorer":{AttachEnvironment:[41,4,1,""],CalculateScore:[41,4,1,""],CalculateScoreProfile:[41,4,1,""]},"promod3.scoring.CBPackingScorer":{DoNormalize:[41,4,1,""],Load:[41,5,1,""],LoadPortable:[41,5,1,""],Save:[41,4,1,""],SavePortable:[41,4,1,""],SetEnergy:[41,4,1,""]},"promod3.scoring.CBetaScorer":{DoExternalScores:[41,4,1,""],DoInternalScores:[41,4,1,""],DoNormalize:[41,4,1,""],Load:[41,5,1,""],LoadPortable:[41,5,1,""],Save:[41,4,1,""],SavePortable:[41,4,1,""],SetEnergy:[41,4,1,""]},"promod3.scoring.ClashScorer":{DoExternalScores:[41,4,1,""],DoInternalScores:[41,4,1,""],DoNormalize:[41,4,1,""]},"promod3.scoring.DiscoContainer":{AddStructuralInfo:[40,1,1,""],AttachConstraints:[40,1,1,""]},"promod3.scoring.HBondScorer":{DoExternalScores:[41,4,1,""],DoInternalScores:[41,4,1,""],DoNormalize:[41,4,1,""],Load:[41,5,1,""],LoadPortable:[41,5,1,""],Save:[41,4,1,""],SavePortable:[41,4,1,""],SetEnergy:[41,4,1,""]},"promod3.scoring.PairwiseFunction":{Score:[40,4,1,""]},"promod3.scoring.PairwiseScorer":{DoExternalScores:[41,4,1,""],DoInternalScores:[41,4,1,""],DoNormalize:[41,4,1,""]},"promod3.scoring.ReducedScorer":{DoExternalScores:[41,4,1,""],DoInternalScores:[41,4,1,""],DoNormalize:[41,4,1,""],Load:[41,5,1,""],LoadPortable:[41,5,1,""],Save:[41,4,1,""],SavePortable:[41,4,1,""],SetEnergy:[41,4,1,""]},"promod3.scoring.SSAgreementScorer":{DoNormalize:[41,4,1,""],Load:[41,5,1,""],LoadPortable:[41,5,1,""],Save:[41,4,1,""],SavePortable:[41,4,1,""],SetScore:[41,4,1,""]},"promod3.scoring.TorsionScorer":{DoNormalize:[41,4,1,""],Load:[41,5,1,""],LoadPortable:[41,5,1,""],Save:[41,4,1,""],SavePortable:[41,4,1,""],SetEnergy:[41,4,1,""]},"promod3.sidechain":{AAToRotID:[49,4,1,""],BBDepRotamerLib:[51,3,1,""],CreateSCWRL3Particle:[49,4,1,""],CreateSCWRL4Particle:[49,4,1,""],CreateVINAParticle:[49,4,1,""],DihedralConfiguration:[51,3,1,""],DisulfidScore:[44,4,1,""],FRMRotamer:[49,3,1,""],FRMRotamerGroup:[49,3,1,""],Frame:[45,3,1,""],FrameResidue:[45,3,1,""],GetDihedralConfiguration:[51,4,1,""],GetRotamericConfiguration:[51,4,1,""],LoadBBDepLib:[48,4,1,""],LoadLib:[48,4,1,""],PScoringFunction:[49,3,1,""],Particle:[49,3,1,""],RRMRotamer:[49,3,1,""],RRMRotamerGroup:[49,3,1,""],ReadDunbrackFile:[48,4,1,""],ResolveCysteins:[44,4,1,""],RotamerConstructor:[50,3,1,""],RotamerGraph:[46,3,1,""],RotamerID:[49,3,1,""],RotamerLib:[51,3,1,""],RotamerLibEntry:[51,3,1,""],SCWRL3RotamerConstructor:[50,3,1,""],SCWRL4ParticleType:[49,3,1,""],SCWRL4RotamerConstructor:[50,3,1,""],SubrotamerOptimizer:[52,4,1,""],TLCToRotID:[49,4,1,""],VINAParticleType:[49,3,1,""],VINARotamerConstructor:[50,3,1,""]},"promod3.sidechain.BBDepRotamerLib":{AddRotamer:[51,4,1,""],Load:[51,5,1,""],LoadPortable:[51,5,1,""],MakeStatic:[51,4,1,""],QueryLib:[51,4,1,""],Save:[51,4,1,""],SavePortable:[51,4,1,""],SetInterpolate:[51,4,1,""]},"promod3.sidechain.FRMRotamer":{"__getitem__":[49,4,1,""],"__len__":[49,4,1,""],AddFrameEnergy:[49,4,1,""],AddSubrotamerDefinition:[49,4,1,""],ApplyOnResidue:[49,4,1,""],GetActiveSubrotamer:[49,4,1,""],GetFrameEnergy:[49,4,1,""],GetInternalEnergy:[49,4,1,""],GetInternalEnergyPrefactor:[49,4,1,""],GetNumSubrotamers:[49,4,1,""],GetProbability:[49,4,1,""],GetSelfEnergy:[49,4,1,""],GetSubrotamerDefinition:[49,4,1,""],GetTemperature:[49,4,1,""],SetActiveSubrotamer:[49,4,1,""],SetFrameEnergy:[49,4,1,""],SetInternalEnergy:[49,4,1,""],SetInternalEnergyPrefactor:[49,4,1,""],SetProbability:[49,4,1,""],SetTemperature:[49,4,1,""],ToFrameResidue:[49,4,1,""],ToRRMRotamer:[49,4,1,""]},"promod3.sidechain.FRMRotamerGroup":{"__getitem__":[49,4,1,""],"__len__":[49,4,1,""],AddFrameEnergy:[49,4,1,""],ApplyOnResidue:[49,4,1,""],ApplySelfEnergyThresh:[49,4,1,""],Merge:[49,4,1,""],SetFrameEnergy:[49,4,1,""]},"promod3.sidechain.FrameResidue":{"__getitem__":[45,4,1,""],"__len__":[45,4,1,""]},"promod3.sidechain.Particle":{GetCollisionDistance:[49,4,1,""],GetName:[49,4,1,""],GetPos:[49,4,1,""],GetScoringFunction:[49,4,1,""],PairwiseScore:[49,4,1,""]},"promod3.sidechain.RRMRotamer":{"__getitem__":[49,4,1,""],"__len__":[49,4,1,""],AddFrameEnergy:[49,4,1,""],ApplyOnResidue:[49,4,1,""],GetFrameEnergy:[49,4,1,""],GetInternalEnergy:[49,4,1,""],GetInternalEnergyPrefactor:[49,4,1,""],GetProbability:[49,4,1,""],GetSelfEnergy:[49,4,1,""],SetFrameEnergy:[49,4,1,""],SetInternalEnergy:[49,4,1,""],SetInternalEnergyPrefactor:[49,4,1,""],SetProbability:[49,4,1,""],ToFrameResidue:[49,4,1,""]},"promod3.sidechain.RRMRotamerGroup":{"__getitem__":[49,4,1,""],"__len__":[49,4,1,""],AddFrameEnergy:[49,4,1,""],ApplyOnResidue:[49,4,1,""],ApplySelfEnergyThresh:[49,4,1,""],Merge:[49,4,1,""],SetFrameEnergy:[49,4,1,""]},"promod3.sidechain.RotamerConstructor":{AssignInternalEnergies:[50,4,1,""],ConstructBackboneFrameResidue:[50,4,1,""],ConstructRRMRotamerGroup:[50,4,1,""],ConstructSidechainFrameResidue:[50,4,1,""]},"promod3.sidechain.RotamerGraph":{CreateFromFRMList:[46,5,1,""],CreateFromRRMList:[46,5,1,""]},"promod3.sidechain.RotamerLib":{AddRotamer:[51,4,1,""],Load:[51,5,1,""],LoadPortable:[51,5,1,""],MakeStatic:[51,4,1,""],QueryLib:[51,4,1,""],Save:[51,4,1,""],SavePortable:[51,4,1,""]},"promod3.sidechain.RotamerLibEntry":{FromResidue:[51,5,1,""],IsSimilar:[51,4,1,""],SimilarDihedral:[51,4,1,""],chi1:[51,6,1,""],chi2:[51,6,1,""],chi3:[51,6,1,""],chi4:[51,6,1,""],probability:[51,6,1,""],sig1:[51,6,1,""],sig2:[51,6,1,""],sig3:[51,6,1,""],sig4:[51,6,1,""]},"promod3.sidechain.SCWRL3RotamerConstructor":{AssignInternalEnergies:[50,4,1,""]},"promod3.sidechain.SCWRL4RotamerConstructor":{AssignInternalEnergies:[50,4,1,""],ConstructFrameResidue:[50,4,1,""],ConstructFrameResidueHeuristic:[50,4,1,""]},"promod3.sidechain.VINARotamerConstructor":{AssignInternalEnergies:[50,4,1,""],ConstructFRMRotamerHeuristic:[50,4,1,""],ConstructFrameResidueHeuristic:[50,4,1,""],ConstructRRMRotamerHeuristic:[50,4,1,""]},"test_actions.ActionTestCase":{RunAction:[1,4,1,""],RunExitStatusTest:[1,4,1,""],pm_action:[1,6,1,""],pm_bin:[1,6,1,""],testPMExists:[1,4,1,""]},promod3:{SetCompoundsChemlib:[15,1,1,""],core:[12,2,0,"-"],loop:[23,2,0,"-"],modelling:[30,2,0,"-"],scoring:[42,2,0,"-"],sidechain:[47,2,0,"-"]},test_actions:{ActionTestCase:[1,3,1,""]}},objnames:{"0":["cmake","command","CMake command"],"1":["py","function","Python function"],"2":["py","module","Python module"],"3":["py","class","Python class"],"4":["py","method","Python method"],"5":["py","staticmethod","Python static method"],"6":["py","attribute","Python attribute"],"7":["std","option","option"]},objtypes:{"0":"cmake:command","1":"py:function","2":"py:module","3":"py:class","4":"py:method","5":"py:staticmethod","6":"py:attribute","7":"std:option"},terms:{"10a":36,"1ake":28,"1aki":26,"1crn":[21,23,25,26,30,31,32,34,35,36,42,47],"1crn_cut":[30,31,35],"1crna":[26,31],"1e2q":28,"1ey":8,"1eye_rec":8,"1ko5":28,"20a":36,"2iyw":28,"2jlp":0,"30a":36,"3x3":9,"655a":26,"__doc__":[11,13],"__getitem__":[26,39,41,45,49],"__init__":[1,8,13,16],"__len__":[22,26,45,49],"__main__":[1,8],"__name__":[1,8],"__setitem__":[26,39,41],"_data":37,"_name":4,"_run":[1,4],"_xml":4,"abstract":[34,50],"boolean":[11,13,35],"break":[3,4,8,16],"byte":[10,37],"case":[0,1,5,8,13,16,22,26,27,28,29,32,34,35,36,37,41,44,47,49,50,51],"catch":26,"char":[22,37],"class":[0,1,3,5,8,9,10,12,13,14,17,20],"const":37,"default":[0,1,2,3,4,5,8,10,13,14,15,18,21,22,25,26,27,28,30,31,32,34],"enum":[26,49],"export":[8,21],"final":[8,18,26,28,30,31,35,40,42,44,46,47,49],"float":[9,10,21,22,25,26,27,28,29,31,32,33,34,35,36,37,39,40,41,43,44,49,50,51,52],"function":[0,1,3],"import":[0,1,5,8,11,13,16,18,20,21,22,23,25,26,27,28,30,31,32,34,35,36,42,47,49,50],"int":[1,9,10,11,14,21,22,24,25,26,27,28,29,31,32,33,34,35,36,37,39,40,41,45,49,50,51,52],"long":35,"new":[1,3,7,8,13,16,17,21,22,25,26,29,31,32,34,35,36,37,38,47,49],"null":26,"public":[8,37,49],"return":[1,8,9,10,11,13,14,15,21,22,24,25,26,27,28,29,31,32,33,34,35,36,37,39,40,41,43,44,45,48,49,50,51],"s\u00f6ding":38,"short":[8,16,37],"static":[8,14,21,25,26,27,28,31,36,37,39,41,46,48,51],"super":47,"switch":[8,16,40],"throw":[1,37,47,48],"true":[1,11,13,14,21,22,23,25,26,28,29,31,32,33,34,35,36,37,39,41,44,47,50],"try":[1,8,18,29,35,37,51],"void":37,"while":[1,4,8,14,20,21,25,35,37,49],a3m:[0,13],a3mtoprofil:[0,13],aa1:41,aa2:41,aa_aft:26,aa_befor:26,aa_clash:[35,39],aa_interact:[35,39],aa_pack:[35,39],aa_packing_scor:37,aa_relax_test:32,aa_res_idx:50,aa_scor:37,aa_with_rotam:47,aaa1:39,aaa2:39,aaa:[21,39],aaaaaaaa:22,aaaaggggggggggggggggggggaaaaaa:35,aafrequ:26,aafrequenciesstruct:26,aah:21,aatorotid:49,abcdefghijklmnopqrstuvwxyz0123456789abcdefghijklmnopqrstuvwxyz:35,abil:16,abl:[2,8],abort:[8,10,32,35],about:[1,4,8,10,26,28,35],abov:[0,1,5,8,13,16,20,22,29,31,35,37,49,51],absolut:[4,5,34],academ:8,accept:[10,13,20,31,32,34,35,36,37],acceptor:[41,49,50],access:[4,5,8,21,22,26,27,31,35,39,40,41,49],accessor:26,accord:[0,5,10,16,21,22,25,26,27,28,29,31,34,35,36,39,44,47,49,50,51],accordingli:[26,40],account:[8,53],accumul:28,accur:28,accuraci:[0,28,35,38],achiev:[10,16],acknowledg:8,across:[1,51],act:[20,32],acta:38,action_nam:16,action_unit_test:1,actiontest:1,activ:[13,14,16,35,44,49,52],active_internal_energi:52,actual:[3,8,13,16,22,26,28,34,35,36,40,41,42,50,51],actual_posit:34,actual_step:34,adapt:[8,25,26,32,34,35,38],add:[1,2,4,6,8,10,13,18,20,21,26,27,28,31,32,35,36,39,40,41,44,47,49,50,53],add_argu:11,add_custom_target:8,add_doc_depend:4,add_doc_sourc:[4,8],add_flag:28,add_subdirectori:8,addalign:13,addcarestraint:32,addcbrestraint:32,addcoordin:26,addcrestraint:32,addedg:10,addendum:20,addfrag:[13,26],addfragmentinfo:31,addframeenergi:49,addharmonicangl:25,addharmonicbond:25,addharmonicimprop:25,addit:[3,4,11,13,14,16,20,22,23,25,26,33,35,37],addition:[1,4,16,21,25,26,28],addljpair:25,addmodellingissu:35,addnod:10,addnrestraint:32,addorestraint:32,addpairwisefunct:40,addperiodicdihedr:25,addperiodicimprop:25,addprofil:13,addresidu:28,address:37,addrotam:51,addseqidparamet:26,addseqsimparamet:[23,26],addsequenceprofileparamet:26,addssagreeparamet:26,addstructur:13,addstructuralinfo:40,addstructureprofileparamet:26,addsubrotamerdefinit:49,addtorsionprobabilityparamet:26,addureybradleyangl:25,admir:8,advanc:28,advantag:25,advic:[8,16],advis:20,affect:[8,22,35,49,50],after:[1,2,4,5,8,10,13,16,21,22,25,26,27,29,31,32,34,35,37,40,51],after_c_stem:22,afterward:[8,26,35],again:[2,3,8,26,28,50],against:[20,28,39],agg:27,agglom:31,ago:1,agre:20,agreement:[13,20,26,28,41],agress:[2,10],aim:19,ala:[22,27,32,47,49,50,51],ala_cb:21,ala_h1:21,ala_h:21,alanin:[3,49],alg:[23,26,35],algorithm:[3,10,19,22,23,26],alia:29,align:[0,13,18,26,28,30,35,38,40],alignedcuboid:22,alignmenthandl:[28,35,40],alignmentlist:[0,13,35],all:[0,1,2,3,4,8,10,13,14,16,18,19,20],all_atom:[21,22,25,49],all_atom_env:21,all_atom_po:[21,50],all_atom_scor:35,all_atom_scorer_env:35,all_atom_sidechain_env:35,all_po:[21,25,32],all_scor:31,allatom:[32,35,36],allatomclashscor:35,allatominteractionscor:[35,37],allatomoverallscor:[31,35],allatompackingscor:[35,37],allatomrelax:[25,32],alleg:20,alloc:26,allow:[0,2,3,5,8,11,16,22,26,27,28,31,34,35,37,39,41,46,51],allow_multitempl:13,allow_prepro_ci:22,almost:[4,32,35],aln:[0,28,30,31,35,40],aln_sourc:13,alon:[11,20],along:[1,8,20],alongsid:20,alot:8,alpha:[9,22,41,47],alpha_bin:41,alreadi:[1,4,8,10,16,22,25,26,28,31,35,36,39,40,41,49,50,51,52],also:[1,2,4,8,11,16,20,26,27,28,31,32,33,34,35,36,44,45,46,50,51],alter:[31,34],altern:[4,5,8,31,34,35,48,50],alwai:[0,1,7,8,16,29,34,35,37],amber:[21,35],ambig:51,ambigu:[0,13,51],aminoacid:[21,22,25,27,41,49,51],aminoacidatom:[21,39],aminoacidhydrogen:21,aminoacidlookup:[21,25],among:31,amount:[18,28,51],analog:28,analysi:[32,33,38],analyt:[31,51],anchor:[9,21],ancient:15,angl:[0,9,21,22,23,25,26],angle_bin:41,angle_bin_s:26,angle_force_const:25,angle_four:9,angle_on:9,angle_thre:9,angle_two:9,angstrom:[26,32],ani:[0,1,4,5,8,10,13,14,15,18,20,21,22,25,26,27,28,29,31,33,34,35,36,37,39,40,41,45,47,49,50],anneal:[10,31,34],annot:20,announc:[1,8],anoth:[4,14,22,29,32,35,36,44],anymor:[3,10,28],anyon:[8,16],anyth:[0,2,5,8,13,14,15,28,31,32,36,39,41],anywai:8,anywher:16,apach:[3,20],apart:[1,31,35,36,39,41],app:7,appear:20,append:[0,13,22,26,27,28,35,47],appendix:20,appli:[3,7,10,11,15,16,20,22,26,28,29,31,32,34,35,36,38,40,44,47,49,51],applic:[1,20,32,50],applyccd:31,applyde:10,applyedgedecomposit:10,applyk:31,applyonresidu:[47,49],applypairwisefunct:[40,41],applysd:25,applyselfenergythresh:[47,49],applytransform:[22,28],approach:[0,2,10,26,28,35,37,44,47,50],appropri:[10,20,27,35,37,50],approx:35,approxim:25,arbitrari:[3,21,26,44],arbitrarili:34,archiv:20,arendal:38,arg:[1,4,13,49],arg_ca:21,arg_hd3:21,arg_sorted_scor:31,arginin:49,argpars:13,argument:[0,1,2,4,11,12],argumentpars:13,argv:13,aris:20,around:[1,4,8,9,16,22,31,32,35,39,40,41,51],arrai:[0,8,37],arrang:28,artifici:26,ascend:29,ask:8,asn:[49,51],asn_c:21,asn_hb2:21,asp:[21,49,51],asp_ha:21,asp_o:21,asparagin:49,aspart:[49,51],ass:34,assembl:13,assemblepars:13,assert:20,assertequ:8,assess:[39,40],assign:[3,10,22,26,31,34,39,41,50,52],assigninternalenergi:50,assignsecstruct:35,associ:[20,26,29,45],assum:[1,4,5,7,8,20,25,26,32,35,37,40,41,44,50],assur:44,astar:3,astarsolv:10,atom:[3,8,9],atom_idx:[21,25],atom_nam:[21,25],atomhandl:50,atp:28,atp_at:28,atp_idx:28,atp_list:28,atp_r:28,atp_sel:28,atp_view:28,attach:[0,4,8,13,20,21,25,28,29,31,35,36,39,40,41,42],attach_view:13,attachconstraint:40,attachenviron:[31,32,34,36,39,41,42],attachview:[30,31,35],attent:[1,16],attribut:[8,13,20,26,35,36,51],author:20,authorship:20,autodock:[38,49],autom:[2,4],automat:[1,8,10,11,14,16,26,30,31,37,50,51],automatis:8,avaibl:50,avail:[1,2,3,5,7,8,15,16,18,20,25,26,31,34,35,40,47,49],availab:20,availabl:8,averag:[31,40,44],avg:26,avg_sampling_per_posit:28,avoid:[0,3,6,11,13,15,26,28,32,34],awai:[16,36],awar:[0,3,8,35,50],awesom:[1,8],axi:[9,22],back:[1,16,25,34],backbon:[0,3,9,18,21,22,26,27,28,29,30,31],backbone_scor:35,backbone_scorer_env:35,backbonelist:[18,21],backboneoverallscor:[28,31,34,35],backbonerelax:[32,35],backbonescor:8,backbonescoreenv:[8,28,31,34,35],backbonescoreenvlisten:8,background:[2,36],backrub:[22,38],backward:37,bad:[25,35],bare:26,base:[0,3,4,5,9,11,13,19,20,22,23],base_target:4,baseclass:47,basel:[8,53],bashrc:8,basi:[4,8,16,20,28,32,34,48],basic:[1,2,8,11,16,27,34,35,47,51],bb_dep_lib:37,bb_list:[18,21,22,23,26,29,31,32,34,35,40],bb_list_on:28,bb_list_two:28,bb_score:31,bbdeprotamerlib:[35,36,37,48,50,51],becaus:[8,16,21,28,35,40],becom:[10,51],been:[2,3,10,16,20,24,26,31,32,35,39,41,44,51],befor:[0,1,4,7,8,13,16,22,25,26,27,29,31,32,34,35,36,37,50],begin:[1,8,21,22,28,34,40],behalf:20,behav:[1,51],behaviour:[0,13,39,40,49,50,51],behind:8,believ:53,bell:8,belong:[3,4,16,21,22,26,29,31,34,35,36,39,40,41,45,49,50],belov:26,below:[0,8,20,21,25,26,28,31,32,36,37,39,41,44,49],below_thre:26,benefici:20,besid:[2,4,10,13,26],best:[4,31,35,44],best_candid:31,beta:[9,22,33,41],beta_bin:41,better:[25,31,34,35,39,41],between:[1,3,10,13,22,25,26,28,29,31,32,34,35,36,37,39,40,41,42,43,44,45,49,50,51],beyond:13,biasini2013:[19,38],biasini:38,bienert:38,big:[25,37],bilinearli:51,bin:[1,8,16,18,26,27,28,39,41,51],bin_siz:[28,51],binari:[1,4,8,16,17,25,26,27],bind:[0,3,13,20,28],bins_per_dimens:27,bioinformat:38,biol:38,biolog:38,biologi:[19,38],biophi:38,biopolym:38,bit:[1,8,16,31,35],bitwis:26,blank:8,block:3,blosum62:[13,23,26,28,40],boilerpl:20,bond:[0,3,9,22,25,26,32,33,35,36,38,41],bond_force_const:25,bond_length:[9,25],bool:[1,8,10,11,13,14,21,22,25,26,29,31,32,33,34,35,36,37,39,41,44,49,50,51],boost:[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],boost_librari:4,boost_root:2,bootstrap:[6,7],bore:34,both:[3,21,26,29,35,44,47,51],bound:[21,25,28,31,49,50],boundari:28,br_vinaparticl:49,bracket:20,bradlei:25,branch:[4,8],branchnam:16,brew:4,bridg:[24,25,32,35,36],briefli:16,bring:8,broken:1,bromin:49,broyden:35,bsd:20,bug:[3,8,16],build_disulfid:36,builder:2,buildfromrawmodel:[30,35],buildrawmodel:[0,30,31,35],buildsidechain:35,buildup:[47,49],built:[4,7,25,26,40,45],bunch:[1,13,16],bundl:20,bytecod:1,c_coord:9,c_num:29,c_p_vinaparticl:[49,50],c_po:[9,22,41],c_stem:[9,23,26,29,31,32,34],c_stem_psi:34,c_str:37,c_ter:[32,50],c_vinaparticl:[49,50],ca_coord:9,ca_pairwise_funct:40,ca_po:[9,22],ca_pos_on:[43,44],ca_pos_two:[43,44],ca_posit:[28,44],ca_rmsd:[23,26],cach:[2,26,28],calcul:[8,22,26,27,28,31,32,34,39,40,41,42,44,45,46,47,49,50],calculateallatomscor:31,calculatebackbonescor:31,calculatelinearcombin:[31,34,39,41],calculatescor:[39,41,42],calculatescoreprofil:[39,41],calculatesequenceprofilescor:31,calculatestemrmsd:31,calculatestructureprofilescor:31,call:[1,2,4,8,11,13,14,15,16,21,25,26,27,29,31,34,35,36,37,39,40,41,49,50,51],callabl:[13,16],calpha:35,calul:27,came:8,can:[0,1,2,3,4,5,7,8,9,10,11,13,14,15,16,18,19,21,22,23,25,26,27,28,29,30,31,32,34,35,36,37,39,40,41,42,44,45,46,47,48],cand:35,candid:[3,30],cannot:[0,8,13,20,25,26,27,29,35,37,39,41,48,49,50,51],canutescu2003:[32,38,49],canutescu2003b:[38,39,41,43,44],canutescu:38,cap:10,capabl:[24,30,34],captur:1,carbon:[9,22,43,49,50],carbonyl:[49,50],care:[0,8,10,31,32,35,37,41],carlo:[0,3,10,28,31,34,35,46],carmsd:[22,23,26],carri:[8,11,20],cast:37,categori:4,caus:[16,20,33],caution:21,caviti:26,cb_in_sidechain:50,cb_pack:[28,35,41],cb_packing_scor:37,cb_pairwise_funct:40,cb_po:22,cb_pos_on:[43,44],cb_pos_two:[43,44],cb_posit:44,cbeta:[28,31,34,35,41,42],cbeta_scor:[37,42],cbetaenvlisten:8,cbetascor:[8,35,37],cbpackingscor:[8,35,37],ccd:[3,30,31],ccdcloser:34,center:[33,49],central:[22,27,41],centroid:31,certain:[1,2,4,8,10,16,26,27,28,29,35,37,39,40,41],certainli:1,ch1particl:49,ch2particl:49,ch3particl:49,ch_name:26,chain:[0,8,13,21,22,23,24],chain_idx:[8,21,31,34,35,36,39,40,41],chain_idx_list:36,chain_idx_on:40,chain_idx_two:40,chain_index:[26,34,39],chain_indic:40,chain_nam:[26,35],chainhandl:[21,22,29],chainid:0,chakravarti:38,chakravarty1999:[26,38],chanact:35,chanc:[8,10,35],chang:[1,3,4,5,8,10,16,20,21,27,28,29,32,34,35,36,39],change_frequ:[10,34],chapter:[29,33],charact:[13,20,26],charg:[8,20,21,25,32,49,50],charmm:[21,25,35],check:[0,1,2,3,5,8,11,13,14,16,22,25,26,30,32],check_dupl:28,check_io:37,check_xml:8,checkbasetyp:37,checkfinalmodel:35,checkmagicnumb:37,checkout:[8,16],checktypes:37,chem:38,chemdict_tool:[5,7],chemic:[5,15,21,35,39],chemistri:[35,38],chemlib:[5,7],chi1:51,chi2:51,chi3:51,chi4:51,chi:51,child:13,childclass:1,chlorin:49,chmod:8,choos:[20,31,34],chose:5,chosen:[0,13,34,35],cif:[0,5,7,13],ciiipgatcpgdyan:35,circumv:50,cl_vinaparticl:49,claim:20,clash:[3,28,31,32,34,35,39,41,42,44,47],clash_scor:42,clash_thresh:35,clashscor:[31,33,34,35],classic:48,claus:20,clean:[2,8,16],cleanli:37,clear:[14,21,22,31,35,40],clearenviron:[21,40],cleargap:29,clearpo:21,clearresidu:21,clip:13,clone:[8,18],close:[16,18,22,26,28,31,32,34,35,36,44],close_at:28,closed_posit:34,closegap:35,closelargedelet:35,closer:[3,26,30,31],closerbas:34,closesmalldelet:[32,35],closest:28,closur:[32,35,38],clustal:[0,13],cluster:[3,31,37,40],cluster_thresh:[28,40],clutter:[1,8,26],cmake:0,cmake_support:[4,8,16,20],cmakecach:2,cmakelist:[1,2,4,8,16],coars:8,code:[0,1,2,3,4,5,6,7,8,11,13,14,15,16,17,18,19,20,21,22,26,27,33,35],codetest:[4,8],coil:[24,28],collect:[11,14,21,28,40],collis:49,column:[26,28],combin:[20,25,26,27,28,31,34,35,38,39,41,44,49,51],come:[1,3,4,8,11,13,35,36,42,46,51],command:[0,1,7,8,11,12],commandlin:13,comment:[16,20],commerci:[8,20],commit:[8,16],common:[8,13,20,28],commonli:[8,18,30,31,41],commun:20,comp_lib:50,compar:[3,8,22,23,26,31,32,51],comparison:[35,38,51],compat:[2,3,16,25,37],compensatori:22,compil:[1,2,3,4,8,14,16,18,20,37,54],complain:1,complaint:16,complet:[14,16,22,25,32,34,35,36,51],complex:[8,16,36,44,49,52],compli:20,complianc:20,complib_dir_contain:[5,7],complib_dir_localhost:[5,7],compon:[5,7,10,15,26,33,41,50],compound:3,compoundlib:[5,50],compress:[11,26],comput:[3,8,19,20,31,33,38,39,41],concaten:21,concept:8,concern:8,condit:[8,20,27],conf:[2,8],confid:[26,41],config:[4,8],config_head:4,configur:[2,8,10,16,20,31,47],conflict:16,conform:[26,32,34,38,46,51],connect:[4,5,10,16,21,25,26,31],connectivi:5,conop:[5,21,22,25,27,41,49,50],conquer:8,consecut:[26,27,41],consequenti:20,conserv:[18,29],consid:[0,4,8,10,13,14,16,21,22,26,27,28,31,32,34,35,36,39,40,41,44,47,49,50,51,53],consider_all_nod:10,consider_hydrogen:49,consider_ligand:36,consist:[3,8,20,21,25,28,29,31,32,34,35,36,37,40,44,49,51],conspicu:20,constant:[3,25,32,39,41,52],constitut:20,constraint:[13,26,32,34,40],constraintfunct:40,constru:20,construct:[0,3,9,21,22,26,28,29,34,37],constructatompo:9,constructbackboneframeresidu:[47,50],constructcbetapo:9,constructcterminaloxygen:9,constructetd:10,constructframeresidu:50,constructframeresidueheurist:50,constructfrmrotamergroup:[47,50],constructfrmrotamerheurist:50,constructor:[21,25,28,29,32,34,37,40,41,47,49],constructrrmrotamergroup:50,constructrrmrotamerheurist:50,constructsidechainframeresidu:50,contact:[40,53],contactfunct:40,contain:[0,1,2,3,4,5],content:[8,12,17,20,23,26,42,47,54],contigu:[25,36,37],continu:[1,21,29,32,47],contract:20,contrast:45,contribut:4,contributor:20,contributori:20,control:[0,3,8,10,20,31,34,36,40,49,50,51,52],conveni:[1,7,8,18,28,31,34,35],convent:[1,49],converg:[28,31,32,34],convers:[20,37],convert:[4,5,22,25,26,27,35,37,39,41,51,52],convert_module_data:4,convertbasetyp:37,cooler:[3,30,31],coolerbas:34,cooling_factor:[10,34],coord:[26,31],coord_idx:26,coordin:[3,9,26,28,31,32,34,35,38,39,47],coordinfo:26,cope:16,copi:[2,3,4,8,16,18,20,21,22,28,29,31,34,35,40],copyright:20,copyright_cmak:20,core:[0,8,9,10,11],correct:[5,25,50],correctli:35,correspond:[0,10,16,21,22,25,26,27,28,31,37,49,50,51],corrupt:[21,40],could:[1,4,5,8,13,16,25,26,35],couldn:35,count:[14,28,29,34,35,39,41],countenclosedgap:29,countenclosedinsert:29,counter:[28,34],counterclaim:20,counterpart:[31,41,50],coupl:[1,8,16,35],cours:8,coutsia:38,coutsias2005:[32,38],coval:49,cover:[0,1,8,12,13,14,21,25,28,30,34,35],coverag:[0,3,35],cparticl:49,cpp:4,cpr:[49,51],cpu:[18,25,35],cpu_platform_support:25,crambin:[26,31,34],crash:47,createalign:[31,35],createemptyview:28,createentityfromview:[28,36,47],createfromfrmlist:[46,47],createfromrrmlist:46,createfullview:[30,31,35],createscwrl3particl:49,createscwrl4particl:49,createsequ:[26,31,35],createvinaparticl:49,creation:[25,32,49],creator:[25,32],criteria:36,criterion:[10,34],criterium:31,croak:16,cross:[20,28],crucial:8,crude:[0,35],cryst:38,cterminalclos:34,cumul:50,current:[2,4,5,8,10,14,16,21,22,25,26,31,34,35,37,40,41,42,49,50,52],custom:[8,26,34,35,36,37,48,49],customari:20,cutoff:[24,25,31,32,36,39,41],cycl:29,cyclic:[31,32,38],cyd:[49,51],cyh:[49,51],cys_hb3:21,cys_sg:21,cystein:[25,36,44,47,49],d_bin:41,dai:11,damag:20,dampen:25,danc:38,dare:4,dat:[26,37],data1:4,data2:4,data:[0,1,3,4,8,16,17,21,23,24,25],data_:37,data_gener:[3,37,48],data_to_stor:26,data_typ:26,databas:[0,9,23,24],databs:26,datatyp:26,date:[5,7,16,20],davi:38,davis2006:[22,38],dbg:8,dcmake_install_prefix:2,deactiv:10,dead:[10,38],deal:[35,36],debug:[8,10,21],decent:15,decid:[3,8,32,50],decis:27,declar:[4,8,16],decod:13,decompos:[3,10],decomposit:[10,28,46],decreas:34,dedic:[4,8,16],dee:10,deep:[22,35],def:[1,8,21,35],def_angl:21,defend:20,defin:[1,4,8,9,13,14,15,20,21,22,23,24,25],definem:8,degre:[22,26,27],delet:[0,2,8,22,35,49],deliber:20,deliv:[1,26,34,35],delta_scor:34,demand:35,demonstr:26,denovoclos:34,densiti:[22,32,38],dep1:4,dep2:4,dep:4,depend:0,dependency1:4,dependency2:4,depends_on:4,depth:[26,38],deriv:[1,20,26,38,43,44],descend:35,descent:[31,32,38],describ:[0,4,7,8,10,11,17,20,21,22,26,28,29,30,32,33,37,39,41,44,47,48,49,50,51,54],descript:[0,5,13,16,20,34,35,51],descriptor:[26,28],descsrib:10,design:[1,3,19,20],desir:[9,18,25,26,31,32,34,35,39,40,41],despit:3,detail:[0,9,13,16,20,25,26,27,31,33,34,35,39,41,48,49,51],detect:[0,11,28,30],determin:[8,11,20,25,26,31,34,40,41],determinist:28,deuterium:[35,50],develop:[1,3,8,16],deviat:[22,33,34,51],devot:12,dict:[4,28,31,33,34,39,41],dictionari:[4,5,13,15,33,38],did:[8,26,31,35],didn:[7,28],didnt:5,differ:[1,2,4,8,10,15,16,20,21,26,28,29,31,35,39,41,47,49,51],differenti:49,dihedr:[9,18,22,23,25,26],dihedral_angl:22,dihedral_bin:41,dihedral_idx:51,dihedral_pair:27,dihedralconfigur:51,dill:38,dimens:27,dimension:38,dir:[4,8,18],direct:[8,20,22,24,26,41,49,50],directli:[8,10,18,26,31,35,36,40,44,49,51,53],directori:[1,2,4,5,7,8],dirti:1,dirtyccdclos:34,disabl:[1,16],disable_doctest:2,disable_document:2,disable_linkcheck:2,discard:26,disclaim:20,discocontain:40,disconnect:3,discret:[28,39,41],discuss:[20,26],disk:[8,25,28,39,41,51],displai:[11,13,14,20],dissimilar:28,dist:41,dist_bin:41,dist_bin_s:26,distanc:[9,22,26,28,31,35,36,39,40,41,43,49],distance_thresh:28,distant:40,distinct:[21,28,36,51],distinguish:3,distribut:[1,8,20,25,26,27,34,37,39,41,48,51],disulfid:[0,25,32,36,43],disulfid_bridg:[25,36],disulfid_score_thresh:36,disulfidscor:[36,44],dive:[16,35],diverg:8,divers:[26,28],dng:18,do_it:[39,41],doc:[2,4,8,16,20],dock:38,docker:3,dockerfil:[5,7],docstr:13,doctest:[2,8,16],document:[1,2],doe:[1,3,4,8,9,10,11,13,15,16,20,22,26,30,31,34,35,37,40,48],doesn:[8,16,29,32,34,35,51],doesnt:51,doexternalscor:[39,41],dointernalscor:[39,41],domain:28,domin:10,don:[2,10,20,31,35,50],done:[1,8,11,13,16,23,25,27,31,34,35,37],donor:[41,49,50],donorm:[39,41],dont:[0,34],dont_write_bytecod:1,dost_root:2,doubl:28,doubt:13,down:[13,22,26,28,34],download:5,dpm3_runtime_profiling_level:14,draw:[22,27,34],drawback:8,drawn:[27,34],drawphigivenpsi:27,drawpsigivenphi:27,drop:8,dssp:[3,26,41],dssp_state:41,due:[0,26,31,32,35,44],dump:[28,51],dunbrack:[3,38,48],duplic:6,dure:[1,21,32,35,37,45,51],dynam:51,dynamicspatialorgan:3,e_cut:10,e_thresh:[10,35],e_tresh:10,each:[0,8,10,13,14,20,21,22,25,26,27,28,29,31,32,33,34,35,36,37,39,41],earli:3,earlier:2,easi:8,easier:[1,8,20],easili:[4,16,35],echo:8,edg:[10,28],edge_idx:10,editor:1,editori:20,editxc:28,educ:8,effect:[4,8,10,25,36,44],effici:[21,28,34,38,42],egg:26,eigen3_include_dir:2,eigen:[2,3],either:[0,8,13,16,20,21,22,27,29,31,32,34,35,36,37,39,40,41,45,49,51],elabor:[8,20],electron:20,electrostat:[25,32],element:[1,10,21,22,26,28,31,33,37,40,44,50],elimin:[10,38],els:[8,16,36,37],emerg:1,empir:[43,44],emploi:16,empti:[8,11,13,22,26,28,31,35,49],enabl:[1,2,3,11,13,15,25,26],enable_mm:2,enable_ss:2,enclos:[20,29,35],encod:0,encount:[29,34],end:[0,1,2,4,8,10,11,13,16,20,21,22,26,28,29,31,35,38],end_resnum:35,end_transl:4,endian:37,energi:[0,3,8,10,18,25,32,34,35,36,39,41,44,45,46,47,49,50,52],energy_funct:[0,36],enforc:[0,3,21,31,34,35,36,39,40,41],engin:19,enough:[8,16,25,26,35,37],ensur:[2,8,18,31,35,37],ent:[0,13,21,25,26,33,36,42],ent_seq:42,enter:[35,45],entiti:[8,13,14,20,21,22,26,28,33,35,42,47],entityhandl:[13,21,22,26,33,35,36,40],entityview:[26,27,28,33,35],entri:[0,3,8,14,25,26,31,32,33,36,41,47,50],enumer:[8,10,21,25,26,28,31,35,40,47,49,50,51],env:[8,18,21,25,28,32,33,35,36,39,40,41,42],env_po:[32,36],env_structur:[21,40],environ:[1,3,8,21,28,29,31,32,34,35,36,37,39],epsilon:[10,25,36,52],equal:[28,34,39,41,44,50],equidist:51,equival:[28,35,39,41],error:[0,11,13,14,26,32,35,37],especi:28,estim:[10,28,33,34,38,41,44,49,50,51],etc:[1,3,8,16,22,26,31,40],evalu:[4,8,32,35,39,40,41],evaluategromacsposrul:9,even:[2,8,10,20,22,25,29,35],event:[20,28],eventu:13,ever:[16,34],everi:[0,1,8,10,13,21,22,26,27,28,31,32,34,35,36,39,40,41,44,46,49,50,51,52],everyth:[1,2,3,7,8],evolut:38,evolv:42,exact:[0,7,10,13,37],exactli:[2,10,26,28,31,35,40,44,49],exampl:[0,1,2,3,8,11,13,16,17,18,20,21,23,25,26,27,28,30],example_reconstruct:47,exce:[39,41],exceed:[26,29],except:[0,3,13,20,26,29,34,35],exclud:[8,20,26],exclus:[1,8,20,25],exec:7,execut:0,exercis:20,exisit:17,exist:[0,1,2,4,8,10,11,13,14,16,21,22,26,31,32,33,34,35,37,39,40,41,48,49,51],exit:[0,1,11,13],exit_cod:1,exit_statu:11,exot:8,exp:34,expect:[1,3,7,21,25,26,35,36,40,44,50,52],expens:26,experiment:35,explain:[1,8],explan:8,explicit:2,explicitli:20,explor:38,exponenti:34,exponentialcool:34,expos:26,express:[20,44],ext:11,extend:[1,4,8,16,17,24,26,28],extendatcterm:29,extendatnterm:29,extended_search:[31,35],extens:[0,3,11,13,29,35],extension_penalti:29,extent:26,extern:[3,4,5,8,34],external_script:[3,8],extra:[2,3,8,16,22,37,48],extra_bin:26,extra_force_field:35,extract:[8,9,21,22,23,25,26,27,28,30,31,32,34,35,36,39,40,41,44,50],extractbackbon:21,extractloopposit:25,extractstatist:27,extrem:[22,28],f_i:26,f_idx:40,f_vinaparticl:49,facilit:28,factor:[10,25,34,49],fail:[0,1,8,11,14,22,31,32,35],failur:[0,8,11,13,20,35,51],fall:32,fallback:51,fals:[1,8,10,11,13,22,25,26,29,31,34,35,36,44,47,49,50],fantast:8,far:[31,35],fast:[0,9,18,19,21,25,26,27,37,39,40,41,51],fasta:[0,13,30,35],faster:[10,25,26,32,33,40],fastest:[32,35],favor:33,favourit:1,fed:[4,16],fedora:8,fee:20,feed:[4,21,31],feel:[8,16],fellow:8,fetch:[13,16,18,28],few:[2,8,16,25,37,42],ff_aa:25,ff_aa_on:25,ff_aa_two:25,ff_ala:25,ff_arg:25,ff_asn:25,ff_asp:25,ff_cy:25,ff_cys2:25,ff_gln:25,ff_glu:25,ff_gly:25,ff_hisd:25,ff_hise:25,ff_ile:25,ff_leu:25,ff_lookup:[25,32,35],ff_lookup_charmm:37,ff_ly:25,ff_met:25,ff_phe:25,ff_pro:25,ff_ser:25,ff_thr:25,ff_trp:25,ff_tyr:25,ff_val:25,ff_xxx:25,field:[20,35,37,51],fifti:20,figur:16,file:[0,1,2,3,4,5,8],filecheck:16,fileexist:11,fileextens:11,filegzip:11,filenam:[0,8,11,13,25,26,27,28,37,39,41,48,51],filenotfound:33,fill:[4,8,13,16,23,26,29,30,31,33,35],fillfromdatabas:[31,35],fillfrommontecarlosampl:[31,35],fillloopsbydatabas:35,fillloopsbymontecarlo:35,filo:40,filtercandid:33,filtercandidateswithsc:33,final_model:[30,35],find:[3,4,7,8,10,16,21,23],findatom:28,findchain:42,findeigen3:20,findmotif:28,findwithin:[8,28],fine:8,finish:52,fire:[1,7],first:[0,1,8,10,13,16,18,21,22,25,26,27,28,29,31,32,34,35,36,39,40,41,43,44,47,49,50,51],fit:[16,20,22,26,30,31],fix:[3,8,11,16,25,32,36,37,39,41],fix_cterm:32,fix_nterm:32,fix_surrounding_hydrogen:25,flag1:4,flag2:4,flag:[0,2,4,8,10,11,13,22,26,28,35,36,49,50],flanking_rot_angle_on:22,flanking_rot_angle_two:22,fletch:[26,47],fletcher:35,flexibl:[0,19,36,44,47,49,50,52],flip:51,flood:26,fluorin:49,flush:[1,16],fold:38,folder:[2,4,8,16,18,37],follow:[0,1,2,4,5,8,10,11,16,18,20,22,23,25,26,28,29,30,31,35,36,37,39,41,47,49,50,51],fontsiz:27,forbidden:8,forc:[25,32,35],force_const:[25,32],forcefield:23,forcefieldaminoacid:25,forcefieldbondinfo:25,forcefieldconnect:25,forcefieldharmonicangleinfo:25,forcefieldharmonicimproperinfo:25,forcefieldljpairinfo:25,forcefieldlookup:[25,32,35,37],forcefieldperiodicdihedralinfo:25,forcefieldureybradleyangleinfo:25,forg:16,forget:[1,8],form:[14,20,24,25,26,30,35,40,51],formal:[31,32,49,51],format:[0,5,13,20,26,48],formula:33,forward:16,found:[1,3,4,8,11,13,16,19,21,23,26,28,31,32,33,34,35,36,44,46,49,51],foundat:1,four:[9,34],fraction:[26,28,32,34],frag_db:[23,26,31,37],frag_length:[23,26,28],frag_map:26,frag_po:[23,26,28],frag_residu:[23,26],frag_seq:[23,26],frag_siz:26,fragdb:[23,24,26,31,35,37],fragger:[13,23,26,28,34,35],fragger_handl:[13,35],fragger_map:26,fraggerhandl:[0,13,26,28,35],fraggermap:[26,28],fragment:[0,3,9,13,22,23,24],fragment_db:35,fragment_handl:28,fragment_info:26,fragment_length:[26,28],fragmentinfo:[26,31],fragments_per_posit:28,fragmentsampl:34,frame:[3,16,35,36],frame_energi:49,frame_residu:[45,47],frameresidu:[45,49,50],framework:[8,19,38],free:[0,8,20,35,49,51],frequenc:[26,34],frm:36,frmrotam:[44,49,50,52],frmrotamergroup:[44,46,49,50],from:[0,1,2,3,4,5,6,7,8,9,10,11,13,16,18,20,21,22,23,25,26,27,28,29,30,31,32,33,34,35,36,37,38,39,40,41,42],fromhhm:26,fromhoriz:26,fromresidu:51,front:[1,11,16],fstream:37,fudg:25,fulfil:[26,51],full:[0,1,3,8,10,21,25,26,28,29,30,31,34,35,36,47,49,50],full_queri:28,full_seq:[29,31],fullgapextend:[29,35],fulli:[8,16,21,22,26,29,30,36],function_typ:40,functions_specific_to_your_act:8,fundament:37,funni:[2,8],further:[10,28,29,35,36,37,50],furthermor:[37,50],futur:[3,25,26],gamma:[40,41,44],gamma_bin:41,gap:[0,3,9,18,24,25],gapextend:[29,35],gapfre:26,gapless:[0,13],gather:[4,12,16,26,28,47,49,51],gauc:51,gauch:51,gauche_minu:51,gauche_plu:51,gaussian1:49,gaussian2:49,gciiipgatcpgdyan:[31,35],gener:[0,1,2,3,5,8,10,13,14,16,18,19,20,23,24],generatedenovotrajectori:28,generatestructureprofil:26,geom:[21,22,25,26,28,32,35,44,49],geometr:[3,9,23],geoom:43,get:[0,1,2,7,8,16],getaa:[21,22,25],getaaa:21,getaah:21,getactivesubrotam:49,getallatomposit:[21,32,36],getallatomscoringkei:31,getallatomweight:31,getanchoratomindex:21,getangl:47,getangularbins:26,getatomcount:8,getatomnam:21,getatomnameamb:21,getatomnamecharmm:21,getaveragescor:31,getbackbonelist:[23,26],getbackbonescoringkei:31,getbackboneweight:31,getbins:27,getbinsperdimens:27,getbound:22,getc:22,getca:22,getcb:22,getchain:29,getchainindex:29,getchainnam:29,getchains:8,getcharg:25,getclust:31,getclusteredcandid:31,getcollisiondist:49,getconfid:26,getcoordidx:26,getcoordinfo:26,getcpuplatformsupport:25,getcreationd:5,getdefault:[25,32,35],getdefaultlib:5,getdihedralangl:26,getdihedralconfigur:51,getdistbins:26,getdisulfidbridg:25,getdisulfidconnect:25,getdsspstat:26,getel:21,getenviron:21,getenvsetdata:8,getepsilon:25,getfirstindex:21,getforcefieldaminoacid:25,getfragmentinfo:[26,31],getframeenergi:49,getfudgelj:25,getfudgeqq:25,geth1index:21,geth2index:21,geth3index:21,getheavyindex:25,gethistogramindex:[22,27],gethistogramindic:27,gethnindex:21,gethydrogenindex:[21,25],getidentifi:28,getindex:[21,25],getinternalconnect:25,getinternalenergi:49,getinternalenergyprefactor:49,getlargestclust:31,getlastindex:21,getlength:29,getlist:28,getlooplength:25,getloopstartindic:25,getmass:25,getmaxnumatom:21,getmaxnumhydrogen:21,getn:[22,28],getnam:[47,49],getnonbondedcutoff:32,getnum:31,getnumatom:[21,25],getnumb:31,getnumcandid:31,getnumchain:8,getnumcoord:26,getnumfrag:26,getnumhydrogen:21,getnumloopresidu:25,getnumresidu:[8,21,25],getnumstempair:26,getnumsubrotam:49,geto:22,getolc:[21,22],getomegators:[21,22],getoxtindex:25,getpeptideboundconnect:25,getphiprobabilitygivenpsi:27,getphitors:[21,22,47],getpo:[21,28,49],getposit:28,getpotentialenergi:25,getpredict:26,getprob:[27,49],getpsiprobabilitygivenphi:27,getpsitors:[21,22,47],getr:33,getresidu:28,getresiduedepth:26,getringpunch:33,getrotamericconfigur:51,getscor:[26,34],getscoringfunct:49,getselfenergi:49,getseqr:[21,40],getsequ:[21,22,26,31],getsequenceprofil:26,getsequenceprofilescoreskei:31,getsigma:25,getsimul:25,getsolventaccessibilitit:26,getstemrmsdskei:31,getstructureprofil:26,getstructureprofilescoreskei:31,getsubdb:26,getsubrotamerdefinit:49,getsystemcr:32,gettemperatur:[34,49],gettransform:22,getversionnumb:37,getweight:[28,31],ggg:35,gggaggg:35,gggggggggggggggggggg:35,git:[0,1,2,3,4,5,6,7,8,9,10,11,12,13,14,15],gitignor:8,gitlab:53,give:[4,8,16,20,23,28,31,34,35,49],given:[0,1,3,4,8,9,10,11,13,14,21,22,25,26,27,28,29,30,31,32,33,34,35,36,37,39,40,41,44,47,49,50,51],glass:38,gln:[49,51],gln_ne2:21,global:[15,26,31,35,37],glu:[21,49,51],glu_oe1:21,glutam:49,glutamin:49,gly:[35,36,47,49,50],gly_n:21,glycin:[3,22,26,32,36,49],goal:[1,10,28,30],goe:[2,8,14,16,35,51],goldfarb:35,goldstein1994:[10,38],goldstein:[10,38],good:[4,8,18,25,26,35],goodwil:20,got:2,govern:20,grain:8,grant:20,graph:3,graph_initial_epsilon:36,graph_intial_epsilon:36,graph_max_complex:36,graphminim:[10,46],greatest:5,grep:2,grid:26,gromac:9,grossli:20,group:[4,14,24,26,27,28,41,44,45,46,47],group_definit:[27,41],group_idx:41,guarante:[26,28,31,34,36,37],gui:[8,27],guid:32,guidelin:[8,37],gzip:[0,5,11,13],haa:38,hand:[0,2,4,13],handl:[3,8,9,13,19],handler:28,happen:[1,8,25,28,29,34,35,49],hard:[43,49],hardwar:18,harmless:20,harmon:[25,32],harmonic_angl:25,harmonic_bond:25,harmonic_improp:25,hasattr:35,hasdata:26,hasfraglength:26,hasfragmentinfo:31,hash:[3,26,28],hash_thresh:28,hash_tresh:28,hasringpunch:33,have:0,hbond:[28,35,41,49,50],hbond_scor:37,hbondscor:[35,37],headach:8,header1:4,header2:4,header3:4,header4:4,header:[0,2,4,16,17],header_output_dir:4,headlin:8,heavi:[21,25,36,39,49,50],heavili:[26,47],helic:[22,24,25,28,35,41],helix:[18,22,34,47],hell:28,hello:37,hello_world:8,hellyeah:18,help:[0,1,2,4,7,8,13,16,18,25,41],helpactiontest:1,helper:4,hen:26,henc:[8,14,21,26,37],here:[0,1,2,4,8,11,13,14,16,18,19,21,22,25,26,27,28,30,31,32,34,35,37,39,41,44,48,51],herebi:20,herein:20,het:35,heurist:[3,35,50],heuristicprocessor:21,hg_po:49,hgfhvhefgdntngcmssgphfnpygkehgapvdenrhlg:0,hhblit:[0,13],hhm:[0,13,26,31],hhsearch:26,hide:[8,16],hierarch:[31,40],hierarchi:15,high:[3,8,16,28,30,35],high_resolut:22,higher:[31,40,41],highest:15,highli:[2,8],hint:13,histidin:[25,49],histogram:[27,34],histori:16,hit:[1,10,16,27,32],hmm:38,hold:[20,28],home:[4,5],homo:[0,13],homolog:[0,12,18,19,35,38],homologu:26,honor:35,honour:35,hook:8,horiz:26,horribl:50,host:[4,7,8,16],hotfix:16,how:[1,7],howev:[5,20,26],hparticl:49,hpp:37,hsd:[49,51],hse:[49,51],html:[2,8,16],http:[7,8,18,19,20,53],hybrid:51,hydrogen:[3,21,22,25,35,38,41,49,50],hydrophob:49,hyphen:1,i_loop:[25,36],i_vinaparticl:49,id_:37,idea:[1,8,21,23,25,26,35,40,49,52],ideal:[22,32,52],ident:[3,26,27,28,41,51],identif:20,identifi:[0,3,13,14,20,26,28,31,35,36,39,41,49,50,51],idx:[10,21,22,25,26,28,32,40,49],idx_ca_res_37:21,idxhandl:8,iff:[26,29,33],ifstream:37,ignor:[0,25,28,32,35],iii:20,illustr:26,image_nam:[5,7],imagehandl:22,imagin:8,imaginari:1,img:[7,22],immedi:[1,8,15,16],impact:[0,25,26],implement:[3,16,19,26,28,29,32,34,35,37,43,44,46,47,49,50,53],impli:20,implicit:2,improp:25,improv:[3,20,25,35,38,44],in_dir:4,in_fil:8,in_path:4,in_stream:37,in_stream_:37,inabl:20,inaccur:25,inaccurate_pot_energi:25,inact:52,inactive_internal_energi:52,incident:20,incl:[25,26,35],includ:[2,3,8,11,16,18,20,21,25,26,28,29,31,33,35,37,39,41,47],include_atom:28,include_ligand:35,inclus:[20,35],incompat:[31,32],incomplet:[35,48],inconsist:[10,13,21,22,25,26,29,31,32,36,40,49],inconveni:16,incorpor:20,increas:[0,10,28,31,32,35,50],increment:28,incur:20,indemn:20,indemnifi:20,independ:[0,3,25,36,48],index:[8,10,21,22,25,26,27,28,29,31,32,33,34,35,39,40,41,45,49,50,51],index_four:25,index_on:25,index_thre:25,index_two:25,indic:[8,10,11,13,20,21,22,25,26,27,28,29,31,32,35,36,40,44,47,49],indirect:20,individu:[20,39,41],inf:[10,32,35],infin:32,infinit:32,influenc:[13,28,40,50],info:[26,31,35,40],inform:[0,5,7,8,13,16,20,22,23,26,28,29,31,34,35,38,40,41,42,53],infring:20,inherit:[1,39,40,41,46],init:16,init_bb_list:34,init_frag:34,initi:[3,10,21,22,26,28,31,32,34,35,36,39,40,41,46,49,50,51],initial_bb:31,initial_epsilon:[10,52],initialis:1,inlin:37,inner:14,input:[0,1,3,13,16,18,25,26,27,28,32,34,35,36,39,40,41,44,48,52],insert:[21,22,29,31,34,35,52],insertinto:[21,22,31],insertloop:[29,35],insertloopcleargap:[29,31,35],insid:[1,4],insight:16,instanc:[3,8,13,24,25,37,53],instead:[0,1,2,3,4,8,11,26,28,29,31,34,35,50],institut:20,instruct:2,int16_t:37,int32_t:37,int_32_t:37,integ:[8,13,21,40],intend:[1,8,34,49],intent:26,intention:20,interact:[3,8,25,32,39,40,41,43,44,45,49],intercept:[39,41],interest:[1,10,25,26,34,37,49,51],interfac:[0,3,4,8,20,50],intermedi:8,intern:[0,1,3,4,5,8,16,21,24,25,26,27,28,31,32,34,35,36,37,38,39,40,41,46,49,50,52],internal_e_prefac:50,internal_e_prefactor:49,internal_energi:49,internet:8,interpl:51,interpol:[40,51],interpret:[8,11],intervent:8,intrins:2,introduc:[1,3,4,8,16,32,35],invalid:[8,21,25,26,29,32,35,36,39,40,41,45,49,51],invalid_vinaparticl:49,invok:[2,4,8,15,16],involv:[16,30,44,49],iodin:49,iostream:37,irrevoc:20,is_c_ter:[25,36],is_cter:25,is_hbond_acceptor:50,is_hbond_donor:50,is_major:35,is_n_ter:[25,36],is_nter:25,isallatomscoringsetup:[31,35],isallset:21,isanyset:21,isbackbonescoringsetup:35,isctermin:29,isempti:31,isen:14,isntermin:29,isoleucin:49,isset:21,issimilar:51,issourc:37,issu:3,istermin:29,isvalid:47,item:[1,8,16,21,22,25,26,35,40],iter:[10,26,27,28,31,32,34,35,49],itself:[3,4,8,16,26,34,36,37,39,41],januari:20,job:[8,26,34,35],johner:38,join:[8,21,23,26,31,32,34,36],jone:[38,49],jones1999:[26,38],journal:38,json:[0,13],jupyt:7,just:[1,2,8,13,15,16,23,25,26,28,29,31,35,50],kabsch1983:[26,38],kabsch:38,keep:[0,1,2,4,5,8,13,16,28,30],keep_non_converg:31,keep_sidechain:[8,36],kei:[0,13,26,28,31,34,35,39,40,41],kept:[8,16,25,31,32,36,45,49],kernel:38,keyword:27,kic:[30,31],kicclos:34,kick:13,kill_electrostat:25,kind:[1,8,20],kinemat:32,know:[2,51],knowledg:51,known:[4,11,21,40,50],krivov2009:[10,38,47,49],krivov:38,kwarg:1,l_e:49,lab:48,label:[16,25],lack:35,languag:[4,20],larg:[5,27,32,35],larger:[10,14,22,26,28,35,50],largest:[28,31,44],last:[1,3,4,21,22,25,29,31,32,34,35,40,41,48],last_psi:22,later:[1,8,10,21,28,47],latest:[2,5,7,8],latter:[0,5,16,35],launcher:[4,8],law:20,lawsuit:20,layer:44,layout:[26,37],lbfg:35,leach1998:[10,38],leach:38,lead:[0,8,9,11,22,25,31,32,36,39,41,48],learn:28,least:[0,2,4,8,10,16,20,22,25,26,35,39,41,44],leav:1,left:[11,32],legal:[8,20],lemon:38,len:[22,23,25,26,28,31,35,36,41,47],length:[0,9,10,21,24,25,26,27,28,29,31,32,34,35,36,37,39,40,44],length_dep_weight:35,length_depend:31,lennard:49,less:[0,10,16,22,25,26,27,31,35,39,41,50,51],let:[1,7,8,22,26,28,31,47],letter:[3,5,21,22,26,27,34,49],leu:49,leu_h:21,leucin:49,level:[2,3,8,14,15,16,30,35],lexicograph:35,liabil:20,liabl:20,lib64:8,lib:[5,7,37],libexec:[4,8],libpromod3_nam:4,librari:[0,3,4],library1:4,library2:4,licenc:48,licens:3,licensor:20,life:16,ligand:[3,35,36,49,50],like:[0,1,4,7,8,16,35,37,48],limit:[0,3,20,26,32,35],line:[0,1,7,8,9,12],linear:[26,28,31,34,39,40,41],linear_weight:[31,34,39,41],linearcombin:31,linearscor:34,link:[0,2,4,8,16,20,21,25,26,28,34,36,39,40,41,42],link_cmd:4,linkcheck:[2,8,16],linker:[4,35],linker_length:35,list:[0,1,2,3,4,8,9,10,11,13,20,21,22,25,26,27,28,29,30,31,32,33,34,35,36,37,39,40,41,44,45,46,47,49,50,51,52],listen:8,literalinclud:8,litig:20,littl:[4,8,16,37],live:[4,8],lj_pair:25,load:[1,8,13,15,21,23],loadalign:[30,35],loadallatominteractionscor:39,loadallatompackingscor:39,loadamberforcefield:35,loadbb:26,loadbbdeplib:[0,36,47,48],loadcach:28,loadcbetascor:[31,34,41,42],loadcbpackingscor:41,loadcharmm:25,loadcharmmforcefield:35,loaddefaultallatomoverallscor:39,loaddefaultbackboneoverallscor:41,loadent:[0,13],loadfragdb:[23,24,31,35],loadhbondscor:41,loadlib:[0,36,48],loadpdb:[8,21,23,25,26,28,30,31,32,34,35,36,42,47],loadport:[25,26,27,37,39,41,51],loadreducedscor:41,loadsequenceprofil:[13,26,31],loadssagreementscor:41,loadstructuredb:[23,24,26,31,35],loadtorsionsampl:[22,24,27,34],loadtorsionsamplercoil:[24,31,35],loadtorsionsamplerextend:24,loadtorsionsamplerhel:24,loadtorsionscor:41,local:[2,5,7,25,26,27,39,41,51],localhost:7,locat:[2,3,4,5,10,22,24,26,28,29,37,39,41,49],log:[11,16,33,35,49,50],logic:0,loginfo:33,lone:49,lone_pair:49,longest:26,look:[5,8,11,16,22,26,36,40,50],lookup:[9,21,23],looooooong:10,loop:[0,3,8,13,18,19,21],loop_candid:31,loop_length:[25,26,31,36],loop_main:8,loop_po:25,loop_seq:31,loop_start_indic:[25,36],loopcandid:[28,30],loss:[16,20],lossi:26,lost:[1,16],lot:[1,8,13,16],low:[1,8,10,50],lower:[31,34,35,39,41],lowest:[31,34,49],lowest_energy_conform:34,lysin:49,m_idx:28,m_vinaparticl:[49,50],machin:[25,26,27,37,39,41,51],macro:[4,8],macromolecul:38,made:[4,20,51],magic:[8,37],mai:[0,1,2,4,8,11,13,16,20,21,25,29,32,35],mail:20,main:[8,35,37,51],mainli:[21,34,49],maintain:[8,16],maintin:34,major:[16,35],makefil:[2,8],makestat:51,malfunct:20,malici:16,man:[2,8],manag:[4,8,20,42],mani:[11,13,26,28,32,33,35,50],manipul:22,manner:[8,10,34],manual:[1,2,5,8,9,16,26,31,34,35,37,49],map:[0,13,21,22,26,28,33,36],mariani:38,mark:[4,20,50],mass:25,massiv:28,master:[8,16],mat3:9,mat4:[9,22,28,35],mat:28,match:[0,4,13,22,25,26,27,28,31,32,34,35,40,41],materi:[1,8],math:33,mathemat:[31,32],matplotlib:27,matric:38,matrix:[9,26,28],matter:[4,7,28,53],max:[9,10,21,29,33,35,36,41,51,52],max_alpha:41,max_beta:41,max_complex:[10,52],max_count:[39,41],max_d:41,max_dev:34,max_dist:[31,40],max_extens:35,max_gamma:41,max_iter:[28,31,35],max_iter_lbfg:35,max_iter_sd:35,max_length:29,max_loops_to_search:35,max_n:10,max_num_all_atom:35,max_p:50,max_prob:49,max_res_extens:35,max_step:32,max_to_show:14,max_triangle_edge_length:28,max_visited_nod:10,maxfraglength:26,maxim:[10,26,28,31,32,34,35,38,40,41],maximum:[10,26,31,32,34,49,50],mc_closer:34,mc_cooler:34,mc_num_loop:35,mc_sampler:34,mc_scorer:34,mc_step:[10,35],mcsolv:10,mean:[4,8,13,16,20,21,25,28,32,35,36],meaning:[26,31],meant:[18,21,26,33,35,50],measur:28,mechan:[18,20,31,32,34,35,40],meddl:[7,35],media:20,medium:20,meet:20,member:[8,13,31,35],memori:[10,26,35,37],mention:[1,2],merchant:20,mere:20,merg:[16,25,28,29,31,35,36,40,49],merge_dist:35,mergegap:29,mergegapsbydist:35,mergemhandl:35,mess:[8,16,40],messi:16,met:49,metal:49,methionin:[35,49],method:[0,1,10,13,21,25,26,27,32,35,36,37,50],metric:40,metropoli:[10,31,34],mhandl:[29,30,31,35],middl:16,might:[10,25,26,28,31,32,34,40,50,52],min:[31,41],min_alpha:41,min_beta:41,min_candid:31,min_d:41,min_dist:40,min_gamma:41,min_loops_requir:35,min_scor:31,min_triangle_edge_length:28,mincadist:22,mind:[1,8],minim:3,minimizemodelenergi:35,minimum:[22,26,28,44],minor:[3,25,35],mirror:37,miser:14,mismatch:[21,35,40],miss:[0,11,13,25,35],mix:[0,4],mkdir:[2,8],mm_sy:[25,32],mm_sys_output:25,mm_system_cr:32,mmcif:[5,11],mmsystemcr:[25,32],mod:8,mode:[1,51],model_termini:35,modelling_issu:35,modellinghandl:[3,29,31,35],modellingissu:35,modeltermini:35,modif:[20,35],modifi:[8,16,20,22,31,35],modified_crambin:31,modul:[1,3],modular:19,module_data:4,mol:[8,9,18,21,22,23],molecular:[18,32,35],molprob:30,molprobity_bin:33,molprobity_execut:33,moment:8,monitor:1,monolith:8,mont:[0,3,10,28,31,34,35,46],montecarlo:3,mood:8,more:[1,2,4,7,8,10,13,14,16,20,28,35,44,49,53],most:[0,3,4,5,8,22,25,26,27,28,31,32,35,39,41,48,50],mostli:[4,16],motif:3,motiffind:28,motifmatch:28,motifqueri:28,motion:[22,38],mount:[5,7],movabl:25,move:[2,3,8,16,25,31,32,34,35,37],movement:28,mpscore:33,msg:11,msgerrorandexit:11,msm:3,msse4:2,much:[10,26,35],multi:18,multipl:[0,2,3,4,8,13,14,18,25,28,31,35,36,39,41],multipli:[10,34],multitempl:13,multithread:38,must:0,mutlipl:13,my_db_on:26,my_db_two:26,my_script:7,myclass:37,myclassptr:37,mytrg:0,n_a_vinaparticl:49,n_ad_vinaparticl:49,n_coord:9,n_d_vinaparticl:49,n_num:29,n_po:[9,22,41],n_stem:[9,23,26,29,31,32,34],n_stem_phi:34,n_ter:[32,50],n_vinaparticl:49,naivesolv:10,name:[0,1,3,4,5,7,8,11,13,14,20,21,25,26,27,29,31,33,35,44,48,49,51],name_pymod:4,namespac:[7,13,37],nan:[32,35,51],nativ:37,necessari:[8,22,34,40],necessarili:[20,52],need:[1,2,3,4,5,8,11,13,15,16,22,25,26,27,28,31,32,35,36,37,39,40,41,47,50],need_config_head:4,neg:[1,10,25,32,40],negelect:[0,35],neglect:[28,32,45,49,50],neglect_size_on:31,neglig:20,neighbor:[8,21,35],neighbour:[28,35,51],network:[22,44],never:[13,16,26,31,35,36,37,39,41],nevertheless:8,new_default:25,new_env_po:21,new_po:21,new_res_nam:49,new_siz:22,newli:[5,21,34],next:[1,8,16,22,27,28,29,37],next_aa:34,nglview:7,nice:8,nitrogen:[9,22,32,43,49,50],nobodi:1,node:10,node_idx:10,node_idx_on:10,node_idx_two:10,non:[0,4,10,13,16,20,24,25,27,28,29,31,32,35,37,47,48,50],non_rotamer:51,nonbonded_cutoff:[25,32],none:[13,26,28,33,34,35,36,49],nonredund:26,nonzero:51,norm:[28,41],normal:[20,39,41],normalis:40,notabl:26,note:[0,2,8,13,14,21,22,25,26,28,31,32,34,35,36,37,39,40,41,47,49,50],notebook:7,noth:[0,4,8,13,14,20,28,34,49],notic:[1,4,16,20],notwithstand:20,novel:[19,38],novo:3,now:[3,8,14,16,18,22,26],nparticl:49,nterminalclos:34,null_model:31,num:[23,28,31,32,36],num_frag:[26,35],num_gap_extens:29,num_loop:31,num_residu:[21,25,34,36,39,40,41],num_residues_list:36,num_trajectori:28,number:[0,1,8,9,10,13,14,18,21,22,24,25,26,27,28,29,31,32,34,35,36,37,39,40,41,42,44,45,49,51],numer:35,numpi:[27,34],nussinov1991:[28,38],nussinov:[28,38],o_a_vinaparticl:[49,50],o_ad_vinaparticl:49,o_d_vinaparticl:49,o_po:22,o_vinaparticl:49,object:[0,3,8,13,14,20,21,22,23],oblig:20,observ:[10,26,28,32,50,52],obtain:[10,18,20,23,28,35],obviou:16,occupi:[45,50],occur:[21,28,35,40,41],ocparticl:49,odd:26,off:[1,8,14,35],offend:33,offer:[6,20,24,30,49,51],offset:[0,3,13,26,31,35],ofstream:37,often:[8,11,13,32],og_po:49,olc:22,old:[33,35],oligom:[0,13,30],oligomer:3,olson:38,omega:[21,22],onc:[1,3,8,16,25,28,31,32,34,46,51,52],one_letter_cod:[21,23,26,31,32,34,36],onli:[0,1,2,4,8,10,11,13,14,15,16,20,21,22,25,26,28,29,31,33,34,35,36,37,39,41,44,47,48,49,50],only_longest_stretch:26,onto:[1,22,26,28],oparticl:49,open:[13,25,26,27,37,39,41,51,53],openmm:[2,18,25,32],openstructur:[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],oper:[3,10,16,18,21,26,40],opt:[11,13,16],optim:[0,2,3,10,13,25,26,27,31,35,38,39,41,44,47,48,51],optimis:8,optimize_subrotam:[36,44],option:[0,2,3,5,7,13,26,31,32,35,51],order:[0,5,13,21,25,26,29,31,35,37,40],org:20,organ:[8,26,51],orient:[9,32,41],orig_indic:[31,33],origin:[5,7,9,13,16,20,22,26,31,34,35,40,52],orthogon:28,ost:[0,1,2,3,4],ost_complib:[5,7],ost_double_precis:2,ost_ent:33,ost_librari:4,ost_root:[2,8],other:[0,1,2,3,4,8,10,14,16,20,21,22,31,32,35,36,39,41,42],other_index:22,other_particl:49,other_res_index:21,otherwis:[1,4,8,10,14,16,20,21,22,25,26,28,29,31,32,34,39,40,41,49,51],our:[4,5,8,16,26,28,31],out:[0,1,2,4,8,14,16,20,21,25,26,27,28,29,31,34,47,51],out_path:4,out_po:25,out_stream:37,out_stream_:37,outdat:[5,7],outer:[14,26],outlier:33,output:0,output_dir:4,outsid:[8,40],outstand:20,over:[2,4,13,16,26,28,32,34,35,49],overal:[10,34,40,46],overhead:25,overlap:[25,34,35,36],overli:16,overload:37,overrid:[2,5,25,50],overridden:4,overriden:5,overview:[8,16],overwrit:31,overwritten:25,own:[1,3,4,5],owner:20,ownership:20,oxt:[9,21,25],oxygen:[22,35,43,49,50],p_vinaparticl:49,pack:21,packag:[4,8,16],pad:[22,37],page:[2,8,20],pai:1,pair:[9,25,26,27,28,32,34,36,37,39,40,41,44,49,51],pairwis:[3,8,10,22,28,31,35,39],pairwise_energi:10,pairwisefunct:[40,41],pairwisefunctiontyp:40,pairwisescor:[8,35],paper:[43,44,47,49],paragraph:[1,8],parallel:26,paramet:[1,4,8,9,10,11,13,14,15,21,22,24,25,26,27,28,29,31,32,33,34,35,36,38,39,40,41,43,44,45,46,48,49,50,51,52],parameter_index:26,parametr:[3,32,35,36,49,50],parent:35,pars:[0,11,12],parser:12,part:[0,1,8,16,18,20,21,26,34,35,40,44],partial:29,particip:[36,44],particl:[3,25,26,32,41,43,44,45,47],particle_typ:49,particular:[8,10,20,26,31,32,34,49,51],partner:[39,40,41],pass:[13,16,21,25,26,28,29,32,34,44,45,49,50],past:[8,16,22,29],patent:20,path:[1,2,4,5,8,11,16,18,25,26,27,33,39,41,51],path_to_chemlib:15,path_to_dockerfile_dir:5,path_to_promod3_checkout:6,pattern:38,paus:14,pdb:[0,5,8,11,13,18,21,22,23,24,25,26,28,30,31,32,33,34,35,36,42,47],penal:[29,35],penalti:[29,35],penultim:3,peopl:16,pep:[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],peptid:[3,21,23,25,26,28,35,36,47],peptide_sel:28,per:[4,8,10,12,16,21,27,31,34,35,39,40,41,44],percent:20,percentag:33,perfect:8,perfectli:8,perform:[0,10,16,18,19,20,25,28,31,32,33,34,35,37,40,44],period:25,periodic_dihedr:25,periodic_improp:25,permiss:[8,20],permut:10,perpetu:20,pertain:20,phase:25,phe:[49,51],phenix:33,phenylalanin:49,phi:[21,22,26,27,32,34,41,47,50,51],phi_bin:[41,51],phi_handl:47,philippsen:38,phipsisampl:34,phosphoru:49,phosphoserin:35,phrase:8,pick:[31,34],pictur:8,piec:[8,28],pipelin:[0,3,14],pivot:[31,32,34],pivot_on:[31,32],pivot_thre:[31,32],pivot_two:[31,32],place:[1,2,4,8,11,13,16,20,26],plain:[0,13],plan:16,plane:33,platform:[18,25],playground:7,pleas:[2,8,16,28,31,32,35,53],plot:27,plt:27,plu:[8,13,15,26,44,49],pluribu:28,pm3_csc:16,pm3_openmm_cpu_thread:[18,25,35],pm3_runtime_profiling_level:14,pm3argpars:[0,11,12],pm3argumentpars:[0,11,13],pm_action:[1,4,8],pm_action_init:8,pm_bin:1,pna:38,png:27,pocket:28,pocket_view:28,point:[2,7,8,13,15,21,26,28,34,35,40,49,51],pointer:[2,8,37],polar:[49,50],polar_direct:49,polici:8,pop:[16,31,34,40],popul:[2,16],port_str_db:26,portabl:[4,17,25,26,27],portable_binary_seri:37,portable_fil:4,portablebinarydatasink:37,portablebinarydatasourc:37,pos_end:28,pos_on:28,pos_start:28,pos_two:28,posit:[3,8,9],possibl:[0,3,8,10,13,16,20,22,25,26,27,28,29,31,32,34,35,36,37,39,40,41,44,46,49,51],post:13,postprocess:36,pot:25,pot_:32,potenti:[10,23,25,26,28,31,32,35,36,37,38,41,49],power:20,pqhpg:0,practic:[4,8,25,26],pre:[8,16],pre_commit:[8,16],preceed:36,precis:[2,31,35],precomput:23,pred:40,predefin:[4,18,25,35,39,41],predict:[13,26,28,35,38,40,41],prefactor:49,prefer:[2,4,20,26,51,52],prefilt:35,prefix:[1,4,8,11],prepar:[8,20,35],present:[22,28,32,36,49,50,51],prev_aa:34,prevent:[1,8],previous:[25,26,31,36,40],primary_rot_angl:22,principl:[3,34,40],print:[1,2,5,20,22,23,25,26,31,32,33,35,42],printstatist:26,printsummari:14,prior:35,privat:[1,37],pro:[21,27,49,51],probabilist:[26,50],probability_cutoff:50,probabl:[4,8,10,13,16,26,27,28,31,32,34,49,50,51],problem:[3,7,10,13,16,26,28,31,32,34,35,40,42,44,46,48,52],problemat:[3,5,28],proce:42,procedur:[10,28,34,36,50],process:[1,3,13,16,21,25,28,32,34,35,37,40,45,49,51],processor:5,produc:[0,1,2,4,8,10,26,29,33,35],product:[1,3,16,20],prof:[0,26,31],prof_dir:26,prof_path:26,profil:[0,3,12,13],profiledb:26,profilehandl:[13,26,28,31,35],prog:13,program:[4,5,8,12],project:[3,4,8,16],prolin:[22,33,49],promin:[0,20],promod3_mod:4,promod3_nam:4,promod3_name_head:4,promod3_path:8,promod3_root:8,promod3_shared_data_path:[8,37],promod3_unittest:[1,4,8],promod:[5,7],promot:8,propag:[8,22],proper:[16,26,50],properli:[1,35,39,41,50],properti:[21,22,35,50,51],propos:[29,31,32,34,44],proposed_posit:34,proposestep:34,prot:[8,23,26,28,32,34,36,47],prot_rec:8,protein:[0,18,19,24,25,28],proteinogen:26,proton:[21,25,49,51],prototyp:19,provid:[0,1,2,3,4,5,7,8,13,16,20,21,22,23,25,26,28,29,31,32,33,34,35,36,37,40,48,49,50,51],prune:[10,52],pscoringfunct:49,pseudo:[34,35,39,41],psi:[21,22,26,27,32,34,41,47,50,51],psi_bin:[41,51],psi_handl:47,psipr:[13,26,28,40,41],psipred_confid:41,psipred_pr:28,psipred_predict:[26,28,35],psipred_st:41,psipredpredict:23,pssm:[0,13],publicli:20,pull:[7,8,16,18],punch:[1,3,30],pure:0,purpos:[8,10,20,35,51],push:[7,16],pushverbositylevel:13,put:[1,4,8,11,13,35],pwd:5,py_run:[1,4,8],pyc:1,pylint:16,pylintrc:16,pymod:[4,8,16],pyplot:27,pytest:8,python2:8,python:[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],python_root:2,pythonpath:8,qmean:2,qmeandisco:40,qualiti:35,quantum:38,queri:[26,28,51],query_idx:28,query_list:28,querylib:51,question:[3,27],quickli:[5,8,32],quit:[8,13],rackovski:38,radian:[9,22,25,27],radii:[33,43],radiu:[8,33,39,41,49],raihvhqfgdlsqgcestgphynplavph:0,rais:[0,9,10,13,21,22,25,26,27,28,29,31,32,33,34,35,36,39,40,41,44,45,49,50,51],rama_iffi:33,ramachandran:33,random:[10,22,24,27,31,32,34],random_se:31,randomized_frag:22,randomli:[27,34],rang:[8,9,21,22,23,25,26,27,28,29,32,34,35,39,40,41,51],rank:31,rapid:38,rare:8,rather:[5,7,8,11,16,34,51],raw:[7,18,25,26,27,30,31],rawmodel:[3,8],reach:[0,29,32],read:[0,8,11,13,16,25,26,27,29,36,37,39,41,48,51],readabl:[0,8,13,20,51],readdunbrackfil:48,reader:[16,18],readi:[2,51],readm:[2,8,48],real:[8,13,37],realli:[1,2,8,11,16],reappear:16,reason:[8,16,20,32,34,52],rebas:16,rebuild:[2,8],recalcul:27,receiv:20,recent:[3,16],recip:[3,6,7],recipi:20,recoginz:49,recogn:[0,13],recognis:[1,8,16],recognit:38,recommend:[2,5,8,20,25,35],reconstruct:[0,3,8,18,21,22,25,30,32,35],reconstructcbetaposit:22,reconstructcstemoxygen:22,reconstructor:[32,35,36],reconstructoxygenposit:22,reconstructsidechain:[0,8,35,36],reconstructtest:8,record:[1,35],recreat:16,redistribut:20,redo:28,reduc:[3,25,28,35,41],reduced_scor:37,reducedscor:[35,37],redund:[24,31],ref_backbon:[23,26],ref_fil:8,refactor:3,refer:[1,4,8,18,19,21,22,23,25,26,34],referenc:8,refin:28,refine_thresh:28,refresh:31,regard:[20,32,44],region:[0,25,28,29,32,34,35,45,50],regist:[4,8],registri:7,regress:38,regularli:5,reinterpret_cast:37,reject:[31,32,34],rel:[4,5,9,10,26,28,32,41],relat:[4,8,13,26,28,37,38,49],relax:30,relev:[2,3,4,7,25,28,36,49],reli:5,remain:[20,30,34,35],rememb:[1,8,34],remodel:[31,36],remodel_cutoff:36,remov:[2,3,10,22,25,26,29,31,33,35,36,40,47,49],removecoordin:26,removeterminalgap:35,renumb:[26,35],reorder:35,reordergap:35,repeat:28,replac:[3,20,21,22,34,35],replacefrag:22,report:[1,8,35],reportmolprobityscor:33,repositori:[1,4,8,16,53],repres:[10,20,21],represent:[22,23,25,26,27,37,39,41,49,51],reproduc:[3,20,35],reproduct:20,repuls:49,request:[26,28,48,51],requir:[0,2,3,5,8,13,16,19,20,21,22,26,27,28,31,32,35,36,37,42,49,50,51],reread:26,res_depth:26,res_idx:[49,50],res_index:21,res_indic:[21,25,36],res_list:[21,25,32,36],res_num:21,resembl:[16,28],reserv:11,reset:[10,21,25,32,34,40,49],resid:5,residu:[0,3,8,9,21,22,23,24,25,26,27,28,29,31,32,33,34,35,36,38,39,40,41,42,44,45,47,49,50,51],residue_depth:26,residue_index:[45,49,50],residue_list:35,residuedepth:26,residuehandl:[9,21,22,26,29,31,32,33,34,35,49,50,51],residuehandlelist:21,residueview:35,resiz:[22,37],resnum:[21,22,29,31,35,36,40],resnum_on:40,resnum_rang:35,resnum_two:40,resolut:[22,32],resolv:[16,21,32],resolvecystein:44,resort:35,respect:[9,25,28,35],respons:[8,16,20],rest:[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],restart:7,restor:[22,31,34,40],restraint:[26,32],restrict:[8,16,29],restructuredtext:[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],result:[0,2,8,10,20,25,27,28,31,32,33,34,35,36,38,44,51],resum:14,retain:20,reus:[35,36],review:[16,53],revis:20,reviv:16,rewrit:1,richardson:38,ridig:36,right:[1,2,8,13,20],rigid:[0,3],rigid_frame_cutoff:36,rigidblock:28,rij:43,ring:[3,30],ring_punch_detect:35,risk:20,rmsd:[22,23,26,28,31,32],rmsd_cutoff:[26,31,32],rmsd_thresh:[26,28],rname:28,rnum:40,robot:38,role:13,root:[2,4,8,16],rosetta:41,rot:36,rot_constructor:47,rot_group:[47,50],rot_lib:50,rot_lib_entri:50,rota_out:33,rotam:[0,3,33,36,38,44,45],rotamer:[48,51],rotamer_group:[44,46,47],rotamer_id:47,rotamer_librari:[3,35,36,48],rotamer_model:36,rotamer_on:44,rotamer_res_indic:36,rotamer_two:44,rotamerconstructor:[3,47,49],rotamergraph:[36,46,47,52],rotamergroup:49,rotamerid:47,rotamerlib:[35,36,37,48,50,51],rotamerlibentri:[50,51],rotat:[9,22],rotatearoundomegators:22,rotatearoundphipsitors:22,rotatearoundphitors:22,rotatearoundpsitors:22,rotationaroundlin:9,roughli:24,round:51,routin:[1,18,31],royalti:20,rrm:36,rrmrotam:[44,49,50],rrmrotamergroup:[44,46,49,50],rst1:4,rst2:4,rst:[4,8,16],rsync:8,rule:[5,8,9,16],run:0,runact:1,runexitstatustest:1,runmolprob:33,runmolprobityent:33,runnabl:8,runner:1,runtest:[1,8],runtim:[0,3,10,12],runtimeerror:[9,10,21,22,25,26,27,29,31,32,34,35,36,39,40,41,44,45,48,49,50,51],runtimeexcept:27,s_id:26,s_vinaparticl:49,safe:[2,8],said:4,same:[0,1,2,4,7,8,10,13,14,20,21,25,26,28,31,32,34,35,36,37,39,40,41,42,45,48,49,50,51],samiti:35,sampl:[0,3,8,22,23],sampled_frag:34,samplemontecarlo:[3,34],sampler:[3,23,24,26],samplerbas:34,sampling_start_index:34,sander:38,saniti:2,sanity_check:2,satisfi:49,save:[16,22,25,26,27,28,31,34,37,39,40,41,51],savebb:26,savecach:28,savefig:27,savepdb:[18,21,22,25,26,28,30,31,32,34,35,36,47],saveport:[25,26,27,37,39,41,51],sc_data:32,sc_rec:[32,36],sc_rec_test:36,sc_result:32,scale:22,scatter:27,scheme:[1,8,13,21,26,29,34],schenk:38,schmidt:38,schwede:[8,18,19,38,53],sci:38,scicor:[8,18,19,53],scondari:35,scope:14,score:[0,3,8,13,19,23,26,28,29,30],score_contain:31,score_env:[31,34,42],score_threshold:44,score_vari:35,scorecontain:31,scorer:3,scorer_env:[28,31,34],scorerbas:34,scoring_weight:28,scoringgapextend:[29,35],scoringweight:[28,31,35],scratch:[26,34],scriptnam:11,scriptpath:8,scwrl3:[36,42],scwrl3disulfidscor:[43,44],scwrl3pairwisescor:43,scwrl3rotamerconstructor:50,scwrl4:[0,36,38,44,47],scwrl4particletyp:49,scwrl4rotamerconstructor:[3,47,50],scwrlrotamerconstructor:3,seamlessli:16,search:[0,2,3,8,21,26,28,31,33,35,36,41,44,49,50],searchdb:[23,26],second:[8,10,22,25,26,28,31,32,35,39,40,41,43,44],secondari:[3,13,26,28,38,41],secondli:8,section:[1,4,7,17,20,53,54],see:[0,1,8,9,10,11,13,16,18,20,21,25,26,27,29,31,33,34,35,37,39,40,41,51],seed:[10,24,27,31,32,34],seem:16,segment:22,select:[3,10,26,28,34,35,36,47],selenium:35,self:[1,8,10,44,47,49],self_energi:[10,49],sell:20,send:11,sensibl:35,sent:20,seok:38,separ:[1,3,8,10,20,25,27,35,39,41,44],seq:[13,21,23,26,28,29,31,35,40,42],seq_idx_on:28,seq_idx_two:28,seq_one_idx:28,seq_sep:[39,41],seq_tpl:[31,35],seq_trg:[31,35],seq_two_idx:28,seqid:[24,26],seqprof:13,seqr:[0,21,23,26,28,29,31,34,35,36,39,40,41],seqres_str:[21,32,36],seqsim:26,sequenc:[0,3,8,13,18,21,22,23],sequencefromchain:42,sequencehandl:[21,26,28,29,35,40],sequencelist:[21,35,40],sequenceprofil:26,sequenti:[22,35],ser:49,serial:[26,37],serializ:37,serin:49,serv:[1,13,26,28,31,34],servic:[16,20],set:[1,2,4,8,10,11,13,15,16,18,21,22,25,26,28,31,32,33,34,35,36,37,39,40,41,44,47,49,50,51,52],setaa:22,setactivesubrotam:49,setallatomscoringkei:31,setaroundomegators:22,setaroundphipsitors:22,setaroundphitors:22,setaroundpsitors:22,setbackbonescoringkei:31,setbackrub:22,setboolprop:50,setc:22,setca:22,setcb:22,setcharg:25,setcpuplatformsupport:25,setdefault:25,setdisulfidconnect:25,setenergi:[39,41],setenviron:[21,32,36,40],setepsilon:25,setfraggerhandl:35,setframeenergi:[47,49],setfudgelj:25,setfudgeqq:25,setinitialenviron:[21,31,32,34,36,40,42],setinternalconnect:25,setinternalenergi:49,setinternalenergyprefactor:49,setinterpol:51,setmass:25,setn:22,setnonbondedcutoff:32,seto:22,setolc:22,setpeptideboundconnect:25,setphitors:22,setpo:21,setprob:49,setpsipredpredict:[35,40,41],setpsitors:22,setresidu:21,setscor:41,setsequ:22,setsequenceoffset:35,setsequenceprofil:35,setsequenceprofilescoreskei:31,setsigma:25,setstemrmsdskei:31,setstructureprofil:26,setstructureprofilescoreskei:31,settemperatur:49,setup:[0,2,5,7,8,13],setupdefaultallatomscor:[31,35],setupdefaultbackbonescor:[31,35],setupsystem:25,setweight:31,sever:[0,2,3,5,8,10,13,24,26,27,28,31,32,35,36,40,41,42,44,48,49,51,52],sg_pos_on:43,sg_pos_two:43,shake:34,shall:20,shanno:35,shapovalov2011:[38,48],shapovalov:38,shared_ptr:37,shebang:8,sheet:35,shelenkov:38,shell:[1,2,8,11],shift:[22,26,29],shiftctermin:29,shiftextens:29,ship:[5,48],shorten:35,shorter:35,shortest:31,shortli:8,should:[1,2,4,5,7,8,10,11,13,16,18,20,22,23,26,27,28,31,32,34,35,36,37,40,45,47,49],show:[1,8,13,14,31,34,47,50],showcas:[1,21,25,27],shown:[8,14,35],shrink:22,shrug:38,side:[8,35,38],sidechain_pymod:8,sidechain_reconstructor:35,sidechain_rst:8,sidechain_test_data:8,sidechain_test_orig:36,sidechain_test_rec:36,sidechain_unit_test:8,sidechainparticl:50,sidechainreconstructiondata:[30,32],sidechainreconstructor:[25,30,32,35],sidenot:[26,36],sig1:51,sig2:51,sig3:51,sig4:51,sigma:25,silent:1,sim:25,similar:[1,2,13,16,23,26,28,40,41,51],similardihedr:51,similarli:[2,25,35],simpl:[0,9,22,26,34,35,39,40,41,49,51],simpler:[25,35],simplest:[5,8,30],simpli:[21,22,31,32,34,35,49,50,51],simplic:[23,26],simplif:13,simplifi:[3,22,25,26],simul:[10,25,31,32,34],sinc:[1,2,4,8,10,11,16,18,22,25,26,27,28,49],singl:[2,4,8,10,21,22,25,26,28,31,32,34,35,36,40,41,45,48,49,50,52],singleton:25,singular:[3,6],singularity_nohttp:7,sink:37,sit:8,site:[3,5,8,28],size:[8,21,22,26,27,28,32,34,37,39,40,41],sizeof:37,skip:[0,1,8,16,26,28,35,50],slide:28,slight:35,slightli:35,slow:37,slower:[18,25,26,27,35,39,41,51],small:[8,26,32,35,36],smaller:[22,26,28,32,41],smallest:47,smallish:[2,8],smart:16,smng:3,smooth:38,smtl:35,soding2005:[26,38],softsampl:34,softwar:[8,20,38,49],sol:47,sole:[1,16,20],soli:38,solis2006:[24,38],solut:[8,10,28,31,32,34,35,36,46,47],solv:[10,16,47,52],solvent:26,solventaccess:26,solver:3,some:[1,2,4,5,6,7,8,13,16,21,23,26,30,33,34,35,36,37,40,42,47,50,51],somedata:37,someth:[1,7,8,11,16,26],sometim:16,somewher:4,soon:[10,32,41,47,51],sort:[1,4,10,14,31,34,51],sound:[16,50],sourc:[1,2,4,8,13,16,18,19,20,26,28,31,32,33,35,37,51],source1:[4,16],source2:[4,16],source3:4,source4:4,source_chain_idx:35,source_mhandl:35,sp3:51,space:[3,10,28,34,38],span:35,sparticl:49,spatial:[8,28,42],spawn:[1,8],spdbv:35,spdbv_style:35,special:[1,2,4,8,20,25,34,49,50,51],specif:[1,3,8,20,25,26,27,28,31,34,38,40,47,48,49],specifi:[0,2,4,5,9,10,22,26,27,28,31,32,35,36,40,49,51],specimen:11,speed:[3,25,35,38],spent:[14,18],sphere:[43,49],sphinx:[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],spin:38,spit:[29,34],split:42,sport:8,squar:26,src:[8,16],ss_agreement:41,ss_agreement_scor:37,ssagre:26,ssagreementscor:37,sse:2,sstream:37,stabil:38,stabl:16,stack:16,stage:[1,2,4,8],stai:[1,8,10,16,34],standalon:7,standard:[2,8,12,13,16,21,27,37,41,51],start:[0,1,2,4,7],start_idx:31,start_resnum:[21,22,26,31,34,35,36,39,40,41],start_resnum_list:36,start_rnum:40,start_temperatur:[10,34],starter:1,startscop:14,stash:[16,31,34,40],state:[1,2,8,20,21,26,31,34,40,41,44,49,51],statement:20,staticruntimeprofil:14,statist:[14,26,38],statu:[1,8],std:37,stderr:1,stdout:1,steadili:[10,34],steepest:[32,35],stem:[9,22,25,26,29,31,32,34,35,36],stemcoord:9,stempairorient:9,step:[8,10,14,16,18,19,28,29,30,31,32,34],stereo:35,stereo_chemical_problem_backbon:35,stereochem:[3,35],steric:51,still:[8,14,25,26,35,37],stop:[1,8,14,28,29,32],stop_criterion:32,stoppag:20,storabl:26,storag:[8,21,25,39,41],store:[0,1,3,8,9,16,18,21,22,25,26,27,28,29,31,32,34,35,36,37,47],stori:8,str:[1,11,13,14,15,21,22,25,26,27,28,29,31,32,33,34,35,36,37,39,40,41,49,51],str_len:37,straight:16,strategi:51,stream:37,stretch:[21,26,31,34,35,40,41],strict:16,strictli:3,string:[0,3,11,13,26,27,29,37],stringstream:37,strip:[0,35],struc:5,struct:[5,26,37],struct_db:23,structral:[21,40],structur:[0,3,8,13],structural_db:31,structuralgap:[29,33],structuralgaplist:[29,35],structure_db:[26,28,31,35,37],structure_db_on:26,structure_db_two:26,structure_dir:26,structure_id:26,structure_path:26,structure_sourc:13,structuredb:[3,13,24,26,28,31,35,37],structuredbdatatyp:26,structureprofil:26,studer:38,stuff:[26,39],style:[35,40,41,49],sub:[8,26],sub_frag:22,sub_res_list:26,subdir:8,subfold:8,subject:[8,20],sublicens:20,submiss:20,submit:20,submodul:8,submodule1:16,subpart:28,subrotam:[0,3,44,47,49,50],subrotameroptim:[36,52],subsequ:[10,20,22,35],subset:[0,13,25,26,28,31,32,35,36],subst:26,subst_matrix:26,substitut:26,substweightmatrix:26,subtre:[4,8],succeed:29,success:[10,11,34],successfulli:5,sudo:[5,7],suffici:26,suffix:11,sugar:6,suggest:[5,8,43],suit:[1,8,26],sulfur:[43,44,49,50],sum:[14,29,35,36,43,44,49],summari:[14,26],superpos:[22,26,28,31,32,34],superpose_stem:22,superposed_rmsd:[22,31],superposeonto:22,superposit:[3,28,31,34],superpost:28,supersed:20,supervis:1,support:[0,1,3,8,11,13,18,20,25,32,35],suppos:[16,34],sure:[2,7,8,13,16,26],surfac:26,surotam:49,surprisingli:50,surround:[25,26,32,36,39,41],symmetr:[26,40,51],symmetri:[39,41],sync:8,syntax:20,system:[1,2,4,8,16,20,23],t_sampler:27,tabl:26,tag:[5,7],tail:22,tailor:[21,35],take:[8,10,21,26,27,28,31,32,34,35,37,41,44,50,52],taken:[0,21,25,32,34,35,50],talk:1,target:[0,1,2,4,8,13,18,26,28,30,31,32,34,35,40,49],target_chain_idx:35,target_mhandl:35,target_pdb:33,target_posit:28,target_sequ:26,task:[8,16,32,35,37,40],techniqu:[10,38],tell:[1,8,11,13,16,26],temperatur:[10,31,34,49],templat:[0,1,3,13,18,30,35,37,40],temporari:[26,35],temporarili:16,term:[8,20,26,49,51,52],termin:[0,1,9,11,18,20,21,22,25,29,31,32,34,35,36,50],terminal_len:34,terminal_seqr:34,termini:[0,3,29,34,35],terminu:[26,34,35],test_:8,test_action_:1,test_action_do_awesom:1,test_action_help:1,test_awesome_featur:8,test_check_io:37,test_cod:8,test_doctest:8,test_foo:4,test_portable_binari:37,test_reconstruct_sidechain:8,test_sidechain_reconstruct:8,test_submodule1:16,test_suite_:4,test_suite_your_module_run:8,test_your_modul:16,testcas:[1,8],testcasenam:8,testexit0:1,testpmexist:1,testreconstruct:8,testutil:[1,8],text:[1,13,20,35],than:[4,8,13,14,16,21,22,26,28,31,32,33,35,36,41,44,50],thei:[2,5,8,16,21,22,25,26,27,28,31,32,33,34,35,44,49,50,51,53],them:[4,8,16,22,25,26,27,28,29,31,35,36,40,45],themselv:25,theoret:34,theori:[20,38],therefor:[5,8,22,24,26,28,32,34,35,51],thereof:[20,25],thi:[0,1,2,3,4,5,7,8,10,11,12,13,14,15,16,17,18,20,21,22,23,25,26,27,28,29,30,31,32,33,34,35,36,37,39,40,41,42,44,47,49,50,51,52,54],thing:[1,2,8,16,26,28,35,51],think:10,thoroughli:16,those:[0,1,2,4,8,10,13,16,20,25,28,31,35,36,37,39,41,47,50,51],though:[25,35,37],thr:49,thread:[18,25,35,38],three:[1,4,16,21,22,27,28,31,33,34,38,41,49,51],threonin:49,thresh:[22,49,51],threshold:[10,26,28,32,35,36,40,51],through:[1,8,9,20,22,26,29,35,39,41],throughout:[13,16,24,25],thrown:26,thu:[5,11,49],tidi:16,tightli:16,time:[1,5,8,13,14,16,18,28,35],timer:14,tini:[16,35],titl:[20,27],tlc:[21,49],tlc_an:21,tlctorotid:[47,49],tmp_buf:37,todens:22,toentiti:[18,21,22,25,26,32,34,36],toframeresidu:49,togeth:[8,16,26,44],too:[13,16,31,32,35,37],tool:[3,4,23,37,42,47],toolbox:16,top:[2,6,7,8,14,15,16,32,35],topic:[1,8,16],topolog:[25,32],torrmrotam:49,torsion:[0,13,21,22,23,24,26],torsion_angl:47,torsion_bin:41,torsion_plot:27,torsion_sampl:[22,26,31,32,34,35,37],torsion_sampler_coil:[28,37],torsion_sampler_extend:[28,37],torsion_sampler_hel:37,torsion_sampler_helix:28,torsion_sampler_list:26,torsion_scor:37,torsionprob:26,torsionsampl:[22,24,26,27,28,31,32,34,35,37,41],torsionscor:[35,37],tort:20,total:[10,14,26,28],touch:[1,8,25,32],toward:[0,3,8,13,26,29,32,35,39,41,47,49,50,52],tpl:[0,30,31,35],tpr:[49,51],trace:35,track:[3,11,20,30],trade:20,trademark:20,tradition:11,trail:0,train:[24,31,35],trajectori:[28,34],tran:[22,49,51],transfer:20,transform:[9,20,22,28,34,35,51],translat:[4,8,20,26,49,51],transomegators:22,treat:[3,8,25,35,36,37,51],treatment:50,tree:[1,4,8,10,16,46,47],treepack:3,treesolv:[10,36,47],trg:[0,13,31,35],tri:[10,28,29,35,44,51],triangl:28,trick:[1,7,16],trigger:[1,4,8,48],tripeptid:27,tripl:11,triplet:23,trott2010:[38,49],trott:38,trp:[49,51],trustworthi:16,tryptophan:49,ttccpsivarsnfnvcrlpgtpea:[31,35],ttccpsivarsnfnvcrlpgtpeaicatgytciiipgatcpgdyan:35,ttccpsivarsnfnvcrlpgtpeaicatytgciiipgatcpgdyan:[31,35],tupl:[9,10,11,22,25,26,28,29,33,35,36,44],turn:[0,1,11,14,16,35],tutori:8,tweak:35,twice:[14,40],two:[1,7,8,10,16,21,22,25,26,28,29,31,32,35,36,37,39,40,41,43,44,47,49,51],txt:[1,2,4,8,16,20],type:[0,1,8,9,10,11,13,14,20,21,22,24,25,26,27,28,29,31,32,33,34,35,36,37,39,40,41,43,47,48,49,50],typedef:37,typenam:37,typic:[22,28,34,47,51],tyr:[49,51],tyrosin:49,uint32_t:37,uint:37,ultra:26,uncertain:8,uncharg:50,unclos:35,undefin:25,under:[4,8,20],undergo:[28,32,34,36],underli:[29,31,49],underscor:1,understand:16,understood:0,undo:10,unexpect:2,unfavor:[22,32],unfavour:[32,34,44],unfortun:16,unhandl:[0,13],uniba:[8,18,19,53],uniform:32,union:20,uniqu:[0,13,28,31,34,51],unittest:[1,8,16],univers:[8,53],unix:16,unknown:25,unless:[13,20,21,22,25,31,39,41],unlik:47,unrecognis:11,unset:[21,25,36],unsupport:[13,37],until:[8,10,28,32,35,40,50],untouch:22,untrack:1,unum:28,unus:16,upat:5,updat:[3,5,7,8,16,21,25,28,29,31,32,35,36,40,42],updatedistribut:27,updateposit:[25,32],upon:[26,32,34],upper:28,urei:25,urey_bradley_angl:25,usabl:16,usag:[0,3,10,13,24,26,31,32,36],use_amber_ff:35,use_bbdep_lib:36,use_frm:36,use_full_extend:35,use_scoring_extend:35,user:[1,5,8,19,28,53],userlevel:1,usr:[2,5,7,8],usual:[1,2,4,8,13,14,16,22,31,35,39],utilis:[8,16],v_size:37,val:[27,49],valid:[0,10,16,22,26,29,34,35,36,48,51],valin:49,valu:[2,10,11,13,21,22,25,26,28,31,34,35,37,39,40,41,44,47,49,50,51,52],valueerror:[28,35],vanish:40,varadarajan:38,vari:[4,37],variabl:[1,2,8,14,18,25,33,35,37],variant:[25,31],variou:[1,2,4,16,30],vec3:[9,21,22,26,32,33,43,44,49],vec3list:[28,49],vector:[25,27,28,31,37,49],verbal:20,verbos:1,veri:[1,8,11,16,25,28,35,37],verif:13,verifi:[1,11,16],version:[2,3,5,8,16,20,26,35,37,48,49],vertic:28,via:[1,5,8,13,15,25],view:[13,16,27,35,40],vina:[3,38],vinaparticletyp:[49,50],vinarotamerconstructor:50,virtual:8,visibl:36,vision:38,visual:18,volum:5,wai:[1,2,4,5,8,16,22,23,25,31,41,47,49],wait:8,walk:[1,8],want:[1,2,3,8,15,16,22,26,28,31,32,35,40,49,50,51,52,53],warn:[8,16,35],warranti:20,watch:8,web:[2,8],weight:[3,26,28,31,34,35,39,41],weird:[28,32,47],well:[0,4,16,21,27,28,29,31,35,37,41,47,50,51],went:[0,8],were:[16,26,31,35],wester:38,wether:10,what:[1,8,11,13,16,23,26,36,40],when:[1,3,4,5,8,10,13,14,21,22,25,26,27,28,29,31,34,35,36,37,38,40,41,44,47,48,49,50,51],whenev:[8,21,31,40],where:[0,1,3,4,5,8,10,11,13,14,16,20,21,22,25,26,27,31,35,37,39,40,41,48,49,50,51],wherea:26,wherev:20,whether:[3,5,8,10,11,13,20,22,25,26,31,32,34,36,39,40,41,49,50,51],which:[0,1,4,8,9,11,12,13,16,18,20,21,22,25,26,27,28,29,31,32,33,34,35,36,37,39,40,41,49,50,51],whistl:8,whitespac:0,who:[10,47],whole:[1,2,8,16,20,22,26,35,49],whom:20,why:[1,16],width:[10,37,47],wild:4,window:28,window_length:28,wise:4,wish:[2,17,27,35],with_aa:31,with_db:31,within:[2,3,4,8,14,16,20,21,25,28,29,33,35,36,39,41,51],without:[0,1,3,4,8,11,13,20,25,29,32,35,40,51],wolfson:[28,38],won:[0,35,36,50],word:4,work:[1,2,4,5,7,8,14,16,18,20,25,29,35,37,50],worldwid:20,worst:16,worth:53,would:[1,2,8,11,22,26,27,44,49],wrap:26,wrapper:[1,4,8,15,35],write:0,writebasetyp:37,writemagicnumb:37,writetypes:37,writeversionnumb:37,written:[8,20,37],wrong:[2,13],wwpdb:5,www:20,xlabel:27,xlim:27,xml:8,xxx:[22,49],xxx_num_atom:21,xxx_num_hydrogen:21,year:1,yet:[26,31,35],ylabel:27,ylim:27,you:[0,1,2,3,4,5,7,8,10,11,13,14,15,16,18,20,21,22,23,25,26,27,28,30,31,32,34,35,36,37,39,40,41,47,48,49,50,51,52,53],your:[1,2,4,5,7],your_modul:[8,16],yourself:[2,8,10,16,35,50],yyyi:20,zero:[0,26,28,35,51],zhou2005:[26,38],zhou:38,zip:[26,47]},titles:["ProMod3 Actions","<code class=\"docutils literal\"><span class=\"pre\">test_actions</span></code> - Testing Actions","Building ProMod3","Changelog","ProMod3&#8216;s Share Of CMake","Docker","ProMod3 and Containers","Singularity","Contributing","Geometry functions","Graph Minimizer","<code class=\"docutils literal\"><span class=\"pre\">helper</span></code> - Shared Functionality For the Everything","<code class=\"docutils literal\"><span class=\"pre\">core</span></code> - ProMod3 Core Functionality","<code class=\"docutils literal\"><span class=\"pre\">pm3argparse</span></code> - Parsing Command Lines","Runtime profiling","<code class=\"docutils literal\"><span class=\"pre\">SetCompoundsChemlib()</span></code>","ProMod3 Setup","Documentation For Developers","Getting Started","ProMod3","License","Handling All Atom Positions","Representing Loops","<code class=\"docutils literal\"><span class=\"pre\">loop</span></code> - Loop Handling","Loading Precomputed Objects","Generate <code class=\"docutils literal\"><span class=\"pre\">ost.mol.mm</span></code> systems","Structural Data","Sampling Dihedral Angles","Modelling Algorithms","Handling Gaps","<code class=\"docutils literal\"><span class=\"pre\">modelling</span></code> - Protein Modelling","Handling Loop Candidates","Fitting Loops Into Gaps","Model Checking","Generating Loops De Novo","Modelling Pipeline","Sidechain Reconstruction","Using Binary Files In ProMod3","References","All Atom Scorers","Backbone Score Environment","Backbone Scorers","<code class=\"docutils literal\"><span class=\"pre\">scoring</span></code> - Loop Scoring","Other Scoring Functions","Disulfid Bond Evaluation","Frame - The Rigid Part","Rotamer Graph","<code class=\"docutils literal\"><span class=\"pre\">sidechain</span></code> - Sidechain Modelling","Loading Rotamer Libraries","Representing Sidechains - Rotamers &amp; Co.","Rotamer Constructor","Rotamer Library","Subrotamer Optimization","Contributing","Documentation For Users"],titleterms:{"class":[21,22,26,27,29,31,36,39,40,41],"default":35,"function":[4,9,11,12,29,36,40,43,49,50],acid:[21,25,27],action:[0,1,4,5,7,8],actiontestcas:1,algorithm:28,all:[21,32,39],allatomclashscor:39,allatomenv:21,allatomenvposit:21,allatominteractionscor:39,allatomoverallscor:39,allatompackingscor:39,allatomposit:21,allatomscor:39,amino:[21,25,27],angl:27,api:1,argument:13,atom:[21,32,39],backbon:[32,40,41,51],backbonelist:22,backboneoverallscor:41,backbonescor:41,backbonescoreenv:40,base:[26,39,41],baseclass:50,binari:37,block:[28,49],bond:44,branch:16,build:[0,2,5,7,35,49],can:49,candid:31,cbetascor:41,cbpackingscor:41,ccd:32,chain:26,changelog:3,check:33,clashscor:41,closer:34,cmake:[1,2,4,16],code:37,command:13,compound:[5,7],configur:51,construct:40,constructor:50,contain:6,contribut:[8,53],conveni:40,cooler:34,core:12,creat:[1,25],data:[26,37],databas:26,defin:[26,27],definit:4,depend:[2,51],detect:33,develop:17,dihedr:27,directori:16,distinguish:21,disulfid:44,docker:5,document:[4,8,17,19,54],entri:51,environ:40,evalu:44,everyth:11,exampl:[31,37],execut:1,exisit:37,extend:29,featur:[8,26],file:[11,37],find:26,finder:28,fit:32,forcefield:25,fragment:26,frame:45,from:43,gap:[29,32],gener:[25,34],geometr:26,geometri:9,get:[18,49],git:16,graph:[10,46],group:49,handl:[21,23,29,31,35],have:1,hbondscor:41,header:37,helper:11,hook:16,how:[8,49],imag:[5,7],instal:2,integr:1,introduct:[4,11,13],issu:8,keep:31,kic:32,librari:[5,7,48,51],licens:[8,20],line:13,load:[24,48],lookup:25,loop:[22,23,25,31,32,34,42],loopcandid:31,mainten:4,make:[1,2],messag:11,minim:10,model:[0,18,28,30,31,33,35,47],modul:[4,8],mol:25,molprob:33,motif:28,must:1,non:51,novo:[28,34],object:[24,34,45],optim:52,ost:[5,7,25],other:43,output:1,own:8,pairwis:40,pairwisescor:41,pars:13,parser:13,part:45,parti:8,particl:49,pipelin:[18,35],pm3argpars:13,portabl:37,posit:21,precomput:24,profil:14,promod3:[0,2,4,6,8,12,16,18,19,37],protein:30,psipredpredict:26,punch:33,quick:8,raw:35,reconstruct:36,reducedscor:41,refer:38,relax:32,releas:3,repres:[22,49],rigid:[28,45],ring:33,rotam:[46,48,49,50,51],rotamerconstructor:50,rotamerid:49,run:[1,2,5,7,18],runtim:14,sampl:27,sampler:[27,34],score:[31,40,42,43,49,50],scorer:[8,34,39,41],script:[1,5,7,8],scwrl3:[43,49],scwrl4:49,sequenc:26,setcompoundschemlib:15,setup:16,share:[4,8,11],sidechain:[0,36,47,49],sidechainreconstructiondata:36,sidechainreconstructor:36,singular:7,smallest:49,specif:50,ssagreementscor:41,stage:16,start:[8,18],step:35,structur:[16,26],subclass:1,subrotam:52,system:25,test:[1,4,8,11],test_act:1,third:8,torsion:27,torsionscor:41,track:31,triplet:27,type:51,unit:[1,4,8],user:54,vina:49,write:8,your:8}})
\ No newline at end of file
diff --git a/doc/html/sidechain/disulfid.html b/doc/html/sidechain/disulfid.html
index 9e47ea4c753400b53429b567c94e62517f6bbdd1..934027fea20063d03c090c1936b0fd653d078932 100644
--- a/doc/html/sidechain/disulfid.html
+++ b/doc/html/sidechain/disulfid.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Disulfid Bond Evaluation &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Disulfid Bond Evaluation &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="sidechain - Sidechain Modelling" href="index.html" />
     <link rel="next" title="Loading Rotamer Libraries" href="loading.html" />
     <link rel="prev" title="Rotamer Graph" href="graph.html" />
@@ -77,10 +77,10 @@ rotamers to the result of the geometric expression.</p>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>rotamer_one</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RRMRotamer" title="promod3.sidechain.RRMRotamer"><code class="xref py py-class docutils literal"><span class="pre">RRMRotamer</span></code></a> , <a class="reference internal" href="rotamer.html#promod3.sidechain.FRMRotamer" title="promod3.sidechain.FRMRotamer"><code class="xref py py-class docutils literal"><span class="pre">FRMRotamer</span></code></a>) &#8211; First rotamer</li>
 <li><strong>rotamer_two</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RRMRotamer" title="promod3.sidechain.RRMRotamer"><code class="xref py py-class docutils literal"><span class="pre">RRMRotamer</span></code></a> , <a class="reference internal" href="rotamer.html#promod3.sidechain.FRMRotamer" title="promod3.sidechain.FRMRotamer"><code class="xref py py-class docutils literal"><span class="pre">FRMRotamer</span></code></a>) &#8211; Second rotamer</li>
-<li><strong>ca_pos_one</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; CA position of first rotamer</li>
-<li><strong>cb_pos_one</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; CB position of first rotamer</li>
-<li><strong>ca_pos_two</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; CA position of second rotamer</li>
-<li><strong>cb_pos_two</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; CB position of second rotamer</li>
+<li><strong>ca_pos_one</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; CA position of first rotamer</li>
+<li><strong>cb_pos_one</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; CB position of first rotamer</li>
+<li><strong>ca_pos_two</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; CA position of second rotamer</li>
+<li><strong>cb_pos_two</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; CB position of second rotamer</li>
 </ul>
 </td>
 </tr>
@@ -113,8 +113,8 @@ possible, the one with the optimal sum of scores gets estimated.</p>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>rotamer_groups</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of
 <a class="reference internal" href="rotamer.html#promod3.sidechain.FRMRotamerGroup" title="promod3.sidechain.FRMRotamerGroup"><code class="xref py py-class docutils literal"><span class="pre">FRMRotamerGroup</span></code></a>/<a class="reference internal" href="rotamer.html#promod3.sidechain.RRMRotamerGroup" title="promod3.sidechain.RRMRotamerGroup"><code class="xref py py-class docutils literal"><span class="pre">RRMRotamerGroup</span></code></a>) &#8211; Every group represents a cysteine</li>
-<li><strong>ca_positions</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; The CA positions of the according rotamers</li>
-<li><strong>cb_positions</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; The CB positions of the according rotamers</li>
+<li><strong>ca_positions</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; The CA positions of the according rotamers</li>
+<li><strong>cb_positions</strong> (<code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; The CB positions of the according rotamers</li>
 <li><strong>score_threshold</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; The score two rotamers must have to be considered
 as a disulfid bond</li>
 <li><strong>optimize_subrotamers</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#bool" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">bool</span></code></a>) &#8211; If set to true and the input consists of flexible
@@ -180,7 +180,7 @@ describe the optimal rotamers in the according rotamer groups.</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/sidechain/frame.html b/doc/html/sidechain/frame.html
index a40d117535fa22c6b4ee6610509f3ec34afffdde..b754527088d1cbe230c678d2500463cb3ffa54dd 100644
--- a/doc/html/sidechain/frame.html
+++ b/doc/html/sidechain/frame.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Frame &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Frame - The Rigid Part &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,10 +24,10 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="sidechain - Sidechain Modelling" href="index.html" />
-    <link rel="next" title="Rotamer Library" href="rotamer_lib.html" />
-    <link rel="prev" title="Rotamers" href="rotamer.html" />
+    <link rel="next" title="Rotamer Constructor" href="rotamer_constructor.html" />
+    <link rel="prev" title="Representing Sidechains - Rotamers &amp; Co." href="rotamer.html" />
    
   <link rel="stylesheet" href="../_static/custom.css" type="text/css" />
   
@@ -42,8 +42,8 @@
         <div class="bodywrapper">
           <div class="body" role="main">
             
-  <div class="section" id="frame">
-<h1>Frame<a class="headerlink" href="#frame" title="Permalink to this headline">¶</a></h1>
+  <div class="section" id="frame-the-rigid-part">
+<h1>Frame - The Rigid Part<a class="headerlink" href="#frame-the-rigid-part" title="Permalink to this headline">¶</a></h1>
 <p>In contrast to the rotamers, the frame is a rigid object. It either
 represents the protein backbone or sidechains kept rigid during the
 sidechain modelling process. Regions, that should not be occupied by
@@ -129,7 +129,7 @@ can be passed to rotamer groups for calculating frame energies.</p>
         <div class="sphinxsidebarwrapper">
   <h3><a href="../index.html">Table Of Contents</a></h3>
   <ul>
-<li><a class="reference internal" href="#">Frame</a><ul>
+<li><a class="reference internal" href="#">Frame - The Rigid Part</a><ul>
 <li><a class="reference internal" href="#the-frame-objects">The Frame Objects</a></li>
 </ul>
 </li>
@@ -140,8 +140,8 @@ can be passed to rotamer groups for calculating frame energies.</p>
   <li><a href="../index.html">Documentation overview</a><ul>
   <li><a href="../users.html">Documentation For Users</a><ul>
   <li><a href="index.html"><code class="docutils literal"><span class="pre">sidechain</span></code> - Sidechain Modelling</a><ul>
-      <li>Previous: <a href="rotamer.html" title="previous chapter">Rotamers</a></li>
-      <li>Next: <a href="rotamer_lib.html" title="next chapter">Rotamer Library</a></li>
+      <li>Previous: <a href="rotamer.html" title="previous chapter">Representing Sidechains - Rotamers &amp; Co.</a></li>
+      <li>Next: <a href="rotamer_constructor.html" title="next chapter">Rotamer Constructor</a></li>
   </ul></li>
   </ul></li>
   </ul></li>
@@ -169,7 +169,7 @@ can be passed to rotamer groups for calculating frame energies.</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/sidechain/graph.html b/doc/html/sidechain/graph.html
index e843e0a687a79b945b82600f3087b3f90451be9a..03f601c9b5ab3462fc42aafdac4f90b0e57546c1 100644
--- a/doc/html/sidechain/graph.html
+++ b/doc/html/sidechain/graph.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Rotamer Graph &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Rotamer Graph &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,10 +24,10 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="sidechain - Sidechain Modelling" href="index.html" />
     <link rel="next" title="Disulfid Bond Evaluation" href="disulfid.html" />
-    <link rel="prev" title="Rotamer Constructor" href="rotamer_constructor.html" />
+    <link rel="prev" title="Rotamer Library" href="rotamer_lib.html" />
    
   <link rel="stylesheet" href="../_static/custom.css" type="text/css" />
   
@@ -91,7 +91,7 @@ conformations for every amino acid position.</td>
   <li><a href="../index.html">Documentation overview</a><ul>
   <li><a href="../users.html">Documentation For Users</a><ul>
   <li><a href="index.html"><code class="docutils literal"><span class="pre">sidechain</span></code> - Sidechain Modelling</a><ul>
-      <li>Previous: <a href="rotamer_constructor.html" title="previous chapter">Rotamer Constructor</a></li>
+      <li>Previous: <a href="rotamer_lib.html" title="previous chapter">Rotamer Library</a></li>
       <li>Next: <a href="disulfid.html" title="next chapter">Disulfid Bond Evaluation</a></li>
   </ul></li>
   </ul></li>
@@ -120,7 +120,7 @@ conformations for every amino acid position.</td>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/sidechain/index.html b/doc/html/sidechain/index.html
index 1f48d7131a1c4e1b7064a8ebd8f819e8300316f5..57f8e3d4ae42ec76cedc4fab30b4402a7e32d8a3 100644
--- a/doc/html/sidechain/index.html
+++ b/doc/html/sidechain/index.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>sidechain - Sidechain Modelling &mdash; ProMod3 2.0.0 documentation</title>
+    <title>sidechain - Sidechain Modelling &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,9 +24,9 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="Documentation For Users" href="../users.html" />
-    <link rel="next" title="RotamerID" href="rotamer_id.html" />
+    <link rel="next" title="Representing Sidechains - Rotamers &amp; Co." href="rotamer.html" />
     <link rel="prev" title="Modelling Algorithms" href="../modelling/algorithms.html" />
    
   <link rel="stylesheet" href="../_static/custom.css" type="text/css" />
@@ -145,22 +145,22 @@ pipelines available in the modelling module.</p>
 <p>Contents:</p>
 <div class="toctree-wrapper compound">
 <ul>
-<li class="toctree-l1"><a class="reference internal" href="rotamer_id.html">RotamerID</a><ul>
-<li class="toctree-l2"><a class="reference internal" href="rotamer_id.html#the-rotamerid">The RotamerID</a></li>
-<li class="toctree-l2"><a class="reference internal" href="rotamer_id.html#how-can-i-get-an-id">How can I get an ID?</a></li>
-</ul>
-</li>
-<li class="toctree-l1"><a class="reference internal" href="rotamer.html">Rotamers</a><ul>
+<li class="toctree-l1"><a class="reference internal" href="rotamer.html">Representing Sidechains - Rotamers &amp; Co.</a><ul>
+<li class="toctree-l2"><a class="reference internal" href="rotamer.html#rotamerid">RotamerID</a></li>
 <li class="toctree-l2"><a class="reference internal" href="rotamer.html#the-smallest-building-block-the-particle">The Smallest Building Block - The Particle</a></li>
-<li class="toctree-l2"><a class="reference internal" href="rotamer.html#the-scwrl4-scoring-function">The SCWRL4 scoring function</a></li>
-<li class="toctree-l2"><a class="reference internal" href="rotamer.html#id1">Rotamers</a></li>
+<li class="toctree-l2"><a class="reference internal" href="rotamer.html#rotamers">Rotamers</a></li>
 <li class="toctree-l2"><a class="reference internal" href="rotamer.html#rotamer-groups">Rotamer Groups</a></li>
 </ul>
 </li>
-<li class="toctree-l1"><a class="reference internal" href="frame.html">Frame</a><ul>
+<li class="toctree-l1"><a class="reference internal" href="frame.html">Frame - The Rigid Part</a><ul>
 <li class="toctree-l2"><a class="reference internal" href="frame.html#the-frame-objects">The Frame Objects</a></li>
 </ul>
 </li>
+<li class="toctree-l1"><a class="reference internal" href="rotamer_constructor.html">Rotamer Constructor</a><ul>
+<li class="toctree-l2"><a class="reference internal" href="rotamer_constructor.html#the-rotamerconstructor-baseclass">The RotamerConstructor Baseclass</a></li>
+<li class="toctree-l2"><a class="reference internal" href="rotamer_constructor.html#scoring-function-specific-rotamerconstructors">Scoring Function Specific RotamerConstructors</a></li>
+</ul>
+</li>
 <li class="toctree-l1"><a class="reference internal" href="rotamer_lib.html">Rotamer Library</a><ul>
 <li class="toctree-l2"><a class="reference internal" href="rotamer_lib.html#the-non-backbone-dependent-rotamer-library">The Non Backbone Dependent Rotamer Library</a></li>
 <li class="toctree-l2"><a class="reference internal" href="rotamer_lib.html#the-backbone-dependent-rotamer-library">The Backbone Dependent Rotamer Library</a></li>
@@ -168,10 +168,6 @@ pipelines available in the modelling module.</p>
 <li class="toctree-l2"><a class="reference internal" href="rotamer_lib.html#rotamer-configurations">Rotamer Configurations</a></li>
 </ul>
 </li>
-<li class="toctree-l1"><a class="reference internal" href="rotamer_constructor.html">Rotamer Constructor</a><ul>
-<li class="toctree-l2"><a class="reference internal" href="rotamer_constructor.html#constructing-rotamers-and-frame-residues">Constructing Rotamers and Frame Residues</a></li>
-</ul>
-</li>
 <li class="toctree-l1"><a class="reference internal" href="graph.html">Rotamer Graph</a></li>
 <li class="toctree-l1"><a class="reference internal" href="disulfid.html">Disulfid Bond Evaluation</a></li>
 <li class="toctree-l1"><a class="reference internal" href="loading.html">Loading Rotamer Libraries</a></li>
@@ -191,7 +187,7 @@ pipelines available in the modelling module.</p>
   <li><a href="../index.html">Documentation overview</a><ul>
   <li><a href="../users.html">Documentation For Users</a><ul>
       <li>Previous: <a href="../modelling/algorithms.html" title="previous chapter">Modelling Algorithms</a></li>
-      <li>Next: <a href="rotamer_id.html" title="next chapter">RotamerID</a></li>
+      <li>Next: <a href="rotamer.html" title="next chapter">Representing Sidechains - Rotamers &amp; Co.</a></li>
   </ul></li>
   </ul></li>
 </ul>
@@ -218,7 +214,7 @@ pipelines available in the modelling module.</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/sidechain/loading.html b/doc/html/sidechain/loading.html
index 1e7bc1857b82f08787f9391ab628bbf4b25680de..1cd38b191475013d7c8f3f9386a78dc28747c80d 100644
--- a/doc/html/sidechain/loading.html
+++ b/doc/html/sidechain/loading.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Loading Rotamer Libraries &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Loading Rotamer Libraries &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="sidechain - Sidechain Modelling" href="index.html" />
     <link rel="next" title="Subrotamer Optimization" href="subrotamer_optimizer.html" />
     <link rel="prev" title="Disulfid Bond Evaluation" href="disulfid.html" />
@@ -159,7 +159,7 @@ incomplete if the last problem gets triggered.</td>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/sidechain/rotamer.html b/doc/html/sidechain/rotamer.html
index e91619bdea34caade0bbe9f581575b1ef222ce51..74427adf1f6b560313d9863e8ee20eb13ec118e4 100644
--- a/doc/html/sidechain/rotamer.html
+++ b/doc/html/sidechain/rotamer.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Rotamers &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Representing Sidechains - Rotamers &amp; Co. &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,10 +24,10 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="sidechain - Sidechain Modelling" href="index.html" />
-    <link rel="next" title="Frame" href="frame.html" />
-    <link rel="prev" title="RotamerID" href="rotamer_id.html" />
+    <link rel="next" title="Frame - The Rigid Part" href="frame.html" />
+    <link rel="prev" title="sidechain - Sidechain Modelling" href="index.html" />
    
   <link rel="stylesheet" href="../_static/custom.css" type="text/css" />
   
@@ -42,18 +42,104 @@
         <div class="bodywrapper">
           <div class="body" role="main">
             
-  <div class="section" id="rotamers">
-<h1>Rotamers<a class="headerlink" href="#rotamers" title="Permalink to this headline">¶</a></h1>
-<p>A rotamer represents an amino acid sidechain and is basically a set of
-<a class="reference internal" href="#promod3.sidechain.Particle" title="promod3.sidechain.Particle"><code class="xref py py-class docutils literal"><span class="pre">Particle</span></code></a> objects. There exist two types. The <a class="reference internal" href="#promod3.sidechain.RRMRotamer" title="promod3.sidechain.RRMRotamer"><code class="xref py py-class docutils literal"><span class="pre">RRMRotamer</span></code></a> and
-<a class="reference internal" href="#promod3.sidechain.FRMRotamer" title="promod3.sidechain.FRMRotamer"><code class="xref py py-class docutils literal"><span class="pre">FRMRotamer</span></code></a>.
-To gather all possible rotamers for one particular sidechain position,
+  <div class="section" id="representing-sidechains-rotamers-co">
+<h1>Representing Sidechains - Rotamers &amp; Co.<a class="headerlink" href="#representing-sidechains-rotamers-co" title="Permalink to this headline">¶</a></h1>
+<p>A rotamer represents an amino acid sidechain identified by a <a class="reference internal" href="#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>
+and is a set of <a class="reference internal" href="#promod3.sidechain.Particle" title="promod3.sidechain.Particle"><code class="xref py py-class docutils literal"><span class="pre">Particle</span></code></a> objects.
+Two types of rotamers exist. The <a class="reference internal" href="#promod3.sidechain.RRMRotamer" title="promod3.sidechain.RRMRotamer"><code class="xref py py-class docutils literal"><span class="pre">RRMRotamer</span></code></a> and <a class="reference internal" href="#promod3.sidechain.FRMRotamer" title="promod3.sidechain.FRMRotamer"><code class="xref py py-class docutils literal"><span class="pre">FRMRotamer</span></code></a>.
+To gather all possible rotamers for one location,
 ProMod3 offers the <a class="reference internal" href="#promod3.sidechain.RRMRotamerGroup" title="promod3.sidechain.RRMRotamerGroup"><code class="xref py py-class docutils literal"><span class="pre">RRMRotamerGroup</span></code></a> and <a class="reference internal" href="#promod3.sidechain.FRMRotamerGroup" title="promod3.sidechain.FRMRotamerGroup"><code class="xref py py-class docutils literal"><span class="pre">FRMRotamerGroup</span></code></a>.
-Pairwise interactions between particles give raise to pairwise energies between
-rotamers. Nevertheless, the energy calculation itself happens on the level
-of RotamerGroups and is mostly hidden away in the construction of the
-the <a class="reference internal" href="graph.html#promod3.sidechain.RotamerGraph" title="promod3.sidechain.RotamerGraph"><code class="xref py py-class docutils literal"><span class="pre">RotamerGraph</span></code></a>. If you&#8217;re too lazy to build up your rotamers
-by hand, you might be interested in the <a class="reference internal" href="rotamer_constructor.html#promod3.sidechain.RotamerConstructor" title="promod3.sidechain.RotamerConstructor"><code class="xref py py-class docutils literal"><span class="pre">RotamerConstructor</span></code></a>.</p>
+All parts of the structure that are kept rigid can be represented by
+a <a class="reference internal" href="frame.html#promod3.sidechain.Frame" title="promod3.sidechain.Frame"><code class="xref py py-class docutils literal"><span class="pre">Frame</span></code></a> object.</p>
+<div class="section" id="rotamerid">
+<h2>RotamerID<a class="headerlink" href="#rotamerid" title="Permalink to this headline">¶</a></h2>
+<p>The sidechain module has its own definition of amino acids to satisfy custom
+requirements for the implemented sidechain construction algorithms.
+As an example there are histidine in two possible protonation states,
+that affect the hbond term or different versions of proline/cysteine.</p>
+<dl class="class">
+<dt id="promod3.sidechain.RotamerID">
+<em class="property">class </em><code class="descclassname">promod3.sidechain.</code><code class="descname">RotamerID</code><a class="headerlink" href="#promod3.sidechain.RotamerID" title="Permalink to this definition">¶</a></dt>
+<dd><p>Enumerates the amino acids. Possible values:</p>
+<table class="hlist"><tr><td><ul class="simple">
+<li>ARG - Arginine</li>
+<li>ASN - Asparagine</li>
+<li>ASP - Aspartate</li>
+<li>GLN - Glutamine</li>
+<li>GLU - Glutamate</li>
+<li>LYS - Lysine</li>
+<li>SER - Serine</li>
+<li>CYS - Cystein</li>
+<li>CYH - &#8220;free&#8221; Cystein</li>
+<li>CYD - disulfid bonded Cystein</li>
+<li>MET - Methionine</li>
+<li>TRP - Tryptophane</li>
+<li>TYR - Tyrosine</li>
+<li>THR - Threonine</li>
+</ul>
+</td><td><ul class="simple">
+<li>VAL - Valine</li>
+<li>ILE - Isoleucine</li>
+<li>LEU - Leucine</li>
+<li>PRO - Proline</li>
+<li>CPR - cis-Proline</li>
+<li>TPR - trans-Proline</li>
+<li>HIS - Histidine</li>
+<li>HSD - d-protonated Histidine</li>
+<li>HSE - e-protonated Histidine</li>
+<li>PHE - Phenylalanine</li>
+<li>GLY - Glycine</li>
+<li>ALA - Alanine</li>
+<li>XXX - Invalid</li>
+</ul>
+</td></tr></table>
+<p>The RotamerID enum can be accessed either directly as <code class="docutils literal"><span class="pre">promod3.sidechain.ARG</span></code>
+or as <code class="docutils literal"><span class="pre">promod3.sidechain.RotamerID.ARG</span></code>.</p>
+</dd></dl>
+
+<div class="section" id="how-can-i-get-an-id">
+<h3>How can I get an ID?<a class="headerlink" href="#how-can-i-get-an-id" title="Permalink to this headline">¶</a></h3>
+<p>The RotamerID enum can directly be accessed from Python. Two convenient
+functions exist to get RotamerIDs from the <a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a> enum
+or from amino acid three letter codes.</p>
+<dl class="method">
+<dt id="promod3.sidechain.TLCToRotID">
+<code class="descclassname">promod3.sidechain.</code><code class="descname">TLCToRotID</code><span class="sig-paren">(</span><em>tlc</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.sidechain.TLCToRotID" title="Permalink to this definition">¶</a></dt>
+<dd><p>Directly translates the three letter code into a RotamerID. Following
+exactly the naming convention defined above.</p>
+<table class="docutils field-list" frame="void" rules="none">
+<col class="field-name" />
+<col class="field-body" />
+<tbody valign="top">
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>tlc</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; Three letter code of amino acid</td>
+</tr>
+<tr class="field-even field"><th class="field-name">Returns:</th><td class="field-body"><a class="reference internal" href="#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>, XXX if <strong>tlc</strong> cannot be recoginzed.</td>
+</tr>
+</tbody>
+</table>
+</dd></dl>
+
+<dl class="method">
+<dt id="promod3.sidechain.AAToRotID">
+<code class="descclassname">promod3.sidechain.</code><code class="descname">AAToRotID</code><span class="sig-paren">(</span><em>aa</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.sidechain.AAToRotID" title="Permalink to this definition">¶</a></dt>
+<dd><p>Directly translates <strong>aa</strong> into a RotamerID. Note, that it is not possible
+to generate special IDs this way
+(e.g. HSD, HSE or the special prolines/cysteins) since they&#8217;re simply not
+defined in <a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a></p>
+<table class="docutils field-list" frame="void" rules="none">
+<col class="field-name" />
+<col class="field-body" />
+<tbody valign="top">
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; AA enum of amino acid</td>
+</tr>
+<tr class="field-even field"><th class="field-name">Returns:</th><td class="field-body"><a class="reference internal" href="#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>, XXX if <strong>aa</strong> is invalid.</td>
+</tr>
+</tbody>
+</table>
+</dd></dl>
+
+</div>
+</div>
 <div class="section" id="the-smallest-building-block-the-particle">
 <h2>The Smallest Building Block - The Particle<a class="headerlink" href="#the-smallest-building-block-the-particle" title="Permalink to this headline">¶</a></h2>
 <p>Particles give raise to more complex objects such as rotamers and frame
@@ -65,7 +151,9 @@ function.</p>
 <em class="property">class </em><code class="descclassname">promod3.sidechain.</code><code class="descname">PScoringFunction</code><a class="headerlink" href="#promod3.sidechain.PScoringFunction" title="Permalink to this definition">¶</a></dt>
 <dd><p>The available scoring functions between <a class="reference internal" href="#promod3.sidechain.Particle" title="promod3.sidechain.Particle"><code class="xref py py-class docutils literal"><span class="pre">Particle</span></code></a> objects</p>
 <ul class="simple">
-<li>SCWRL4</li>
+<li>SCWRL4 - <a class="reference internal" href="#scwrl4-scoring-function"><span class="std std-ref">The SCWRL4 scoring function</span></a></li>
+<li>SCWRL3 - <a class="reference internal" href="#scwrl3-scoring-function"><span class="std std-ref">The SCWRL3 scoring function</span></a></li>
+<li>VINA - <a class="reference internal" href="#vina-scoring-function"><span class="std std-ref">The VINA scoring function</span></a></li>
 </ul>
 </dd></dl>
 
@@ -140,7 +228,7 @@ evaluated by the underlying scoring function.</td>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Returns:</th><td class="field-body">The position of the particle</td>
 </tr>
-<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a></td>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a></td>
 </tr>
 </tbody>
 </table>
@@ -163,13 +251,16 @@ evaluated by the underlying scoring function.</td>
 
 </dd></dl>
 
-</div>
 <div class="section" id="the-scwrl4-scoring-function">
-<h2>The SCWRL4 scoring function<a class="headerlink" href="#the-scwrl4-scoring-function" title="Permalink to this headline">¶</a></h2>
+<span id="scwrl4-scoring-function"></span><h3>The SCWRL4 scoring function<a class="headerlink" href="#the-scwrl4-scoring-function" title="Permalink to this headline">¶</a></h3>
+<p>The SCWRL4 scoring function combines a Lennard-Jones style term with
+a hydrogen bond term. Details can be found in the relevant publication
+<a class="reference internal" href="../references.html#krivov2009" id="id1">[krivov2009]</a>.</p>
 <dl class="class">
 <dt id="promod3.sidechain.SCWRL4ParticleType">
 <em class="property">class </em><code class="descclassname">promod3.sidechain.</code><code class="descname">SCWRL4ParticleType</code><a class="headerlink" href="#promod3.sidechain.SCWRL4ParticleType" title="Permalink to this definition">¶</a></dt>
-<dd><p>The SCWRL4 energy function differentiates between following particle types</p>
+<dd><p>The SCWRL4 energy function differentiates between following particle types
+that define the behaviour of the Lennard-Jones style term:</p>
 <ul class="simple">
 <li>HParticle   - represents hydrogen</li>
 <li>CParticle   - default representation of a carbon</li>
@@ -195,13 +286,21 @@ function</p>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
 <li><strong>name</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; The name of the particle</li>
 <li><strong>particle_type</strong> (<a class="reference internal" href="#promod3.sidechain.SCWRL4ParticleType" title="promod3.sidechain.SCWRL4ParticleType"><code class="xref py py-class docutils literal"><span class="pre">SCWRL4ParticleType</span></code></a>) &#8211; The type of the particle</li>
-<li><strong>pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; The position of the particle</li>
+<li><strong>pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; The position of the particle</li>
 <li><strong>charge</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; The charge of the particle, relevant for the hydrogen
 bond term</li>
 <li><strong>lone_pairs</strong> (<code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3List</span></code>) &#8211; Direction of all possible lone pairs of the particle,
-relevant for the hydrogen bond term</li>
-<li><strong>polar_direction</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; The polar direction of the particle,
-relevant for the hdrogen bond term</li>
+relevant for the hydrogen bond term. If set, the
+particle is a potential hydrogen bond acceptor.
+An example would be the Serine OG atom, where you can
+represent the two lone pairs with vectors pointing
+from the OG position towards the lone pair centers.</li>
+<li><strong>polar_direction</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; The polar direction of the particle,
+relevant for the hydrogen bond term. If set, the
+particle is a potential hydrogen bond donor. An
+example would be the Serine HG hydrogen. The
+<em>polar_direction</em> would be a vector
+estimated as follows: hg_pos-og_pos.</li>
 </ul>
 </td>
 </tr>
@@ -210,8 +309,93 @@ relevant for the hdrogen bond term</li>
 </dd></dl>
 
 </div>
-<div class="section" id="id1">
-<h2>Rotamers<a class="headerlink" href="#id1" title="Permalink to this headline">¶</a></h2>
+<div class="section" id="the-scwrl3-scoring-function">
+<span id="scwrl3-scoring-function"></span><h3>The SCWRL3 scoring function<a class="headerlink" href="#the-scwrl3-scoring-function" title="Permalink to this headline">¶</a></h3>
+<p>The SCWRL3 scoring function implements a simple repulsion term that depends on
+the hard-sphere radius of the involved particles.
+Details can be found in the relevant publication <a class="reference internal" href="../references.html#canutescu2003" id="id2">[canutescu2003]</a>.</p>
+<dl class="method">
+<dt id="promod3.sidechain.CreateSCWRL3Particle">
+<code class="descclassname">promod3.sidechain.</code><code class="descname">CreateSCWRL3Particle</code><span class="sig-paren">(</span><em>name</em>, <em>radius</em>, <em>pos</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.sidechain.CreateSCWRL3Particle" title="Permalink to this definition">¶</a></dt>
+<dd><p>Creates and returns a <a class="reference internal" href="#promod3.sidechain.Particle" title="promod3.sidechain.Particle"><code class="xref py py-class docutils literal"><span class="pre">Particle</span></code></a> that can evaluate the SCWRL3 scoring
+function</p>
+<table class="docutils field-list" frame="void" rules="none">
+<col class="field-name" />
+<col class="field-body" />
+<tbody valign="top">
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
+<li><strong>name</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; The name of the particle</li>
+<li><strong>radius</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; The hard-sphere radius of the particle, relevant for the
+repulsion term.</li>
+<li><strong>pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; The position of the particle</li>
+</ul>
+</td>
+</tr>
+</tbody>
+</table>
+</dd></dl>
+
+</div>
+<div class="section" id="the-vina-scoring-function">
+<span id="vina-scoring-function"></span><h3>The VINA scoring function<a class="headerlink" href="#the-vina-scoring-function" title="Permalink to this headline">¶</a></h3>
+<p>The VINA scoring function is a combination of scores that are named
+gaussian1, gaussian2, repulsion, hydrophobic and hbond in the Autodock Vina
+software <a class="reference internal" href="../references.html#trott2010" id="id3">[trott2010]</a>. VINA only evaluates heavy atoms. Gaussian1, gaussian2
+and repulsion are evaluated for all pairs of particles. Hydrophobic is only
+evaluated between C_VINAParticle <a class="reference internal" href="#promod3.sidechain.VINAParticleType" title="promod3.sidechain.VINAParticleType"><code class="xref py py-class docutils literal"><span class="pre">VINAParticleType</span></code></a> and hbond is
+evaluated between hydrogen bond donor/acceptor pairs. While SCWRL3 and SCWRL4
+are intended to evaluate sidechain-sidechain interactions in proteins,
+VINA is mainly targeted at interactions between sidechains and ligands.</p>
+<p>The VINA scoring function differentiates between the following particle types:</p>
+<dl class="class">
+<dt id="promod3.sidechain.VINAParticleType">
+<em class="property">class </em><code class="descclassname">promod3.sidechain.</code><code class="descname">VINAParticleType</code><a class="headerlink" href="#promod3.sidechain.VINAParticleType" title="Permalink to this definition">¶</a></dt>
+<dd><ul class="simple">
+<li>O_D_VINAParticle - Oxygen that can be a hydrogen bond donor</li>
+<li>N_D_VINAParticle - Nitrogen that can be a hydrogen bond donor</li>
+<li>O_A_VINAParticle - Oxygen that can be a hydrogen bond acceptor</li>
+<li>N_A_VINAParticle - Nitrogen that can be a hydrogen bond acceptor</li>
+<li>O_AD_VINAParticle - Oxygen that can be a hydrogen bond donor and acceptor</li>
+<li>N_AD_VINAParticle - Nitrogen that can be a hydrogen bond donor and acceptor</li>
+<li>O_VINAParticle - Oxygen</li>
+<li>N_VINAParticle - Nitrogen</li>
+<li>S_VINAParticle - Sulfur</li>
+<li>P_VINAParticle - Phosphorus</li>
+<li>C_P_VINAParticle - Polar carbon that is covalently bound to a charged atom</li>
+<li>C_VINAParticle - Hydrophobic carbon that is only bound to other carbons or hydrogens</li>
+<li>F_VINAParticle - Fluorine</li>
+<li>Cl_VINAParticle - Chlorine</li>
+<li>Br_VINAParticle - Bromine</li>
+<li>I_VINAParticle - Iodine</li>
+<li>M_VINAParticle - Metals</li>
+<li>INVALID_VINAParticle - Invalid particle...</li>
+</ul>
+</dd></dl>
+
+<dl class="method">
+<dt id="promod3.sidechain.CreateVINAParticle">
+<code class="descclassname">promod3.sidechain.</code><code class="descname">CreateVINAParticle</code><span class="sig-paren">(</span><em>name</em>, <em>particle_type</em>, <em>pos</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.sidechain.CreateVINAParticle" title="Permalink to this definition">¶</a></dt>
+<dd><p>Creates and returns a <a class="reference internal" href="#promod3.sidechain.Particle" title="promod3.sidechain.Particle"><code class="xref py py-class docutils literal"><span class="pre">Particle</span></code></a> that can evaluate the VINA scoring
+function</p>
+<table class="docutils field-list" frame="void" rules="none">
+<col class="field-name" />
+<col class="field-body" />
+<tbody valign="top">
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
+<li><strong>name</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; The name of the particle</li>
+<li><strong>radius</strong> (<a class="reference internal" href="#promod3.sidechain.VINAParticleType" title="promod3.sidechain.VINAParticleType"><code class="xref py py-class docutils literal"><span class="pre">VINAParticleType</span></code></a>) &#8211; The type of the particle</li>
+<li><strong>pos</strong> (<a class="reference external" href="https://www.openstructure.org/docs/geom/vec/#ost.geom.Vec3" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.geom.Vec3</span></code></a>) &#8211; The position of the particle</li>
+</ul>
+</td>
+</tr>
+</tbody>
+</table>
+</dd></dl>
+
+</div>
+</div>
+<div class="section" id="rotamers">
+<h2>Rotamers<a class="headerlink" href="#rotamers" title="Permalink to this headline">¶</a></h2>
 <dl class="class">
 <dt id="promod3.sidechain.RRMRotamer">
 <em class="property">class </em><code class="descclassname">promod3.sidechain.</code><code class="descname">RRMRotamer</code><span class="sig-paren">(</span><em>particles</em>, <em>probability</em>, <em>internal_e_prefactor</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.sidechain.RRMRotamer" title="Permalink to this definition">¶</a></dt>
@@ -278,7 +462,7 @@ in this process.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue to be reconstructed</li>
+<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue to be reconstructed</li>
 <li><strong>consider_hydrogens</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#bool" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">bool</span></code></a>) &#8211; Flag, whether polar hydrogens should be added to
 <strong>res</strong></li>
 <li><strong>new_res_name</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; New name of <strong>res</strong>. Nothing happens in case of the
@@ -554,7 +738,7 @@ No atoms are removed from <strong>res</strong> in this process.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue to be reconstructed</li>
+<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue to be reconstructed</li>
 <li><strong>consider_hydrogens</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#bool" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">bool</span></code></a>) &#8211; Flag, whether polar hydrogens should be added to
 the sidechain</li>
 <li><strong>new_res_name</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; New name of residue. Nothing happens in case of the
@@ -954,7 +1138,7 @@ particles of the same residue.</li>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Rotamer index</li>
-<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue to be reconstructed</li>
+<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue to be reconstructed</li>
 <li><strong>consider_hydrogens</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#bool" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">bool</span></code></a>) &#8211; Flag, whether polar hydrogens should be added to
 the sidechain</li>
 <li><strong>new_res_name</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; New name of residue. Nothing happens in case of the
@@ -1088,7 +1272,7 @@ particles of the same residue.</li>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Rotamer index</li>
-<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue to be reconstructed</li>
+<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue to be reconstructed</li>
 <li><strong>consider_hydrogens</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#bool" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">bool</span></code></a>) &#8211; Flag, whether polar hydrogens should be added to
 the sidechain</li>
 <li><strong>new_res_name</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; New name of residue. Nothing happens in case of the
@@ -1170,10 +1354,18 @@ rotamers with <em>self_energy</em> &gt; <em>l_e</em> + <em>thresh</em></p>
         <div class="sphinxsidebarwrapper">
   <h3><a href="../index.html">Table Of Contents</a></h3>
   <ul>
-<li><a class="reference internal" href="#">Rotamers</a><ul>
-<li><a class="reference internal" href="#the-smallest-building-block-the-particle">The Smallest Building Block - The Particle</a></li>
+<li><a class="reference internal" href="#">Representing Sidechains - Rotamers &amp; Co.</a><ul>
+<li><a class="reference internal" href="#rotamerid">RotamerID</a><ul>
+<li><a class="reference internal" href="#how-can-i-get-an-id">How can I get an ID?</a></li>
+</ul>
+</li>
+<li><a class="reference internal" href="#the-smallest-building-block-the-particle">The Smallest Building Block - The Particle</a><ul>
 <li><a class="reference internal" href="#the-scwrl4-scoring-function">The SCWRL4 scoring function</a></li>
-<li><a class="reference internal" href="#id1">Rotamers</a></li>
+<li><a class="reference internal" href="#the-scwrl3-scoring-function">The SCWRL3 scoring function</a></li>
+<li><a class="reference internal" href="#the-vina-scoring-function">The VINA scoring function</a></li>
+</ul>
+</li>
+<li><a class="reference internal" href="#rotamers">Rotamers</a></li>
 <li><a class="reference internal" href="#rotamer-groups">Rotamer Groups</a></li>
 </ul>
 </li>
@@ -1184,8 +1376,8 @@ rotamers with <em>self_energy</em> &gt; <em>l_e</em> + <em>thresh</em></p>
   <li><a href="../index.html">Documentation overview</a><ul>
   <li><a href="../users.html">Documentation For Users</a><ul>
   <li><a href="index.html"><code class="docutils literal"><span class="pre">sidechain</span></code> - Sidechain Modelling</a><ul>
-      <li>Previous: <a href="rotamer_id.html" title="previous chapter">RotamerID</a></li>
-      <li>Next: <a href="frame.html" title="next chapter">Frame</a></li>
+      <li>Previous: <a href="index.html" title="previous chapter"><code class="docutils literal"><span class="pre">sidechain</span></code> - Sidechain Modelling</a></li>
+      <li>Next: <a href="frame.html" title="next chapter">Frame - The Rigid Part</a></li>
   </ul></li>
   </ul></li>
   </ul></li>
@@ -1213,7 +1405,7 @@ rotamers with <em>self_energy</em> &gt; <em>l_e</em> + <em>thresh</em></p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/sidechain/rotamer_constructor.html b/doc/html/sidechain/rotamer_constructor.html
index 992881a63c466cf6e9dad28c2276f87bd8837b6b..cc1e1e8a80f21e51d9942ba7a60803771bfd5835 100644
--- a/doc/html/sidechain/rotamer_constructor.html
+++ b/doc/html/sidechain/rotamer_constructor.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Rotamer Constructor &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Rotamer Constructor &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,10 +24,10 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="sidechain - Sidechain Modelling" href="index.html" />
-    <link rel="next" title="Rotamer Graph" href="graph.html" />
-    <link rel="prev" title="Rotamer Library" href="rotamer_lib.html" />
+    <link rel="next" title="Rotamer Library" href="rotamer_lib.html" />
+    <link rel="prev" title="Frame - The Rigid Part" href="frame.html" />
    
   <link rel="stylesheet" href="../_static/custom.css" type="text/css" />
   
@@ -44,15 +44,15 @@
             
   <div class="section" id="rotamer-constructor">
 <h1>Rotamer Constructor<a class="headerlink" href="#rotamer-constructor" title="Permalink to this headline">¶</a></h1>
-<p>Instead of creating rotamers by yourself, you can simply use the convenient
-functionality provided by ProMod3.</p>
-<div class="section" id="constructing-rotamers-and-frame-residues">
-<h2>Constructing Rotamers and Frame Residues<a class="headerlink" href="#constructing-rotamers-and-frame-residues" title="Permalink to this headline">¶</a></h2>
+<p>Instead of creating rotamers or frame residues by yourself, you can use the
+convenient functionality provided by ProMod3.</p>
+<div class="section" id="the-rotamerconstructor-baseclass">
+<h2>The RotamerConstructor Baseclass<a class="headerlink" href="#the-rotamerconstructor-baseclass" title="Permalink to this headline">¶</a></h2>
 <dl class="class">
 <dt id="promod3.sidechain.RotamerConstructor">
 <em class="property">class </em><code class="descclassname">promod3.sidechain.</code><code class="descname">RotamerConstructor</code><a class="headerlink" href="#promod3.sidechain.RotamerConstructor" title="Permalink to this definition">¶</a></dt>
 <dd><p>Abstract base class that cannot be initialized from Python. It builds
-an interface implemented by energy function specific constructors
+an interface implemented by scoring function specific constructors
 (e.g. <a class="reference internal" href="#promod3.sidechain.SCWRL4RotamerConstructor" title="promod3.sidechain.SCWRL4RotamerConstructor"><code class="xref py py-class docutils literal"><span class="pre">SCWRL4RotamerConstructor</span></code></a>).</p>
 <dl class="method">
 <dt id="promod3.sidechain.RotamerConstructor.ConstructRRMRotamerGroup">
@@ -79,11 +79,11 @@ an interface implemented by energy function specific constructors
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; To extract the required backbone atoms</li>
+<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; To extract the required backbone atoms</li>
 <li><strong>all_atom_pos</strong> (<a class="reference internal" href="../loop/all_atom.html#promod3.loop.AllAtomPositions" title="promod3.loop.AllAtomPositions"><code class="xref py py-class docutils literal"><span class="pre">promod3.loop.AllAtomPositions</span></code></a>) &#8211; To extract the required backbone atoms</li>
 <li><strong>aa_res_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Index of residue in <strong>all_atom_pos</strong> from which to
 extract the required backbone atoms</li>
-<li><strong>id</strong> (<a class="reference internal" href="rotamer_id.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identifies the sidechain.</li>
+<li><strong>id</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identifies the sidechain.</li>
 <li><strong>residue_index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Important for the energy calculations towards the
 <a class="reference internal" href="frame.html#promod3.sidechain.Frame" title="promod3.sidechain.Frame"><code class="xref py py-class docutils literal"><span class="pre">Frame</span></code></a> you don&#8217;t want to calculate a pairwise
 energy of the sidechain particles towards particles
@@ -134,11 +134,11 @@ don&#8217;t show up in a rotamer).</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue from which to extract the backbone positions</li>
+<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue from which to extract the backbone positions</li>
 <li><strong>all_atom_pos</strong> (<a class="reference internal" href="../loop/all_atom.html#promod3.loop.AllAtomPositions" title="promod3.loop.AllAtomPositions"><code class="xref py py-class docutils literal"><span class="pre">promod3.loop.AllAtomPositions</span></code></a>) &#8211; To extract the backbone positions</li>
 <li><strong>aa_res_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Index of residue in <strong>all_atom_pos</strong> from which to
 extract the backbone positions</li>
-<li><strong>id</strong> (<a class="reference internal" href="rotamer_id.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identifies the sidechain</li>
+<li><strong>id</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identifies the sidechain</li>
 <li><strong>residue_index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Important for the energy calculations towards the
 <a class="reference internal" href="frame.html#promod3.sidechain.Frame" title="promod3.sidechain.Frame"><code class="xref py py-class docutils literal"><span class="pre">Frame</span></code></a> you don&#8217;t want to calculate a pairwise
 energy of the sidechain particles towards particles
@@ -177,11 +177,11 @@ you observe in a rotamer).</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue from which to extract the backbone positions</li>
+<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue from which to extract the backbone positions</li>
 <li><strong>all_atom_pos</strong> (<a class="reference internal" href="../loop/all_atom.html#promod3.loop.AllAtomPositions" title="promod3.loop.AllAtomPositions"><code class="xref py py-class docutils literal"><span class="pre">promod3.loop.AllAtomPositions</span></code></a>) &#8211; To extract the backbone positions</li>
 <li><strong>aa_res_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Index of residue in <strong>all_atom_pos</strong> from which to
 extract the backbone positions</li>
-<li><strong>id</strong> (<a class="reference internal" href="rotamer_id.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identifies the sidechain</li>
+<li><strong>id</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identifies the sidechain</li>
 <li><strong>residue_index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Important for the energy calculations towards the
 <a class="reference internal" href="frame.html#promod3.sidechain.Frame" title="promod3.sidechain.Frame"><code class="xref py py-class docutils literal"><span class="pre">Frame</span></code></a> you don&#8217;t want to calculate a pairwise
 energy of the sidechain particles towards particles
@@ -219,7 +219,7 @@ to the energy function specific constructors to override that behaviour.</p>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
 <li><strong>rot_group</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RRMRotamerGroup" title="promod3.sidechain.RRMRotamerGroup"><code class="xref py py-class docutils literal"><span class="pre">RRMRotamerGroup</span></code></a> / <a class="reference internal" href="rotamer.html#promod3.sidechain.FRMRotamerGroup" title="promod3.sidechain.FRMRotamerGroup"><code class="xref py py-class docutils literal"><span class="pre">FRMRotamerGroup</span></code></a>) &#8211; containing all rotamers for which internal energies have
 to be assigned</li>
-<li><strong>id</strong> (<a class="reference internal" href="rotamer_id.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identifies the sidechain</li>
+<li><strong>id</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identifies the sidechain</li>
 <li><strong>residue_index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; The index of the residue which is represented by
 <em>rot_group</em></li>
 <li><strong>phi</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; The dihedral angle of the current residue</li>
@@ -235,6 +235,9 @@ to be assigned</li>
 
 </dd></dl>
 
+</div>
+<div class="section" id="scoring-function-specific-rotamerconstructors">
+<h2>Scoring Function Specific RotamerConstructors<a class="headerlink" href="#scoring-function-specific-rotamerconstructors" title="Permalink to this headline">¶</a></h2>
 <dl class="class">
 <dt id="promod3.sidechain.SCWRL4RotamerConstructor">
 <em class="property">class </em><code class="descclassname">promod3.sidechain.</code><code class="descname">SCWRL4RotamerConstructor</code><span class="sig-paren">(</span><em>cb_in_sidechain</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.sidechain.SCWRL4RotamerConstructor" title="Permalink to this definition">¶</a></dt>
@@ -262,7 +265,7 @@ any rotamers for ALA and GLY.</td>
 <dl class="method">
 <dt id="promod3.sidechain.SCWRL4RotamerConstructor.ConstructFrameResidue">
 <code class="descname">ConstructFrameResidue</code><span class="sig-paren">(</span><em>residue</em>, <em>residue_index</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.sidechain.SCWRL4RotamerConstructor.ConstructFrameResidue" title="Permalink to this definition">¶</a></dt>
-<dd><p>Constructs a <a class="reference internal" href="frame.html#promod3.sidechain.FrameResidue" title="promod3.sidechain.FrameResidue"><code class="xref py py-class docutils literal"><span class="pre">FrameResidue</span></code></a> from a <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>.
+<dd><p>Constructs a <a class="reference internal" href="frame.html#promod3.sidechain.FrameResidue" title="promod3.sidechain.FrameResidue"><code class="xref py py-class docutils literal"><span class="pre">FrameResidue</span></code></a> from a <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>.
 This can be useful to mark a region occupied by a ligand. Note, that
 there won&#8217;t be any parametrization of hbonds in this function. All heavy
 atoms of the residue will be represented as carbons and hydrogens are
@@ -272,7 +275,7 @@ skipped.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>residue</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue from which all atoms will be taken to
+<li><strong>residue</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue from which all atoms will be taken to
 construct a <a class="reference internal" href="frame.html#promod3.sidechain.FrameResidue" title="promod3.sidechain.FrameResidue"><code class="xref py py-class docutils literal"><span class="pre">FrameResidue</span></code></a>.</li>
 <li><strong>residue_index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Index this <a class="reference internal" href="frame.html#promod3.sidechain.FrameResidue" title="promod3.sidechain.FrameResidue"><code class="xref py py-class docutils literal"><span class="pre">FrameResidue</span></code></a> belongs to.</li>
 </ul>
@@ -288,7 +291,7 @@ construct a <a class="reference internal" href="frame.html#promod3.sidechain.Fra
 <dl class="method">
 <dt id="promod3.sidechain.SCWRL4RotamerConstructor.ConstructFrameResidueHeuristic">
 <code class="descname">ConstructFrameResidueHeuristic</code><span class="sig-paren">(</span><em>residue</em>, <em>residue_index</em>, <em>comp_lib</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.sidechain.SCWRL4RotamerConstructor.ConstructFrameResidueHeuristic" title="Permalink to this definition">¶</a></dt>
-<dd><p>Constructs a <a class="reference internal" href="frame.html#promod3.sidechain.FrameResidue" title="promod3.sidechain.FrameResidue"><code class="xref py py-class docutils literal"><span class="pre">FrameResidue</span></code></a> from a <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a> using
+<dd><p>Constructs a <a class="reference internal" href="frame.html#promod3.sidechain.FrameResidue" title="promod3.sidechain.FrameResidue"><code class="xref py py-class docutils literal"><span class="pre">FrameResidue</span></code></a> from a <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a> using
 a heuristic treatment of the atoms based on the passed compounds library.
 This is meant to be used as an alternative to <a class="reference internal" href="#promod3.sidechain.SCWRL4RotamerConstructor.ConstructFrameResidue" title="promod3.sidechain.SCWRL4RotamerConstructor.ConstructFrameResidue"><code class="xref py py-func docutils literal"><span class="pre">ConstructFrameResidue()</span></code></a>,
 which will be called by this function if the residue is not known by the given
@@ -306,10 +309,10 @@ as in the <code class="xref py py-class docutils literal"><span class="pre">Side
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>residue</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue from which all atoms will be taken to
+<li><strong>residue</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue from which all atoms will be taken to
 construct a <a class="reference internal" href="frame.html#promod3.sidechain.FrameResidue" title="promod3.sidechain.FrameResidue"><code class="xref py py-class docutils literal"><span class="pre">FrameResidue</span></code></a>.</li>
 <li><strong>residue_index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Index this <a class="reference internal" href="frame.html#promod3.sidechain.FrameResidue" title="promod3.sidechain.FrameResidue"><code class="xref py py-class docutils literal"><span class="pre">FrameResidue</span></code></a> belongs to.</li>
-<li><strong>comp_lib</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/compoundlib/#ost.conop.CompoundLib" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.CompoundLib</span></code></a>) &#8211; OST compound library to use</li>
+<li><strong>comp_lib</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/compoundlib/#ost.conop.CompoundLib" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.CompoundLib</span></code></a>) &#8211; OST compound library to use</li>
 </ul>
 </td>
 </tr>
@@ -338,7 +341,121 @@ is already called at construction and the energies are properly assigned.</p>
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
 <li><strong>rot_group</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RRMRotamerGroup" title="promod3.sidechain.RRMRotamerGroup"><code class="xref py py-class docutils literal"><span class="pre">RRMRotamerGroup</span></code></a> / <a class="reference internal" href="rotamer.html#promod3.sidechain.FRMRotamerGroup" title="promod3.sidechain.FRMRotamerGroup"><code class="xref py py-class docutils literal"><span class="pre">FRMRotamerGroup</span></code></a>) &#8211; containing all rotamers for which internal energies have
 to be assigned</li>
-<li><strong>id</strong> (<a class="reference internal" href="rotamer_id.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identifies the sidechain</li>
+<li><strong>id</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identifies the sidechain</li>
+<li><strong>residue_index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; The index of the residue which is represented by
+<em>rot_group</em></li>
+<li><strong>phi</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; The dihedral angle of the current residue</li>
+<li><strong>psi</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; The dihedral angle of the current residue</li>
+<li><strong>n_ter</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#bool" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">bool</span></code></a>) &#8211; Whether the residue is n-terminal</li>
+<li><strong>c_ter</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#bool" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">bool</span></code></a>) &#8211; Whether the residue is c-terminal</li>
+</ul>
+</td>
+</tr>
+</tbody>
+</table>
+</dd></dl>
+
+</dd></dl>
+
+<dl class="class">
+<dt id="promod3.sidechain.SCWRL3RotamerConstructor">
+<em class="property">class </em><code class="descclassname">promod3.sidechain.</code><code class="descname">SCWRL3RotamerConstructor</code><span class="sig-paren">(</span><em>cb_in_sidechain</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.sidechain.SCWRL3RotamerConstructor" title="Permalink to this definition">¶</a></dt>
+<dd><p>This object implements the full interface defined in
+<a class="reference internal" href="#promod3.sidechain.RotamerConstructor" title="promod3.sidechain.RotamerConstructor"><code class="xref py py-class docutils literal"><span class="pre">RotamerConstructor</span></code></a> and constructs rotamers and frame residues that
+are parametrized according to the SCWRL3 method. They contain only heavy atoms.</p>
+<table class="docutils field-list" frame="void" rules="none">
+<col class="field-name" />
+<col class="field-body" />
+<tbody valign="top">
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>cb_in_sidechain</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#bool" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">bool</span></code></a>) &#8211; If set to true, all constructed rotamers will contain
+the cb atom. This flag also affects the construction
+of frame residues and controls whether the cb atom
+shows up in the backbone frame residues or sidechain
+frame residues.
+This is useful when you want to represent ALA or
+GLY with actual rotamers, but be aware of increased
+runtime. This flag can be set to False for most
+modeling applications and you just don&#8217;t generate
+any rotamers for ALA and GLY.</td>
+</tr>
+</tbody>
+</table>
+<dl class="method">
+<dt id="promod3.sidechain.SCWRL3RotamerConstructor.AssignInternalEnergies">
+<code class="descname">AssignInternalEnergies</code><span class="sig-paren">(</span><em>rot_group</em>, <em>id</em>, <em>residue_index</em><span class="optional">[</span>, <em>phi = -1.0472</em>, <em>psi = -0.7854</em>, <em>n_ter = False</em>, <em>c_ter = False</em><span class="optional">]</span><span class="sig-paren">)</span><a class="headerlink" href="#promod3.sidechain.SCWRL3RotamerConstructor.AssignInternalEnergies" title="Permalink to this definition">¶</a></dt>
+<dd><p>Overrides the method defined in <a class="reference internal" href="#promod3.sidechain.RotamerConstructor" title="promod3.sidechain.RotamerConstructor"><code class="xref py py-class docutils literal"><span class="pre">RotamerConstructor</span></code></a>.
+Takes the rotamer group and assigns every single rotamer its internal
+energy based on the probabilistic approach used by SCWRL3.
+=&gt; -internal_e_prefac*log(p/max_p), where internal_e_prefac and p are
+rotamer specific and max_p is the maximum probablity of any of the rotamers
+in <strong>rot_group</strong>. If you construct a rotamer group by the
+ConstructRRMRotamerGroup/ConstructFRMRotamerGroup functions, this function
+is already called at construction and the energies are properly assigned.</p>
+<table class="docutils field-list" frame="void" rules="none">
+<col class="field-name" />
+<col class="field-body" />
+<tbody valign="top">
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
+<li><strong>rot_group</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RRMRotamerGroup" title="promod3.sidechain.RRMRotamerGroup"><code class="xref py py-class docutils literal"><span class="pre">RRMRotamerGroup</span></code></a> / <a class="reference internal" href="rotamer.html#promod3.sidechain.FRMRotamerGroup" title="promod3.sidechain.FRMRotamerGroup"><code class="xref py py-class docutils literal"><span class="pre">FRMRotamerGroup</span></code></a>) &#8211; containing all rotamers for which internal energies have
+to be assigned</li>
+<li><strong>id</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identifies the sidechain</li>
+<li><strong>residue_index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; The index of the residue which is represented by
+<em>rot_group</em></li>
+<li><strong>phi</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; The dihedral angle of the current residue</li>
+<li><strong>psi</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; The dihedral angle of the current residue</li>
+<li><strong>n_ter</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#bool" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">bool</span></code></a>) &#8211; Whether the residue is n-terminal</li>
+<li><strong>c_ter</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#bool" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">bool</span></code></a>) &#8211; Whether the residue is c-terminal</li>
+</ul>
+</td>
+</tr>
+</tbody>
+</table>
+</dd></dl>
+
+</dd></dl>
+
+<dl class="class">
+<dt id="promod3.sidechain.VINARotamerConstructor">
+<em class="property">class </em><code class="descclassname">promod3.sidechain.</code><code class="descname">VINARotamerConstructor</code><span class="sig-paren">(</span><em>cb_in_sidechain</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.sidechain.VINARotamerConstructor" title="Permalink to this definition">¶</a></dt>
+<dd><p>This object implements the full interface defined in
+<a class="reference internal" href="#promod3.sidechain.RotamerConstructor" title="promod3.sidechain.RotamerConstructor"><code class="xref py py-class docutils literal"><span class="pre">RotamerConstructor</span></code></a> and constructs rotamers and frame residues that
+are parametrized according to the VINA method. They contain only heavy atoms.</p>
+<table class="docutils field-list" frame="void" rules="none">
+<col class="field-name" />
+<col class="field-body" />
+<tbody valign="top">
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>cb_in_sidechain</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#bool" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">bool</span></code></a>) &#8211; If set to true, all constructed rotamers will contain
+the cb atom. This flag also affects the construction
+of frame residues and controls whether the cb atom
+shows up in the backbone frame residues or sidechain
+frame residues.
+This is useful when you want to represent ALA or
+GLY with actual rotamers, but be aware of increased
+runtime. This flag can be set to False for most
+modeling applications and you just don&#8217;t generate
+any rotamers for ALA and GLY.</td>
+</tr>
+</tbody>
+</table>
+<dl class="method">
+<dt id="promod3.sidechain.VINARotamerConstructor.AssignInternalEnergies">
+<code class="descname">AssignInternalEnergies</code><span class="sig-paren">(</span><em>rot_group</em>, <em>id</em>, <em>residue_index</em><span class="optional">[</span>, <em>phi = -1.0472</em>, <em>psi = -0.7854</em>, <em>n_ter = False</em>, <em>c_ter = False</em><span class="optional">]</span><span class="sig-paren">)</span><a class="headerlink" href="#promod3.sidechain.VINARotamerConstructor.AssignInternalEnergies" title="Permalink to this definition">¶</a></dt>
+<dd><p>Overrides the method defined in <a class="reference internal" href="#promod3.sidechain.RotamerConstructor" title="promod3.sidechain.RotamerConstructor"><code class="xref py py-class docutils literal"><span class="pre">RotamerConstructor</span></code></a>.
+Takes the rotamer group and assigns every single rotamer its internal
+energy based on the probabilistic approach used by SCWRL3/SCWRL4.
+=&gt; -internal_e_prefac*log(p/max_p), where internal_e_prefac and p are
+rotamer specific and max_p is the maximum probablity of any of the rotamers
+in <strong>rot_group</strong>. If you construct a rotamer group by the
+ConstructRRMRotamerGroup/ConstructFRMRotamerGroup functions, this function
+is already called at construction and the energies are properly assigned.</p>
+<table class="docutils field-list" frame="void" rules="none">
+<col class="field-name" />
+<col class="field-body" />
+<tbody valign="top">
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first last simple">
+<li><strong>rot_group</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RRMRotamerGroup" title="promod3.sidechain.RRMRotamerGroup"><code class="xref py py-class docutils literal"><span class="pre">RRMRotamerGroup</span></code></a> / <a class="reference internal" href="rotamer.html#promod3.sidechain.FRMRotamerGroup" title="promod3.sidechain.FRMRotamerGroup"><code class="xref py py-class docutils literal"><span class="pre">FRMRotamerGroup</span></code></a>) &#8211; containing all rotamers for which internal energies have
+to be assigned</li>
+<li><strong>id</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identifies the sidechain</li>
 <li><strong>residue_index</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; The index of the residue which is represented by
 <em>rot_group</em></li>
 <li><strong>phi</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; The dihedral angle of the current residue</li>
@@ -352,6 +469,102 @@ to be assigned</li>
 </table>
 </dd></dl>
 
+<dl class="method">
+<dt id="promod3.sidechain.VINARotamerConstructor.ConstructFrameResidueHeuristic">
+<code class="descname">ConstructFrameResidueHeuristic</code><span class="sig-paren">(</span><em>res</em>, <em>res_idx</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.sidechain.VINARotamerConstructor.ConstructFrameResidueHeuristic" title="Permalink to this definition">¶</a></dt>
+<dd><p>Constructs a <a class="reference internal" href="frame.html#promod3.sidechain.FrameResidue" title="promod3.sidechain.FrameResidue"><code class="xref py py-class docutils literal"><span class="pre">FrameResidue</span></code></a> from a <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a> using
+a heuristic treatment of the atoms. It is important that the residue has
+proper bonds assigned, as they influence the atom typing procedure.
+Furthermore, you need hydrogens to automatically estimate the correct
+atom type for oxygens and nitrogens (hydrogen bond donor/acceptor).
+Alternatively you can assign generic properties to oxygens and nitrogens
+to circumvent the requirement of hydrogens. This is further described for
+the case of oxygen.</p>
+<ul class="simple">
+<li>Carbon is assigned C_VINAParticle <a class="reference internal" href="rotamer.html#promod3.sidechain.VINAParticleType" title="promod3.sidechain.VINAParticleType"><code class="xref py py-class docutils literal"><span class="pre">VINAParticleType</span></code></a> if its only
+bound to other carbons or hydrogens (and deuterium). All other carbons are
+assigned C_P_VINAParticle <a class="reference internal" href="rotamer.html#promod3.sidechain.VINAParticleType" title="promod3.sidechain.VINAParticleType"><code class="xref py py-class docutils literal"><span class="pre">VINAParticleType</span></code></a>.</li>
+<li>In case of oxygen, the heuristic first checks for set generic properties.
+If the atom has the bool properties &#8220;is_hbond_acceptor&#8221; AND
+&#8220;is_hbond_donor&#8221; set, it decides between the according oxygen types
+in <a class="reference internal" href="rotamer.html#promod3.sidechain.VINAParticleType" title="promod3.sidechain.VINAParticleType"><code class="xref py py-class docutils literal"><span class="pre">VINAParticleType</span></code></a>. If the generic properties are not set,
+every oxygen is assumed to be an hbond acceptor. But only an hbond donor
+if its bound to a hydrogen (or deuterium). You can set the generic
+properties for an <a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.AtomHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.AtomHandle</span></code></a> by calling
+at.SetBoolProp(&#8220;is_hbond_donor&#8221;, False) and
+at.SetBoolProp(&#8220;is_hbond_acceptor&#8221;, True). An oxygen with those
+generic properties is assigned O_A_VINAParticle <a class="reference internal" href="rotamer.html#promod3.sidechain.VINAParticleType" title="promod3.sidechain.VINAParticleType"><code class="xref py py-class docutils literal"><span class="pre">VINAParticleType</span></code></a>.</li>
+<li>In case of nitrogen, the heuristic again first checks for set generic
+properties.
+If the atom has the bool properties &#8220;is_hbond_acceptor&#8221; AND
+&#8220;is_hbond_donor&#8221; set, it decides between the according nitrogen types
+in <a class="reference internal" href="rotamer.html#promod3.sidechain.VINAParticleType" title="promod3.sidechain.VINAParticleType"><code class="xref py py-class docutils literal"><span class="pre">VINAParticleType</span></code></a>. If not, nitrogen is expected to be an
+hbond donor if it is bound to a hydrogen (or deuterium) and
+an hbond acceptor if it is bound to less than 3 other atoms (sounds
+horrible but works surprisingly well).</li>
+<li>Atoms of elements [&#8220;MG&#8221;, &#8220;MN&#8221;, &#8220;ZN&#8221;, &#8220;CA&#8221;, &#8220;FE&#8221;] are assigned
+M_VINAParticle <a class="reference internal" href="rotamer.html#promod3.sidechain.VINAParticleType" title="promod3.sidechain.VINAParticleType"><code class="xref py py-class docutils literal"><span class="pre">VINAParticleType</span></code></a>.</li>
+<li>Atoms of elements [&#8220;S&#8221;, &#8220;P&#8221;, &#8220;F&#8221;, &#8220;CL&#8221;, &#8220;BR&#8221;, &#8220;I&#8221;] are assigned their
+corresponding <a class="reference internal" href="rotamer.html#promod3.sidechain.VINAParticleType" title="promod3.sidechain.VINAParticleType"><code class="xref py py-class docutils literal"><span class="pre">VINAParticleType</span></code></a>.</li>
+<li>All other atoms are neglected and not added to the returned
+<a class="reference internal" href="frame.html#promod3.sidechain.FrameResidue" title="promod3.sidechain.FrameResidue"><code class="xref py py-class docutils literal"><span class="pre">FrameResidue</span></code></a>.</li>
+</ul>
+<table class="docutils field-list" frame="void" rules="none">
+<col class="field-name" />
+<col class="field-body" />
+<tbody valign="top">
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
+<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue from which to create the
+<a class="reference internal" href="frame.html#promod3.sidechain.FrameResidue" title="promod3.sidechain.FrameResidue"><code class="xref py py-class docutils literal"><span class="pre">FrameResidue</span></code></a></li>
+<li><strong>res_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Index that is set in <a class="reference internal" href="frame.html#promod3.sidechain.FrameResidue" title="promod3.sidechain.FrameResidue"><code class="xref py py-class docutils literal"><span class="pre">FrameResidue</span></code></a></li>
+</ul>
+</td>
+</tr>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><p class="first last"><a class="reference internal" href="frame.html#promod3.sidechain.FrameResidue" title="promod3.sidechain.FrameResidue"><code class="xref py py-class docutils literal"><span class="pre">FrameResidue</span></code></a></p>
+</td>
+</tr>
+</tbody>
+</table>
+</dd></dl>
+
+<dl class="method">
+<dt id="promod3.sidechain.VINARotamerConstructor.ConstructRRMRotamerHeuristic">
+<code class="descname">ConstructRRMRotamerHeuristic</code><span class="sig-paren">(</span><em>res</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.sidechain.VINARotamerConstructor.ConstructRRMRotamerHeuristic" title="Permalink to this definition">¶</a></dt>
+<dd><p>Construct a <a class="reference internal" href="rotamer.html#promod3.sidechain.RRMRotamer" title="promod3.sidechain.RRMRotamer"><code class="xref py py-class docutils literal"><span class="pre">RRMRotamer</span></code></a> with the atom typing heuristic
+as in the <a class="reference internal" href="#promod3.sidechain.VINARotamerConstructor.ConstructFrameResidueHeuristic" title="promod3.sidechain.VINARotamerConstructor.ConstructFrameResidueHeuristic"><code class="xref py py-meth docutils literal"><span class="pre">ConstructFrameResidueHeuristic()</span></code></a> method.</p>
+<table class="docutils field-list" frame="void" rules="none">
+<col class="field-name" />
+<col class="field-body" />
+<tbody valign="top">
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue from which to create the
+<a class="reference internal" href="rotamer.html#promod3.sidechain.RRMRotamer" title="promod3.sidechain.RRMRotamer"><code class="xref py py-class docutils literal"><span class="pre">RRMRotamer</span></code></a></td>
+</tr>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference internal" href="rotamer.html#promod3.sidechain.RRMRotamer" title="promod3.sidechain.RRMRotamer"><code class="xref py py-class docutils literal"><span class="pre">RRMRotamer</span></code></a></td>
+</tr>
+</tbody>
+</table>
+</dd></dl>
+
+<dl class="method">
+<dt id="promod3.sidechain.VINARotamerConstructor.ConstructFRMRotamerHeuristic">
+<code class="descname">ConstructFRMRotamerHeuristic</code><span class="sig-paren">(</span><em>res</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.sidechain.VINARotamerConstructor.ConstructFRMRotamerHeuristic" title="Permalink to this definition">¶</a></dt>
+<dd><p>Construct a <a class="reference internal" href="rotamer.html#promod3.sidechain.FRMRotamer" title="promod3.sidechain.FRMRotamer"><code class="xref py py-class docutils literal"><span class="pre">FRMRotamer</span></code></a> with the atom typing heuristic
+as in the <a class="reference internal" href="#promod3.sidechain.VINARotamerConstructor.ConstructFrameResidueHeuristic" title="promod3.sidechain.VINARotamerConstructor.ConstructFrameResidueHeuristic"><code class="xref py py-meth docutils literal"><span class="pre">ConstructFrameResidueHeuristic()</span></code></a> method. The
+constructed <a class="reference internal" href="rotamer.html#promod3.sidechain.FRMRotamer" title="promod3.sidechain.FRMRotamer"><code class="xref py py-class docutils literal"><span class="pre">FRMRotamer</span></code></a> only contains one subrotamer that
+contains the atoms from <em>residue</em>.</p>
+<table class="docutils field-list" frame="void" rules="none">
+<col class="field-name" />
+<col class="field-body" />
+<tbody valign="top">
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Residue from which to create the
+<a class="reference internal" href="rotamer.html#promod3.sidechain.FRMRotamer" title="promod3.sidechain.FRMRotamer"><code class="xref py py-class docutils literal"><span class="pre">FRMRotamer</span></code></a></td>
+</tr>
+<tr class="field-even field"><th class="field-name">Return type:</th><td class="field-body"><a class="reference internal" href="rotamer.html#promod3.sidechain.FRMRotamer" title="promod3.sidechain.FRMRotamer"><code class="xref py py-class docutils literal"><span class="pre">FRMRotamer</span></code></a></td>
+</tr>
+</tbody>
+</table>
+</dd></dl>
+
 </dd></dl>
 
 </div>
@@ -366,7 +579,8 @@ to be assigned</li>
   <h3><a href="../index.html">Table Of Contents</a></h3>
   <ul>
 <li><a class="reference internal" href="#">Rotamer Constructor</a><ul>
-<li><a class="reference internal" href="#constructing-rotamers-and-frame-residues">Constructing Rotamers and Frame Residues</a></li>
+<li><a class="reference internal" href="#the-rotamerconstructor-baseclass">The RotamerConstructor Baseclass</a></li>
+<li><a class="reference internal" href="#scoring-function-specific-rotamerconstructors">Scoring Function Specific RotamerConstructors</a></li>
 </ul>
 </li>
 </ul>
@@ -376,8 +590,8 @@ to be assigned</li>
   <li><a href="../index.html">Documentation overview</a><ul>
   <li><a href="../users.html">Documentation For Users</a><ul>
   <li><a href="index.html"><code class="docutils literal"><span class="pre">sidechain</span></code> - Sidechain Modelling</a><ul>
-      <li>Previous: <a href="rotamer_lib.html" title="previous chapter">Rotamer Library</a></li>
-      <li>Next: <a href="graph.html" title="next chapter">Rotamer Graph</a></li>
+      <li>Previous: <a href="frame.html" title="previous chapter">Frame - The Rigid Part</a></li>
+      <li>Next: <a href="rotamer_lib.html" title="next chapter">Rotamer Library</a></li>
   </ul></li>
   </ul></li>
   </ul></li>
@@ -405,7 +619,7 @@ to be assigned</li>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/sidechain/rotamer_id.html b/doc/html/sidechain/rotamer_id.html
deleted file mode 100644
index 80e2b6832047a2ac820f8d5dd21d16cc6b4e7e57..0000000000000000000000000000000000000000
--- a/doc/html/sidechain/rotamer_id.html
+++ /dev/null
@@ -1,202 +0,0 @@
-<!DOCTYPE html PUBLIC "-//W3C//DTD XHTML 1.0 Transitional//EN"
-  "http://www.w3.org/TR/xhtml1/DTD/xhtml1-transitional.dtd">
-
-
-<html xmlns="http://www.w3.org/1999/xhtml">
-  <head>
-    <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
-    
-    <title>RotamerID &mdash; ProMod3 2.0.0 documentation</title>
-    
-    <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
-    <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
-    
-    <script type="text/javascript">
-      var DOCUMENTATION_OPTIONS = {
-        URL_ROOT:    '../',
-        VERSION:     '2.0.0',
-        COLLAPSE_INDEX: false,
-        FILE_SUFFIX: '.html',
-        HAS_SOURCE:  true
-      };
-    </script>
-    <script type="text/javascript" src="../_static/jquery.js"></script>
-    <script type="text/javascript" src="../_static/underscore.js"></script>
-    <script type="text/javascript" src="../_static/doctools.js"></script>
-    <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
-    <link rel="up" title="sidechain - Sidechain Modelling" href="index.html" />
-    <link rel="next" title="Rotamers" href="rotamer.html" />
-    <link rel="prev" title="sidechain - Sidechain Modelling" href="index.html" />
-   
-  <link rel="stylesheet" href="../_static/custom.css" type="text/css" />
-  
-  <meta name="viewport" content="width=device-width, initial-scale=0.9, maximum-scale=0.9" />
-
-  </head>
-  <body role="document">
-  
-
-    <div class="document">
-      <div class="documentwrapper">
-        <div class="bodywrapper">
-          <div class="body" role="main">
-            
-  <div class="section" id="rotamerid">
-<h1>RotamerID<a class="headerlink" href="#rotamerid" title="Permalink to this headline">¶</a></h1>
-<p>The sidechain module has its own definition of amino acids to satisfy custom
-requirements for the implemented sidechain construction algorithms.
-As an example there are histidine in two possible protonation states,
-that affect the hbond term or different versions of proline/cysteine.</p>
-<div class="section" id="the-rotamerid">
-<h2>The RotamerID<a class="headerlink" href="#the-rotamerid" title="Permalink to this headline">¶</a></h2>
-<dl class="class">
-<dt id="promod3.sidechain.RotamerID">
-<em class="property">class </em><code class="descclassname">promod3.sidechain.</code><code class="descname">RotamerID</code><a class="headerlink" href="#promod3.sidechain.RotamerID" title="Permalink to this definition">¶</a></dt>
-<dd><p>Enumerates the amino acids. Possible values:</p>
-<table class="hlist"><tr><td><ul class="simple">
-<li>ARG - Arginine</li>
-<li>ASN - Asparagine</li>
-<li>ASP - Aspartate</li>
-<li>GLN - Glutamine</li>
-<li>GLU - Glutamate</li>
-<li>LYS - Lysine</li>
-<li>SER - Serine</li>
-<li>CYS - Cystein</li>
-<li>CYH - &#8220;free&#8221; Cystein</li>
-<li>CYD - disulfid bonded Cystein</li>
-<li>MET - Methionine</li>
-<li>TRP - Tryptophane</li>
-<li>TYR - Tyrosine</li>
-<li>THR - Threonine</li>
-</ul>
-</td><td><ul class="simple">
-<li>VAL - Valine</li>
-<li>ILE - Isoleucine</li>
-<li>LEU - Leucine</li>
-<li>PRO - Proline</li>
-<li>CPR - cis-Proline</li>
-<li>TPR - trans-Proline</li>
-<li>HIS - Histidine</li>
-<li>HSD - d-protonated Histidine</li>
-<li>HSE - e-protonated Histidine</li>
-<li>PHE - Phenylalanine</li>
-<li>GLY - Glycine</li>
-<li>ALA - Alanine</li>
-<li>XXX - Invalid</li>
-</ul>
-</td></tr></table>
-<p>The RotamerID enum can be accessed either directly as <code class="docutils literal"><span class="pre">promod3.sidechain.ARG</span></code>
-or as <code class="docutils literal"><span class="pre">promod3.sidechain.RotamerID.ARG</span></code>.</p>
-</dd></dl>
-
-</div>
-<div class="section" id="how-can-i-get-an-id">
-<h2>How can I get an ID?<a class="headerlink" href="#how-can-i-get-an-id" title="Permalink to this headline">¶</a></h2>
-<p>The RotamerID enum can directly be accessed from Python. Two convenient
-functions exist to get RotamerIDs from the <a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a> enum
-or from amino acid three letter codes.</p>
-<dl class="method">
-<dt id="promod3.sidechain.TLCToRotID">
-<code class="descclassname">promod3.sidechain.</code><code class="descname">TLCToRotID</code><span class="sig-paren">(</span><em>tlc</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.sidechain.TLCToRotID" title="Permalink to this definition">¶</a></dt>
-<dd><p>Directly translates the three letter code into a RotamerID. Following
-exactly the naming convention defined above.</p>
-<table class="docutils field-list" frame="void" rules="none">
-<col class="field-name" />
-<col class="field-body" />
-<tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>tlc</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#str" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">str</span></code></a>) &#8211; Three letter code of amino acid</td>
-</tr>
-<tr class="field-even field"><th class="field-name">Returns:</th><td class="field-body"><a class="reference internal" href="#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>, XXX if <strong>tlc</strong> cannot be recoginzed.</td>
-</tr>
-</tbody>
-</table>
-</dd></dl>
-
-<dl class="method">
-<dt id="promod3.sidechain.AAToRotID">
-<code class="descclassname">promod3.sidechain.</code><code class="descname">AAToRotID</code><span class="sig-paren">(</span><em>aa</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.sidechain.AAToRotID" title="Permalink to this definition">¶</a></dt>
-<dd><p>Directly translates <strong>aa</strong> into a RotamerID. Note, that it is not possible
-to generate special IDs this way
-(e.g. HSD, HSE or the special prolines/cysteins) since they&#8217;re simply not
-defined in <a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a></p>
-<table class="docutils field-list" frame="void" rules="none">
-<col class="field-name" />
-<col class="field-body" />
-<tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>aa</strong> (<a class="reference external" href="https://www.openstructure.org/docs/conop/aminoacid/#ost.conop.AminoAcid" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.conop.AminoAcid</span></code></a>) &#8211; AA enum of amino acid</td>
-</tr>
-<tr class="field-even field"><th class="field-name">Returns:</th><td class="field-body"><a class="reference internal" href="#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>, XXX if <strong>aa</strong> is invalid.</td>
-</tr>
-</tbody>
-</table>
-</dd></dl>
-
-</div>
-</div>
-
-
-          </div>
-        </div>
-      </div>
-      <div class="sphinxsidebar" role="navigation" aria-label="main navigation">
-        <div class="sphinxsidebarwrapper">
-  <h3><a href="../index.html">Table Of Contents</a></h3>
-  <ul>
-<li><a class="reference internal" href="#">RotamerID</a><ul>
-<li><a class="reference internal" href="#the-rotamerid">The RotamerID</a></li>
-<li><a class="reference internal" href="#how-can-i-get-an-id">How can I get an ID?</a></li>
-</ul>
-</li>
-</ul>
-<div class="relations">
-<h3>Related Topics</h3>
-<ul>
-  <li><a href="../index.html">Documentation overview</a><ul>
-  <li><a href="../users.html">Documentation For Users</a><ul>
-  <li><a href="index.html"><code class="docutils literal"><span class="pre">sidechain</span></code> - Sidechain Modelling</a><ul>
-      <li>Previous: <a href="index.html" title="previous chapter"><code class="docutils literal"><span class="pre">sidechain</span></code> - Sidechain Modelling</a></li>
-      <li>Next: <a href="rotamer.html" title="next chapter">Rotamers</a></li>
-  </ul></li>
-  </ul></li>
-  </ul></li>
-</ul>
-</div>
-  <div role="note" aria-label="source link">
-    <h3>This Page</h3>
-    <ul class="this-page-menu">
-      <li><a href="../_sources/sidechain/rotamer_id.txt"
-            rel="nofollow">Show Source</a></li>
-    </ul>
-   </div>
-<div id="searchbox" style="display: none" role="search">
-  <h3>Quick search</h3>
-    <form class="search" action="../search.html" method="get">
-      <input type="text" name="q" />
-      <input type="submit" value="Go" />
-      <input type="hidden" name="check_keywords" value="yes" />
-      <input type="hidden" name="area" value="default" />
-    </form>
-</div>
-<script type="text/javascript">$('#searchbox').show(0);</script>
-        </div>
-      </div>
-      <div class="clearer"></div>
-    </div>
-    <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
-      
-      |
-      Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
-      &amp; <a href="https://github.com/bitprophet/alabaster">Alabaster 0.7.8</a>
-      
-      |
-      <a href="../_sources/sidechain/rotamer_id.txt"
-          rel="nofollow">Page source</a>
-    </div>
-
-    
-
-    
-  </body>
-</html>
\ No newline at end of file
diff --git a/doc/html/sidechain/rotamer_lib.html b/doc/html/sidechain/rotamer_lib.html
index ea9eb17d345a9d27780d4c12a5e80198cfbc9698..9d52fdcf96927e184234973507f62579c7bdc3b2 100644
--- a/doc/html/sidechain/rotamer_lib.html
+++ b/doc/html/sidechain/rotamer_lib.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Rotamer Library &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Rotamer Library &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,10 +24,10 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="sidechain - Sidechain Modelling" href="index.html" />
-    <link rel="next" title="Rotamer Constructor" href="rotamer_constructor.html" />
-    <link rel="prev" title="Frame" href="frame.html" />
+    <link rel="next" title="Rotamer Graph" href="graph.html" />
+    <link rel="prev" title="Rotamer Constructor" href="rotamer_constructor.html" />
    
   <link rel="stylesheet" href="../_static/custom.css" type="text/css" />
   
@@ -115,7 +115,7 @@ for details.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>id</strong> (<a class="reference internal" href="rotamer_id.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identity of rotamer to be added</li>
+<li><strong>id</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identity of rotamer to be added</li>
 <li><strong>rotamer</strong> (<a class="reference internal" href="#promod3.sidechain.RotamerLibEntry" title="promod3.sidechain.RotamerLibEntry"><code class="xref py py-class docutils literal"><span class="pre">RotamerLibEntry</span></code></a>) &#8211; the rotamer to be added</li>
 </ul>
 </td>
@@ -144,7 +144,7 @@ special <em>id</em> requests.</p>
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>id</strong> (<a class="reference internal" href="rotamer_id.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identity of rotamer of interest</td>
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>id</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identity of rotamer of interest</td>
 </tr>
 <tr class="field-even field"><th class="field-name">Returns:</th><td class="field-body"><code class="xref py py-class docutils literal"><span class="pre">list</span></code> of <a class="reference internal" href="#promod3.sidechain.RotamerLibEntry" title="promod3.sidechain.RotamerLibEntry"><code class="xref py py-class docutils literal"><span class="pre">RotamerLibEntry</span></code></a> of nonzero
 probability sorted by their probability</td>
@@ -237,7 +237,7 @@ for details.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>id</strong> (<a class="reference internal" href="rotamer_id.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identity of rotamer to be added</li>
+<li><strong>id</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identity of rotamer to be added</li>
 <li><strong>r1</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Configuration of chi1</li>
 <li><strong>r2</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Configuration of chi2</li>
 <li><strong>r3</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Configuration of chi3</li>
@@ -284,7 +284,7 @@ special <em>id</em> requests.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>id</strong> (<a class="reference internal" href="rotamer_id.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identity of rotamer of interest</li>
+<li><strong>id</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identity of rotamer of interest</li>
 <li><strong>phi</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; Phi backbone dihedral angle in range [-pi,pi[</li>
 <li><strong>psi</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; Psi backbone dihedral angle in range [-pi,pi[</li>
 </ul>
@@ -308,11 +308,11 @@ found</p>
 <dd><p>Once all rotamers are added, the library can be made static to become readable
 and ready for io. Several things get checked during this process</p>
 <ul class="simple">
-<li>For every phi/psi bin combination of a particular <a class="reference internal" href="rotamer_id.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>,
+<li>For every phi/psi bin combination of a particular <a class="reference internal" href="rotamer.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>,
 the same number of rotamers must have been added</li>
 <li>All configuration combinations of the added rotamers in one phi/psi bin
-of a particular <a class="reference internal" href="rotamer_id.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a> must be unique</li>
-<li>The configuration combinations of a particular <a class="reference internal" href="rotamer_id.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a> must
+of a particular <a class="reference internal" href="rotamer.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a> must be unique</li>
+<li>The configuration combinations of a particular <a class="reference internal" href="rotamer.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a> must
 be consistent across all phi/psi bins</li>
 </ul>
 <table class="docutils field-list" frame="void" rules="none">
@@ -436,7 +436,7 @@ functionalities.</p>
 <dt id="promod3.sidechain.RotamerLibEntry.FromResidue">
 <em class="property">static </em><code class="descname">FromResidue</code><span class="sig-paren">(</span><em>res</em><span class="sig-paren">)</span><a class="headerlink" href="#promod3.sidechain.RotamerLibEntry.FromResidue" title="Permalink to this definition">¶</a></dt>
 <dd><p>Creates a <a class="reference internal" href="#promod3.sidechain.RotamerLibEntry" title="promod3.sidechain.RotamerLibEntry"><code class="xref py py-class docutils literal"><span class="pre">RotamerLibEntry</span></code></a> from the given <em>res</em>.
-The function tries to automatically identify the <a class="reference internal" href="rotamer_id.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a> based
+The function tries to automatically identify the <a class="reference internal" href="rotamer.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a> based
 on the residue name. The probability and standard deviations are set to 0.0,
 all not required chi angles with their corresponding  standard deviations to
 NaN.</p>
@@ -444,12 +444,12 @@ NaN.</p>
 <col class="field-name" />
 <col class="field-body" />
 <tbody valign="top">
-<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Source of dihedral angles</td>
+<tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Source of dihedral angles</td>
 </tr>
 <tr class="field-even field"><th class="field-name">Returns:</th><td class="field-body"><a class="reference internal" href="#promod3.sidechain.RotamerLibEntry" title="promod3.sidechain.RotamerLibEntry"><code class="xref py py-class docutils literal"><span class="pre">RotamerLibEntry</span></code></a></td>
 </tr>
 <tr class="field-odd field"><th class="field-name">Raises:</th><td class="field-body"><a class="reference external" href="https://docs.python.org/2.7/library/exceptions.html#exceptions.RuntimeError" title="(in Python v2.7)"><code class="xref py py-exc docutils literal"><span class="pre">RuntimeError</span></code></a> if residue name cannot be
-translated to <a class="reference internal" href="rotamer_id.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a> or when not all  required atoms
+translated to <a class="reference internal" href="rotamer.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a> or when not all  required atoms
 are present in <em>res</em>.</td>
 </tr>
 </tbody>
@@ -468,8 +468,8 @@ are NaN.</p>
 <col class="field-body" />
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
-<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.9.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Source of dihedral angles</li>
-<li><strong>id</strong> (<a class="reference internal" href="rotamer_id.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; The identity of the returned <a class="reference internal" href="#promod3.sidechain.RotamerLibEntry" title="promod3.sidechain.RotamerLibEntry"><code class="xref py py-class docutils literal"><span class="pre">RotamerLibEntry</span></code></a></li>
+<li><strong>res</strong> (<a class="reference external" href="https://www.openstructure.org/docs/mol/base/entity/#ost.mol.ResidueHandle" title="(in OpenStructure v1.10.0)"><code class="xref py py-class docutils literal"><span class="pre">ost.mol.ResidueHandle</span></code></a>) &#8211; Source of dihedral angles</li>
+<li><strong>id</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; The identity of the returned <a class="reference internal" href="#promod3.sidechain.RotamerLibEntry" title="promod3.sidechain.RotamerLibEntry"><code class="xref py py-class docutils literal"><span class="pre">RotamerLibEntry</span></code></a></li>
 </ul>
 </td>
 </tr>
@@ -528,7 +528,7 @@ the chi2 is checked for its actual value, but also for its flipped state.</p>
 <li><strong>other</strong> (<a class="reference internal" href="#promod3.sidechain.RotamerLibEntry" title="promod3.sidechain.RotamerLibEntry"><code class="xref py py-class docutils literal"><span class="pre">RotamerLibEntry</span></code></a>) &#8211; The Entry you want to compare with</li>
 <li><strong>thresh</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; The max difference between two dihedrals to be
 considered similar</li>
-<li><strong>id</strong> (<a class="reference internal" href="rotamer_id.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identity of the entries to be compared</li>
+<li><strong>id</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identity of the entries to be compared</li>
 </ul>
 </td>
 </tr>
@@ -586,7 +586,7 @@ for its actual value, but also for its flipped state.</p>
 (0 for chi1, 3 for chi4)</li>
 <li><strong>thresh</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#float" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">float</span></code></a>) &#8211; The max difference between two dihedrals to be
 considered similar</li>
-<li><strong>id</strong> (<a class="reference internal" href="rotamer_id.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identity of the entries to be compared</li>
+<li><strong>id</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identity of the entries to be compared</li>
 </ul>
 </td>
 </tr>
@@ -652,7 +652,7 @@ to also return NON_ROTAMERIC (e.g. chi2 for ASN).</p>
 <tbody valign="top">
 <tr class="field-odd field"><th class="field-name">Parameters:</th><td class="field-body"><ul class="first simple">
 <li><strong>entry</strong> (<a class="reference internal" href="#promod3.sidechain.RotamerLibEntry" title="promod3.sidechain.RotamerLibEntry"><code class="xref py py-class docutils literal"><span class="pre">RotamerLibEntry</span></code></a>) &#8211; Sidechain dihedral angle comes from here</li>
-<li><strong>id</strong> (<a class="reference internal" href="rotamer_id.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identity of rotamer</li>
+<li><strong>id</strong> (<a class="reference internal" href="rotamer.html#promod3.sidechain.RotamerID" title="promod3.sidechain.RotamerID"><code class="xref py py-class docutils literal"><span class="pre">RotamerID</span></code></a>) &#8211; Identity of rotamer</li>
 <li><strong>dihedral_idx</strong> (<a class="reference external" href="https://docs.python.org/2.7/library/functions.html#int" title="(in Python v2.7)"><code class="xref py py-class docutils literal"><span class="pre">int</span></code></a>) &#8211; Specifies angle (0 =&gt; chi1, ..., 3 =&gt; chi4)</li>
 </ul>
 </td>
@@ -691,8 +691,8 @@ valid and non rotameric, INVALID otherwise.</p>
   <li><a href="../index.html">Documentation overview</a><ul>
   <li><a href="../users.html">Documentation For Users</a><ul>
   <li><a href="index.html"><code class="docutils literal"><span class="pre">sidechain</span></code> - Sidechain Modelling</a><ul>
-      <li>Previous: <a href="frame.html" title="previous chapter">Frame</a></li>
-      <li>Next: <a href="rotamer_constructor.html" title="next chapter">Rotamer Constructor</a></li>
+      <li>Previous: <a href="rotamer_constructor.html" title="previous chapter">Rotamer Constructor</a></li>
+      <li>Next: <a href="graph.html" title="next chapter">Rotamer Graph</a></li>
   </ul></li>
   </ul></li>
   </ul></li>
@@ -720,7 +720,7 @@ valid and non rotameric, INVALID otherwise.</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/sidechain/subrotamer_optimizer.html b/doc/html/sidechain/subrotamer_optimizer.html
index 866eab60f7473aaddc35597e20ac9bcd3a9a08ab..4919ec5cd562a672a8c5dd640d7c6a18e2ad2140 100644
--- a/doc/html/sidechain/subrotamer_optimizer.html
+++ b/doc/html/sidechain/subrotamer_optimizer.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Subrotamer Optimization &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Subrotamer Optimization &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="../_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="../_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    '../',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="../_static/underscore.js"></script>
     <script type="text/javascript" src="../_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="../index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="../index.html" />
     <link rel="up" title="sidechain - Sidechain Modelling" href="index.html" />
     <link rel="next" title="scoring - Loop Scoring" href="../scoring/index.html" />
     <link rel="prev" title="Loading Rotamer Libraries" href="loading.html" />
@@ -126,7 +126,7 @@ internal <a class="reference internal" href="graph.html#promod3.sidechain.Rotame
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/user_contributions.html b/doc/html/user_contributions.html
index ee0f7551b808e93fd74f67b2d31d813b6809ce8c..df6d3a8e13a6c45f1862db56f6eaeda2cddfa4ce 100644
--- a/doc/html/user_contributions.html
+++ b/doc/html/user_contributions.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Contributing &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Contributing &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    './',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="_static/underscore.js"></script>
     <script type="text/javascript" src="_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="index.html" />
     <link rel="up" title="Documentation For Users" href="users.html" />
     <link rel="next" title="Documentation For Developers" href="developers.html" />
     <link rel="prev" title="SetCompoundsChemlib()" href="core/setcompoundschemlib.html" />
@@ -92,7 +92,7 @@ information on that matter in the developer section of the documentation
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>
diff --git a/doc/html/users.html b/doc/html/users.html
index e576c73592ed54aaec6a4e2db6c99ad4bbd635ea..dc1a92438ecea83e3e810dbb99cfc865e9503e94 100644
--- a/doc/html/users.html
+++ b/doc/html/users.html
@@ -6,7 +6,7 @@
   <head>
     <meta http-equiv="Content-Type" content="text/html; charset=utf-8" />
     
-    <title>Documentation For Users &mdash; ProMod3 2.0.0 documentation</title>
+    <title>Documentation For Users &mdash; ProMod3 2.1.0 documentation</title>
     
     <link rel="stylesheet" href="_static/alabaster.css" type="text/css" />
     <link rel="stylesheet" href="_static/pygments.css" type="text/css" />
@@ -14,7 +14,7 @@
     <script type="text/javascript">
       var DOCUMENTATION_OPTIONS = {
         URL_ROOT:    './',
-        VERSION:     '2.0.0',
+        VERSION:     '2.1.0',
         COLLAPSE_INDEX: false,
         FILE_SUFFIX: '.html',
         HAS_SOURCE:  true
@@ -24,7 +24,7 @@
     <script type="text/javascript" src="_static/underscore.js"></script>
     <script type="text/javascript" src="_static/doctools.js"></script>
     <script type="text/javascript" src="https://cdnjs.cloudflare.com/ajax/libs/mathjax/2.7.5/MathJax.js?config=TeX-MML-AM_CHTML"></script>
-    <link rel="top" title="ProMod3 2.0.0 documentation" href="index.html" />
+    <link rel="top" title="ProMod3 2.1.0 documentation" href="index.html" />
     <link rel="next" title="Getting Started" href="gettingstarted.html" />
     <link rel="prev" title="ProMod3" href="index.html" />
    
@@ -82,11 +82,10 @@ scripts using the functionality of this library.</p>
 </ul>
 </li>
 <li class="toctree-l1"><a class="reference internal" href="sidechain/index.html"><code class="docutils literal"><span class="pre">sidechain</span></code> - Sidechain Modelling</a><ul>
-<li class="toctree-l2"><a class="reference internal" href="sidechain/rotamer_id.html">RotamerID</a></li>
-<li class="toctree-l2"><a class="reference internal" href="sidechain/rotamer.html">Rotamers</a></li>
-<li class="toctree-l2"><a class="reference internal" href="sidechain/frame.html">Frame</a></li>
-<li class="toctree-l2"><a class="reference internal" href="sidechain/rotamer_lib.html">Rotamer Library</a></li>
+<li class="toctree-l2"><a class="reference internal" href="sidechain/rotamer.html">Representing Sidechains - Rotamers &amp; Co.</a></li>
+<li class="toctree-l2"><a class="reference internal" href="sidechain/frame.html">Frame - The Rigid Part</a></li>
 <li class="toctree-l2"><a class="reference internal" href="sidechain/rotamer_constructor.html">Rotamer Constructor</a></li>
+<li class="toctree-l2"><a class="reference internal" href="sidechain/rotamer_lib.html">Rotamer Library</a></li>
 <li class="toctree-l2"><a class="reference internal" href="sidechain/graph.html">Rotamer Graph</a></li>
 <li class="toctree-l2"><a class="reference internal" href="sidechain/disulfid.html">Disulfid Bond Evaluation</a></li>
 <li class="toctree-l2"><a class="reference internal" href="sidechain/loading.html">Loading Rotamer Libraries</a></li>
@@ -159,7 +158,7 @@ scripts using the functionality of this library.</p>
       <div class="clearer"></div>
     </div>
     <div class="footer">
-      &copy;2013-2019, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
+      &copy;2013-2020, SIB - Swiss Institute of Bioinformatics and Biozentrum - University of Basel.
       
       |
       Powered by <a href="http://sphinx-doc.org/">Sphinx 1.4.1</a>