Rosetta
|
Namespaces | |
carbohydrates | |
membrane | |
orbitals | |
parametric | |
residue_datacache | |
RotamerSetCacheableDataType | |
signals | |
symmetry | |
Classes | |
class | AbstractRotamerTrie |
class | Atom |
class | AtomGraphVertexData |
class | AtomGraphEdgeData |
class | Conformation |
A container of Residues and the kinematics to manage them. More... | |
struct | DefaultCubeHash |
uses default boost::hash combine to hash Cubes More... | |
struct | AddEdgeVisitor |
class | PointGraphVertexData |
class | PointGraphEdgeData |
class | PseudoBond |
class | PseudoBondCollection |
class | Residue |
Instance Residue class, used for placed residues and rotamers. More... | |
class | ResidueFactory |
a collection of functions making a single residue More... | |
class | ResidueKinWriter |
class | ConformationKinWriter |
class | ResidueMatcher |
class | WatsonCrickResidueMatcher |
class | ExactResidueMatcher |
class | RotamerSetBase |
class | UltraLightResidue |
Typedefs | |
typedef utility::pointer::shared_ptr< AbstractRotamerTrie > | AbstractRotamerTrieOP |
typedef utility::pointer::shared_ptr< AbstractRotamerTrie const > | AbstractRotamerTrieCOP |
typedef utility::vector1< Atom > | Atoms |
typedef utility::graph::UpperEdgeGraph< AtomGraphVertexData, AtomGraphEdgeData > | AtomGraph |
typedef utility::pointer::shared_ptr< AtomGraph > | AtomGraphOP |
typedef utility::pointer::shared_ptr< Conformation > | ConformationOP |
typedef utility::pointer::shared_ptr< Conformation const > | ConformationCOP |
typedef utility::pointer::weak_ptr< Conformation > | ConformationAP |
typedef utility::pointer::weak_ptr< Conformation const > | ConformationCAP |
typedef numeric::xyzTriple< core::Size > | CubeKey |
typedef numeric::xyzVector< core::Real > | PointPosition |
typedef utility::graph::UpperEdgeGraph< PointGraphVertexData, PointGraphEdgeData > | PointGraph |
typedef utility::pointer::shared_ptr< PointGraph > | PointGraphOP |
typedef utility::vector0< ppo_torsion_bin > | torsion_bin_string |
typedef utility::pointer::shared_ptr< PseudoBondCollection > | PseudoBondCollectionOP |
typedef utility::pointer::shared_ptr< PseudoBondCollection const > | PseudoBondCollectionCOP |
typedef utility::pointer::weak_ptr< Residue > | ResidueAP |
typedef utility::pointer::weak_ptr< Residue const > | ResidueCAP |
typedef utility::pointer::shared_ptr< Residue > | ResidueOP |
typedef utility::pointer::shared_ptr< Residue const > | ResidueCOP |
typedef utility::vector1< ResidueOP > | ResidueOPs |
typedef utility::vector1< ResidueCOP > | ResidueCOPs |
typedef utility::vector1< ResidueCAP > | ResidueCAPs |
typedef utility::pointer::shared_ptr< ResidueKinWriter > | ResidueKinWriterOP |
typedef utility::pointer::shared_ptr< ResidueKinWriter const > | ResidueKinWriterCOP |
typedef utility::pointer::shared_ptr< ConformationKinWriter > | ConformationKinWriterOP |
typedef utility::pointer::shared_ptr< ConformationKinWriter const > | ConformationKinWriterCOP |
typedef utility::pointer::shared_ptr< ResidueMatcher > | ResidueMatcherOP |
typedef utility::pointer::shared_ptr< ResidueMatcher const > | ResidueMatcherCOP |
typedef utility::pointer::shared_ptr< RotamerSetBase > | RotamerSetBaseOP |
typedef utility::pointer::shared_ptr< RotamerSetBase const > | RotamerSetBaseCOP |
typedef utility::pointer::shared_ptr< UltraLightResidue > | UltraLightResidueOP |
Enumerations | |
enum | Strategy { NAIVE , AUTOMATIC , OCTREE , THREEDGRID , STRIPEHASH } |
enum | ppo_torsion_bin { ppo_torbin_A = 1 , ppo_torbin_B , ppo_torbin_E , ppo_torbin_G , ppo_torbin_a , ppo_torbin_b , ppo_torbin_e , ppo_torbin_g , ppo_torbin_X , ppo_torbin_U , n_ppo_torsion_bins = ppo_torbin_U } |
Enumeration representing the different phi/psi/omega torsion bins. More... | |
Functions | |
std::ostream & | operator<< (std::ostream &out, Atom const &atom) |
void | atom_graph_from_conformation (Conformation const &conformation, AtomGraph &atom_graph) |
platform::Size | annotated_atom_graph_from_conformation (Conformation const &conformation, AtomGraph &pg, PointPosition const &additional_point) |
create a pointgraph which consists of 1 node for every atom, plus 1 additional node which will be added as the last node. The index of the additional node is returned More... | |
std::ostream & | operator<< (std::ostream &os, Conformation const &conf) |
template<class Vertex , class Edge > | |
void | find_neighbors_naive (utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > point_graph, core::Real neighbor_cutoff) |
template<class Vertex , class Edge > | |
void | find_neighbors_octree (utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > point_graph, core::Real neighbor_cutoff, Strategy strategy) |
Finds the residue neighbors efficiently using an octree-like spatial sort. More... | |
template<class Vertex , class Edge > | |
void | find_neighbors_3dgrid (utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > point_graph, core::Real neighbor_cutoff) |
Create a 3D grid of points. O(N^3). For "spherical" conformations, Theta(N). Speeds neighbor detection in abinitio by a factor of 2. Definition: Spherical = span of x,y and z all O(N**1/3). Note circularity. Adendum: if the 3D grid used a list of point indices instead of a vector, then this would be Theta(N) for spherical conformations; however, with a vector, this is O(NlgN). With the additional assumption that each cube contains O(1) points, then this implementation is O(N). Such an assumption is unneccessary in the list implementation. More... | |
template<class Vertex , class Edge > | |
void | find_neighbors_naive_restricted (utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > point_graph, core::Real neighbor_cutoff, utility::vector1< bool > const &residue_selection) |
template<class Vertex , class Edge > | |
void | find_neighbors_octree_restricted (utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > point_graph, core::Real neighbor_cutoff, utility::vector1< bool > const &residue_selection, Strategy strategy) |
Finds the residue neighbors efficiently using an octree-like spatial sort. More... | |
template<class Vertex , class Edge > | |
void | find_neighbors_3dgrid_restricted (utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > point_graph, core::Real neighbor_cutoff, utility::vector1< bool > const &residue_selection) |
Create a 3D grid of points. O(N^3). For "spherical" conformations, Theta(N). Speeds neighbor detection in abinitio by a factor of 2. Definition: Spherical = span of x,y and z all O(N**1/3). Note circularity. Adendum: if the 3D grid used a list of point indices instead of a vector, then this would be Theta(N) for spherical conformations; however, with a vector, this is O(NlgN). With the additional assumption that each cube contains O(1) points, then this implementation is O(N). Such an assumption is unneccessary in the list implementation. More... | |
template<class Vertex , class Edge > | |
core::Size | get_nearest_neighbor (utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > point_graph, core::Size node_id, core::Real neighbor_cutoff, Strategy strategy=AUTOMATIC) |
template<class Vertex , class Edge > | |
void | find_neighbors (utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > point_graph, core::Real neighbor_cutoff, Strategy strategy=AUTOMATIC) |
template<class Vertex , class Edge > | |
void | find_neighbors_stripe (utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > point_graph, core::Real neighbor_cutoff) |
template<class Vertex , class Edge > | |
void | find_neighbors_restricted (utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > point_graph, core::Real neighbor_cutoff, utility::vector1< bool > const &residue_selection, Strategy strategy=AUTOMATIC) |
template<class Vertex , class Edge > | |
void | find_neighbors_naive_surface (utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > point_graph, core::Real neighbor_cutoff, utility::vector1< std::pair< Size, Size > > const &non_surface_ranges, utility::vector1< bool > const &is_surface) |
void | residue_point_graph_from_conformation (Conformation const &conformation, PointGraph &pg) |
ppo_torsion_bin | get_torsion_bin (core::Real phi, core::Real psi, core::Real omega=180) |
determine the torsion bin for a given phi/psi/omega combination, assuming that omega is 180 if not specified More... | |
ppo_torsion_bin | remap_cis_omega_torsion_bins_to_trans (ppo_torsion_bin torbin) |
bool | cis_omega_torsion_bin (ppo_torsion_bin torbin) |
torsion_bin_string | map_string_to_torsion_bin_string (std::string const &torstring) |
convert a string of characters into a vector of the internally recognized ppo_torsion_bin enumeration More... | |
bool | char_valid_as_torsion_bin (char torbin) |
returns true if the input character represents a valid torsion bin More... | |
ppo_torsion_bin | map_char_to_torsion_bin (char torbin) |
returns the torsion bin that the input character represents More... | |
char | map_torsion_bin_to_char (ppo_torsion_bin torbin) |
convert a torsion bin to a character s.t. that character can be converted back to a torsion bin More... | |
static basic::Tracer | TR ("core.conformation.Residue") |
chemical::ResidueType const & | reference_from_restype_ptr (chemical::ResidueTypeCOP rsd_type) |
This function enforces the fact that ResidueTypes must be constructed with non-null-pointer ResidueTypeCOPs. More... | |
bool | missing_stubs_build (core::Size ii, Residue const &residue, utility::vector1< bool > const &missing, Vector &coordinate) |
void | improper_build (Residue const &residue, core::Size missing, core::Size parent, core::Size sibling1, core::Size sibling2, Vector &coordinate) |
Build. More... | |
std::ostream & | operator<< (std::ostream &os, Residue const &res) |
void | idealize_hydrogens (Residue &res, Conformation const &conf) |
void | set_chi_according_to_coordinates (conformation::Residue &rotamer) |
rotamer chi-update from coords useful for building rotamers from coordinates More... | |
void | insert_partial_atom_ids_for_mainchain_torsion (Residue const &res, Size const mainchain_torsion, std::set< id::PartialAtomID > &atoms) |
For a given mainchain torsion, report the partial atom IDs that define it, inserting these partial atom IDs into a std::set (to avoid redundancy perhaps with other torsions that also depend on the same atoms). More... | |
void | write_kinemage_header (std::ostream &ostr, Size const kin_number, std::string const &title, Vector const &ctr) |
void | print_node (std::ostream &out, int residue_num, int atom_num, core::Vector const &atom_xyz, core::chemical::ResidueType const &res, std::string const &extras="") |
TWO FUNCTIONS STOLEN FROM IAN: and slightly modified. More... | |
void | print_node (std::ostream &out, int residue_num, int atom_num, core::conformation::Residue const &res, std::string const &extras="") |
void | print_node (std::ostream &out, int residue_num, std::string atom_name, core::conformation::Residue const &res, std::string const &extras="") |
void | orient_residue_for_ideal_bond (Residue &moving_rsd, chemical::ResidueConnection const &moving_connection, Residue const &fixed_rsd, chemical::ResidueConnection const &fixed_connection, Conformation const &conformation, bool lookup_bond_length) |
void | insert_ideal_mainchain_bonds (Size const seqpos, Conformation &conformation) |
void | insert_ideal_bonds_at_polymer_junction (Size const seqpos, Conformation &conformation) |
Sets the two bond angles and the bond length across the junction, rebuilds dependent atoms (eg O,H) More... | |
void | idealize_position (Size const seqpos, Conformation &conformation) |
Idealize backbone and sidechain at seqpos. More... | |
bool | is_ideal_position ( Size const seqpos, Conformation const &conformation, Real theta_epsilon=0.005, Real D_epsilon=0.02) |
Return true if position contains an ideal geometry up to some epsilon. More... | |
void | copy_residue_coordinates_and_rebuild_missing_atoms (Residue const &source_rsd, Residue &target_rsd, Conformation const &conformation, bool const preserve_only_sidechain_dihedrals) |
Fills coords of target_rsd with coords from source_rsd of same atom_name, rebuilds others. More... | |
void | copy_residue_coordinates_and_rebuild_missing_atoms (Residue const &source_rsd, Residue &target_rsd, Conformation const &conformation) |
Fills coords of target_rsd with coords from source_rsd of same atom_name, rebuilds others. More... | |
void | copy_residue_coordinates_and_rebuild_missing_atoms (Residue const &source_rsd, Residue &target_rsd, utility::vector1< core::Size > const &mapping, Conformation const &conformation) |
Fills coords of target_rsd with coords from source_rsd using the provided mapping, rebuilds others The mapping is indexed by target_rsd atom index, giving source_rsd index or zero for not present. More... | |
std::ostream & | print_atom (id::AtomID const &id, Conformation const &conf, std::ostream &os) |
void | check_good_cutpoint_neighbour (core::conformation::Residue const &thisres, core::conformation::Residue const &other_res) |
Given two residues, check that they are compatible types to be connected via a cutpoint. More... | |
void | update_cutpoint_virtual_atoms_if_connected (core::conformation::Conformation &conf, core::Size const cutpoint_res, bool recurse) |
Given a conformation and a position that may or may not be CUTPOINT_UPPER or CUTPOINT_LOWER, determine whether this position has either of these variant types, and if it does, determine whether it's connected to anything. If it is, update the C-OVL1-OVL2 bond lengths and bond angle (for CUTPOINT_LOWER) or OVU1-N bond length (for CUTPOINT_UPPER) to match any potentially non-ideal geometry in the residue to which it's bonded. More... | |
void | show_atom_tree (kinematics::tree::Atom const &atom, Conformation const &conf, std::ostream &os) |
void | replace_conformation_residue_copying_existing_coordinates (conformation::Conformation &conformation, Size const seqpos, chemical::ResidueType const &new_rsd_type) |
void | add_variant_type_to_conformation_residue (conformation::Conformation &conformation, chemical::VariantType const variant_type, Size const seqpos) |
Construct a variant of an existing conformation residue. More... | |
void | remove_variant_type_from_conformation_residue (conformation::Conformation &conformation, chemical::VariantType const variant_type, Size const seqpos) |
Construct a non-variant of an existing conformation residue. More... | |
void | add_lower_terminus_type_to_conformation_residue (conformation::Conformation &conformation, Size const seqpos) |
void | remove_lower_terminus_type_from_conformation_residue (conformation::Conformation &conformation, Size const seqpos) |
void | add_upper_terminus_type_to_conformation_residue (conformation::Conformation &conformation, Size const seqpos) |
void | remove_upper_terminus_type_from_conformation_residue (conformation::Conformation &conformation, Size const seqpos) |
void | build_tree (kinematics::FoldTree const &fold_tree, conformation::ResidueCOPs const &residues, kinematics::AtomPointer2D &atom_pointer) |
void | build_jump_edge (kinematics::Edge const &edge, conformation::ResidueCOPs const &residues, kinematics::AtomPointer2D &atom_pointer) |
build a sub atom-tree for a jump edge and attach it to main atom-tree More... | |
void | build_polymer_edge (kinematics::Edge const &edge, conformation::ResidueCOPs const &residues, kinematics::AtomPointer2D &atom_pointer) |
build a sub atom-tree for a polymer edge and attach it to main atom-tree More... | |
void | build_chemical_edge (kinematics::Edge const &edge, conformation::ResidueCOPs const &residues, kinematics::AtomPointer2D &atom_pointer) |
build a sub atom-tree for a chemical edge and attach it to main atom-tree More... | |
int | get_root_atomno (conformation::Residue const &rsd, int const dir) |
get the root atom for building residue atom-tree given the folding direction "dir" More... | |
Size | get_root_residue_root_atomno (conformation::Residue const &rsd, kinematics::FoldTree const &fold_tree) |
void | build_residue_tree (conformation::ResidueCOPs const &residues, conformation::Residue const &rsd, kinematics::FoldTree const &fold_tree, kinematics::AtomPointer1D &atom_ptr) |
build_residue_tree function that uses the foldtree info More... | |
bool | check_good_neighbor (Size const &atom_index, utility::vector1< Size > const &cut_nbrs) |
Check if this atom neighbor has been black-listed ("CUT_BOND" in params file). More... | |
bool | chi_continuation (Size const atom1, Size const atom2, utility::vector1< utility::vector1< Size > > const &chi_atoms) |
is atom2 the last atom of our chi angle ? More... | |
bool | chi_interruption (Size const atom1, Size const atom2, utility::vector1< utility::vector1< Size > > const &chi_atoms, utility::vector1< bool > const &is_done) |
would we be breaking into a chi angle by adding atom2 to the tree now? More... | |
void | setup_links_simple (conformation::Residue const &rsd, kinematics::Links &links) |
simply fill the "links" by adding, for each atom, its bonded neighbors More... | |
void | setup_atom_links (int const atom1, kinematics::Links const &full_links, utility::vector1< bool > &is_done, utility::vector1< bool > const &is_mainchain, utility::vector1< bool > const &is_chi, utility::vector1< bool > const &is_hydrogen, utility::vector1< utility::vector1< Size > > const &chi_atoms, kinematics::Links &new_links) |
set correct order for how atoms are linked to each other. More... | |
void | setup_links (conformation::Residue const &rsd, int const root_atomno, kinematics::Links &links) |
given the root_atomno, set up rules for how other atoms are linked for this residue a wrapper function calling setup_atom_links recursively . More... | |
void | build_residue_tree (int const root_atomno, conformation::Residue const &rsd, kinematics::AtomPointer1D &atom_ptr, bool const root_is_jump_atom) |
set up a local atom-tree for a residue from the defined root atom. More... | |
void | get_residue_connections (conformation::Residue const &new_rsd, kinematics::FoldTree const &fold_tree, conformation::ResidueCOPs const &residues, id::BondID &new_rsd_in, utility::vector1< id::BondID > &new_rsd_out) |
void | replace_residue_in_atom_tree (conformation::Residue const &new_rsd, kinematics::FoldTree const &fold_tree, conformation::ResidueCOPs const &residues, kinematics::AtomTree &atom_tree) |
Helper function for conformation routines. More... | |
void | insert_residue_into_atom_tree (conformation::Residue const &new_rsd, kinematics::FoldTree const &fold_tree, conformation::ResidueCOPs const &residues, kinematics::AtomTree &atom_tree) |
Inserts/ appends new residue subtree into an existing atomtree. More... | |
int | get_anchor_atomno (conformation::Residue const &anchor_rsd, Size const seqpos, kinematics::FoldTree const &fold_tree) |
Get the atom-index of the atom to which the residue at position seqpos should be anchored. More... | |
int | get_anchor_atomno (conformation::Residue const &rsd, int const dir) |
get anchor atom to which the atom-tree of next residue in the edge is attached. More... | |
void | get_anchor_and_root_atoms (conformation::Residue const &anchor_rsd, conformation::Residue const &root_rsd, kinematics::Edge const &edge, Size &anchor_atomno, Size &root_atomno) |
Use this routine to deduce atom indices of connect atoms in the tree. More... | |
void | promote_sameresidue_child_of_jump_atom (kinematics::Edge const &edge, conformation::ResidueCOPs const &residues, kinematics::AtomTree &atom_tree) |
Moves the first same-residue child of the jump atom corresponding to edge into first place in the child list. More... | |
void | promote_sameresidue_child_of_jump_atom (kinematics::Edge const &edge, conformation::ResidueCOPs const &residues, kinematics::AtomPointer2D const &atom_pointer) |
Moves the first same-residue child of the jump atom corresponding to edge into first place in the child list. More... | |
void | get_chemical_root_and_anchor_atomnos (conformation::Residue const &rsd_anchor, conformation::Residue const &rsd_root, Size &anchor_atom_no, Size &root_atom_no) |
void | setup_corresponding_atoms (id::AtomID_Map< id::AtomID > &atom_map, conformation::Residue const &rsd1, conformation::Residue const &rsd2) |
set up a map to match mainchain atoms from residue1 to residue2 More... | |
bool | change_cys_state (Size const index, std::string const &cys_type_name3, Conformation &conf) |
Switch the disulfide state of a disulfide-forming residue (e.g. CYS->CYD or CYD->CYS or DCYD->DCYS or DCYS->DCYD or whatnot). More... | |
id::NamedAtomID | atom_id_to_named_atom_id (id::AtomID const &atom_id, conformation::Residue const &rsd) |
id::AtomID | named_atom_id_to_atom_id (id::NamedAtomID const &named_atom_id, conformation::Residue const &rsd) |
id::NamedStubID | stub_id_to_named_stub_id (id::StubID const &stub_id, conformation::Residue const &rsd) |
id::StubID | named_stub_id_to_stub_id (id::NamedStubID const &named_stub_id, conformation::Residue const &rsd) |
core::Size | get_disulf_partner (core::conformation::Conformation const &conformation, core::Size const res_index) |
Gets a disulfide-forming residue's partner in the disulfide bond. More... | |
void | break_all_disulfides (core::conformation::Conformation &conformation) |
Break all the disulfides in the conformation. More... | |
void | break_disulfide (core::conformation::Conformation &conformation, core::Size const res1, core::Size const res2) |
Breaks a disulfide bond. More... | |
void | form_disulfide (Conformation &conformation, Size lower_res, Size upper_res, bool const preserve_d_residues, bool const force_d_residues) |
Introduce cysteines at the specified location and define a disulfide bond between them. More... | |
void | form_disulfide_helper (core::conformation::Conformation &conformation, core::Size const res_index, core::chemical::ResidueTypeSetCOP restype_set, bool const preserve_d_residues, bool const force_d_residues) |
Helper function for the form_disulfide function. More... | |
bool | upper_is_symm_equivalent_of_lower (core::conformation::Conformation const &conformation, core::Size const lower_res, core::Size const upper_res) |
Another helper function for the form_disulfide function. More... | |
bool | is_disulfide_bond (conformation::Conformation const &conformation, Size residueA_pos, Size residueB_pos) |
Find whether there is a disulfide defined between two residues. More... | |
void | disulfide_bonds (conformation::Conformation const &conformation, utility::vector1< std::pair< Size, Size > > &disulfides) |
Generate a list of all disulfide bonds in the conformation. More... | |
core::id::TorsionID | find_bond_torsion_with_nearest_orientation (core::conformation::Conformation const &conf, utility::vector1< core::id::TorsionID > const &torsions, core::id::TorsionID const &query_torsion) |
Return a nearby TorsionID with approximately the same 3D orientation, selected from the give TorsionIDs. More... | |
core::uint | position_of_atom_on_ring (Residue const &residue, core::uint query_atom, utility::vector1< core::uint > const &ring_atoms) |
What is the attachment position of the query atom on the given ring? More... | |
chemical::rings::AxEqDesignation | is_atom_axial_or_equatorial_to_ring (Residue const &residue, core::uint query_atom, utility::vector1< core::uint > const &ring_atoms) |
Is the query atom in this residue axial or equatorial to the given ring or neither? More... | |
chemical::rings::AxEqDesignation | is_atom_axial_or_equatorial (Residue const &residue, core::uint query_atom) |
Is the query atom in this residue axial or equatorial or neither? More... | |
chemical::ResidueTypeCOP | virtual_type_for_conf (core::conformation::Conformation const &conformation) |
Return the appropritate ResidueType for the virtual residue for the "mode" (fullatom, centroid ...) the conformation is in. More... | |
chemical::ResidueTypeCOP | inv_virtual_type_for_conf (core::conformation::Conformation const &conformation) |
Return the appropritate ResidueType for the inverse virtual residue for the "mode" (fullatom, centroid ...) the conformation is in. More... | |
core::Vector | all_atom_center (core::conformation::Residue const &residue) |
Get the center of the Residue. More... | |
bool | get_second_atom_from_connection (core::Size &resno, core::Size &atomno, Residue const &rsd, Conformation const &conformation, core::Size const &conn_id) |
Given a residue and a connection id, get the heavyatom adjacent to the atom that makes that connection. More... | |
conformation::ResidueOP | get_residue_from_name (std::string const &name, std::string const &residue_type_set="fa_standard") |
Returns a new residue based on a name. More... | |
conformation::ResidueOP | get_residue_from_name1 (char name1, bool is_lower_terminus=false, bool is_upper_terminus=false, bool d_aa=false, std::string const &residue_type_set="fa_standard") |
Returns a new residue based on a name1. More... | |
core::kinematics::Stub | get_stub_from_residue (core::conformation::Residue const &res) |
Get stub from orient_atoms. More... | |
core::kinematics::RT | get_rt_from_residue_pair (core::conformation::Residue const &res1, core::conformation::Residue const &res2) |
Get stub mapping that maps residue 1 to residue 2. More... | |
void | disulfide_bonds (core::conformation::Conformation const &conformation, utility::vector1< std::pair< core::Size, core::Size > > &disulfides) |
Generate a list of all disulfide bonds in the conformation. More... | |
typedef utility::pointer::shared_ptr< AbstractRotamerTrie const > core::conformation::AbstractRotamerTrieCOP |
typedef utility::pointer::shared_ptr< AbstractRotamerTrie > core::conformation::AbstractRotamerTrieOP |
typedef utility::graph::UpperEdgeGraph<AtomGraphVertexData, AtomGraphEdgeData> core::conformation::AtomGraph |
typedef utility::pointer::shared_ptr<AtomGraph > core::conformation::AtomGraphOP |
typedef utility::vector1< Atom > core::conformation::Atoms |
typedef utility::pointer::weak_ptr< Conformation > core::conformation::ConformationAP |
typedef utility::pointer::weak_ptr< Conformation const > core::conformation::ConformationCAP |
typedef utility::pointer::shared_ptr< Conformation const > core::conformation::ConformationCOP |
typedef utility::pointer::shared_ptr< ConformationKinWriter const > core::conformation::ConformationKinWriterCOP |
typedef utility::pointer::shared_ptr< ConformationKinWriter > core::conformation::ConformationKinWriterOP |
typedef utility::pointer::shared_ptr< Conformation > core::conformation::ConformationOP |
typedef numeric::xyzTriple< core::Size > core::conformation::CubeKey |
typedef utility::graph::UpperEdgeGraph< PointGraphVertexData, PointGraphEdgeData > core::conformation::PointGraph |
typedef utility::pointer::shared_ptr< PointGraph > core::conformation::PointGraphOP |
typedef numeric::xyzVector< core::Real > core::conformation::PointPosition |
typedef utility::pointer::shared_ptr< PseudoBondCollection const > core::conformation::PseudoBondCollectionCOP |
typedef utility::pointer::shared_ptr< PseudoBondCollection > core::conformation::PseudoBondCollectionOP |
typedef utility::pointer::weak_ptr< Residue > core::conformation::ResidueAP |
typedef utility::pointer::weak_ptr< Residue const > core::conformation::ResidueCAP |
typedef utility::vector1< ResidueCAP > core::conformation::ResidueCAPs |
typedef utility::pointer::shared_ptr< Residue const > core::conformation::ResidueCOP |
typedef utility::vector1< ResidueCOP > core::conformation::ResidueCOPs |
typedef utility::pointer::shared_ptr< ResidueKinWriter const > core::conformation::ResidueKinWriterCOP |
typedef utility::pointer::shared_ptr< ResidueKinWriter > core::conformation::ResidueKinWriterOP |
typedef utility::pointer::shared_ptr< ResidueMatcher const > core::conformation::ResidueMatcherCOP |
typedef utility::pointer::shared_ptr< ResidueMatcher > core::conformation::ResidueMatcherOP |
typedef utility::pointer::shared_ptr< Residue > core::conformation::ResidueOP |
typedef utility::vector1< ResidueOP > core::conformation::ResidueOPs |
typedef utility::pointer::shared_ptr< RotamerSetBase const > core::conformation::RotamerSetBaseCOP |
typedef utility::pointer::shared_ptr< RotamerSetBase > core::conformation::RotamerSetBaseOP |
typedef utility::vector0< ppo_torsion_bin > core::conformation::torsion_bin_string |
typedef utility::pointer::shared_ptr< UltraLightResidue > core::conformation::UltraLightResidueOP |
void core::conformation::add_lower_terminus_type_to_conformation_residue | ( | conformation::Conformation & | conformation, |
Size const | seqpos | ||
) |
void core::conformation::add_upper_terminus_type_to_conformation_residue | ( | conformation::Conformation & | conformation, |
Size const | seqpos | ||
) |
void core::conformation::add_variant_type_to_conformation_residue | ( | conformation::Conformation & | conformation, |
chemical::VariantType const | variant_type, | ||
Size const | seqpos | ||
) |
Construct a variant of an existing conformation residue.
E.g., make a terminus variant, and replace the original in pose.
References core::chemical::ResidueTypeBase::mode(), replace_conformation_residue_copying_existing_coordinates(), core::conformation::Conformation::residue(), core::conformation::Conformation::residue_type_set_for_conf(), and core::conformation::Residue::type().
Referenced by add_lower_terminus_type_to_conformation_residue(), and add_upper_terminus_type_to_conformation_residue().
core::Vector core::conformation::all_atom_center | ( | core::conformation::Residue const & | residue | ) |
Get the center of the Residue.
This computes an equally-weighted, all-atom (including virtuals and hydrogens) center
References core::pose::center_of_mass(), protocols::splice::coords(), core::conformation::Residue::natoms(), and core::conformation::Residue::xyz().
Referenced by protocols::ligand_docking::get_ligand_travel_ensemble_best().
platform::Size core::conformation::annotated_atom_graph_from_conformation | ( | Conformation const & | conformation, |
AtomGraph & | atom_graph, | ||
PointPosition const & | additional_point | ||
) |
create a pointgraph which consists of 1 node for every atom, plus 1 additional node which will be added as the last node. The index of the additional node is returned
References core::conformation::Residue::atom_name(), core::conformation::Residue::natoms(), core::chemical::ResidueType::natoms(), core::pose::num_atoms(), core::conformation::Conformation::residue(), core::conformation::Conformation::residue_type(), core::conformation::Conformation::size(), and core::conformation::Residue::xyz().
void core::conformation::atom_graph_from_conformation | ( | Conformation const & | conformation, |
AtomGraph & | atom_graph | ||
) |
References core::conformation::Residue::atom_name(), core::conformation::Residue::atom_type(), core::chemical::AtomType::lj_radius(), core::conformation::Residue::natoms(), core::chemical::ResidueType::natoms(), core::pose::num_atoms(), core::conformation::Conformation::residue(), core::conformation::Conformation::residue_type(), core::conformation::Conformation::size(), and core::conformation::Residue::xyz().
id::NamedAtomID core::conformation::atom_id_to_named_atom_id | ( | id::AtomID const & | atom_id, |
conformation::Residue const & | rsd | ||
) |
References core::conformation::Residue::atom_name(), core::id::AtomID::atomno(), core::conformation::Residue::atoms(), core::id::AtomID::rsd(), and TR().
Referenced by core::conformation::Conformation::append_residue_by_bond(), core::conformation::Conformation::append_residues(), protocols::constraints_additional::COMCoordinateConstraint::remapped_clone(), core::scoring::constraints::AmbiguousNMRDistanceConstraint::remapped_clone(), core::scoring::constraints::AngleConstraint::remapped_clone(), core::scoring::constraints::AtomPairConstraint::remapped_clone(), core::scoring::constraints::AtomToAxisConstraint::remapped_clone(), core::scoring::constraints::CoordinateConstraint::remapped_clone(), core::scoring::constraints::AngleConstraint::show_def(), core::scoring::constraints::AtomPairConstraint::show_def(), core::scoring::constraints::AtomToAxisConstraint::show_def(), core::scoring::constraints::DihedralConstraint::show_def(), and stub_id_to_named_stub_id().
void core::conformation::break_all_disulfides | ( | core::conformation::Conformation & | conformation | ) |
Break all the disulfides in the conformation.
References break_disulfide(), disulfide_bonds(), and core::scoring::pair.
void core::conformation::break_disulfide | ( | core::conformation::Conformation & | conformation, |
core::Size const | res1, | ||
core::Size const | res2 | ||
) |
Breaks a disulfide bond.
References change_cys_state(), get_disulf_partner(), core::chemical::ResidueType::is_disulfide_bonded(), core::conformation::Residue::name3(), core::conformation::Conformation::residue(), core::conformation::Conformation::size(), and core::conformation::Residue::type().
Referenced by protocols::calc_taskop_movers::ForceDisulfidesMover::apply(), protocols::simple_moves::MutateResidue::break_a_disulfide(), break_all_disulfides(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::break_disulfides(), protocols::minimization_packing::DisulfideOptimizationMover::break_repack_reform(), protocols::denovo_design::construct_poly_ala_pose(), and protocols::denovo_design::DisulfidizeMover::mutate_disulfides_to_ala().
void core::conformation::build_chemical_edge | ( | kinematics::Edge const & | edge, |
conformation::ResidueCOPs const & | residues, | ||
kinematics::AtomPointer2D & | atom_pointer | ||
) |
build a sub atom-tree for a chemical edge and attach it to main atom-tree
assumes that the start residue of edge has already been built. Traverse the chemical edge residue by residue and after building sub atom-tree for this residue, attaches the edge's subtree to the anchor_atom in the previous residue.
References build_residue_tree(), get_anchor_and_root_atoms(), core::kinematics::Edge::start(), and core::kinematics::Edge::stop().
Referenced by build_tree().
void core::conformation::build_jump_edge | ( | kinematics::Edge const & | edge, |
conformation::ResidueCOPs const & | residues, | ||
kinematics::AtomPointer2D & | atom_pointer | ||
) |
build a sub atom-tree for a jump edge and attach it to main atom-tree
root_atomno is the root for the sub atom-tree of this edge. anchor_atomno is the entry point of this sub atom-tree into the main atom-tree.
References build_residue_tree(), get_anchor_and_root_atoms(), core::kinematics::Edge::is_jump(), core::kinematics::Edge::start(), and core::kinematics::Edge::stop().
Referenced by build_tree().
void core::conformation::build_polymer_edge | ( | kinematics::Edge const & | edge, |
conformation::ResidueCOPs const & | residues, | ||
kinematics::AtomPointer2D & | atom_pointer | ||
) |
build a sub atom-tree for a polymer edge and attach it to main atom-tree
assumes that the start residue of edge has already been built. Traverse the polymer edge residue by residue and after building sub atom-tree for this residue, attaches the edge's subtree to the anchor_atom in the previous residue.
References build_residue_tree(), get_anchor_and_root_atoms(), core::kinematics::Edge::polymer_direction(), core::kinematics::Edge::start(), protocols::loops::start, core::kinematics::Edge::stop(), and protocols::loops::stop.
Referenced by build_tree().
void core::conformation::build_residue_tree | ( | conformation::ResidueCOPs const & | residues, |
conformation::Residue const & | rsd, | ||
kinematics::FoldTree const & | fold_tree, | ||
kinematics::AtomPointer1D & | atom_ptr | ||
) |
build_residue_tree function that uses the foldtree info
A wrapper function to build an atom-tree for a residue. Uses information from the foldtree to find the proper root atom if it is not defined, and determine the direction in which to build the residue. The goal of this function is to allow the Conformation to rebuild parts of the AtomTree in a way that is compatible with what would be built if we erased the entire atomtree and rebuilt it using the foldtree. Also used to build the atomtree for the root residue when we are building the atomtree from scratch.
also used in build_tree to build the residue tree for the root residue
References core::conformation::Residue::atom_index(), core::kinematics::dir_jump, core::kinematics::Edge::downstream_atom(), get_anchor_and_root_atoms(), core::kinematics::FoldTree::get_residue_edge(), get_root_atomno(), get_root_residue_root_atomno(), core::kinematics::Edge::has_atom_info(), core::kinematics::Edge::is_jump(), core::kinematics::Edge::is_peptide(), core::kinematics::Edge::polymer_direction(), core::kinematics::FoldTree::root(), core::conformation::Residue::seqpos(), core::kinematics::Edge::start(), and core::kinematics::Edge::stop().
Referenced by build_chemical_edge(), build_jump_edge(), build_polymer_edge(), build_tree(), core::conformation::Conformation::fill_missing_atoms(), replace_residue_in_atom_tree(), and core::pack::scmin::ResidueAtomTreeCollection::ResidueAtomTreeCollection().
void core::conformation::build_residue_tree | ( | int const | root_atomno, |
conformation::Residue const & | rsd, | ||
kinematics::AtomPointer1D & | atom_ptr, | ||
bool const | root_is_jump_atom | ||
) |
set up a local atom-tree for a residue from the defined root atom.
build the tree of atoms for this residue, anchored at root_atomno
References core::kinematics::add_atom(), core::conformation::Residue::atom(), core::conformation::Residue::natoms(), core::conformation::Residue::seqpos(), setup_links(), and core::conformation::Atom::xyz().
void core::conformation::build_tree | ( | kinematics::FoldTree const & | fold_tree, |
conformation::ResidueCOPs const & | residues, | ||
kinematics::AtomPointer2D & | atom_pointer | ||
) |
Build an atom-tree from a fold-tree and a set of residues atoms in the tree are allocated with new (on the heap) and held in owning pointers in atom_pointer
References build_chemical_edge(), build_jump_edge(), build_polymer_edge(), build_residue_tree(), core::kinematics::Edge::CHEMICAL, core::id::AtomID_Map< T >::clear(), core::kinematics::Edge::PEPTIDE, promote_sameresidue_child_of_jump_atom(), core::id::AtomID_Map< T >::resize(), core::kinematics::FoldTree::root(), and TR().
Referenced by core::conformation::Conformation::setup_atom_tree().
bool core::conformation::change_cys_state | ( | Size const | index, |
std::string const & | cys_type_name3, | ||
Conformation & | conf | ||
) |
Switch the disulfide state of a disulfide-forming residue (e.g. CYS->CYD or CYD->CYS or DCYD->DCYS or DCYS->DCYD or whatnot).
[in] | index | Position of the residue to replace. |
[in] | cys_type_name3 | The 3-letter name of the cys type to use: e.g. CYS or CYD. DEPRECATED and kept only for backward-compatibility. |
[in,out] | conf | The conformation to modify |
Substitutes a residue with the given cys type, keeping as many of the existing atom positions as possible. If the original residue has a disulfide variant it will be removed, otherwise a disulfide variant will be added. Should work with any ResidueTypeSet that has the proper disulfide variants. If the replacement fails for any reason a warning will be printed.
[in] | index | Position of the residue to replace. |
[in] | cys_type_name3 | The 3-letter name of the cys type to use: either CYS or CYD. DEPRECATED and kept only for backward-compatibility. |
[in,out] | conf | The conformation to modify |
References copy_residue_coordinates_and_rebuild_missing_atoms(), core::conformation::ResidueFactory::create_residue(), core::chemical::DISULFIDE, core::chemical::ResidueProperties::get_list_of_variants(), core::chemical::ResidueTypeBase::has_variant_type(), core::chemical::ResidueType::is_disulfide_bonded(), core::chemical::ResidueType::is_sidechain_thiol(), core::chemical::ResidueTypeBase::mode(), core::chemical::ResidueTypeBase::name3(), core::chemical::ResidueTypeBase::properties(), core::conformation::Conformation::replace_residue(), core::conformation::Conformation::residue(), core::conformation::Conformation::residue_type(), core::conformation::Conformation::residue_type_set_for_conf(), and TR().
Referenced by core::conformation::Conformation::add_disulfide_bond(), protocols::hybridization::HybridizeProtocol::apply(), protocols::hybridization::CartesianSampler::apply_frame(), break_disulfide(), protocols::peptide_deriver::PeptideDeriverFilter::build_receptor_peptide_pose(), protocols::features::ProteinResidueConformationFeatures::check_num_requested_atoms(), core::conformation::Conformation::detect_disulfides(), core::conformation::symmetry::SymmetricConformation::detect_disulfides(), form_disulfide(), and protocols::simple_ddg::SSElementBisectddGFilter::get_ddg_bisect_score().
bool core::conformation::char_valid_as_torsion_bin | ( | char | torbin | ) |
returns true if the input character represents a valid torsion bin
Referenced by map_string_to_torsion_bin_string().
void core::conformation::check_good_cutpoint_neighbour | ( | core::conformation::Residue const & | thisres, |
core::conformation::Residue const & | other_res | ||
) |
Given two residues, check that they are compatible types to be connected via a cutpoint.
References core::chemical::ResidueTypeBase::has_property(), core::chemical::ResidueType::is_alpha_aa(), core::chemical::ResidueType::is_aramid(), core::chemical::ResidueType::is_beta_aa(), core::chemical::ResidueType::is_carbohydrate(), core::chemical::ResidueType::is_gamma_aa(), core::chemical::ResidueType::is_NA(), core::chemical::ResidueType::is_oligourea(), core::chemical::ResidueTypeBase::is_peptoid(), core::chemical::ResidueTypeBase::is_polymer(), core::chemical::ResidueTypeBase::is_RNA(), core::chemical::ResidueType::is_sri(), core::chemical::TNA, core::chemical::TRIAZOLE_LINKER, and core::conformation::Residue::type().
Referenced by update_cutpoint_virtual_atoms_if_connected().
bool core::conformation::check_good_neighbor | ( | Size const & | atom_index, |
utility::vector1< Size > const & | cut_nbrs | ||
) |
Check if this atom neighbor has been black-listed ("CUT_BOND" in params file).
Referenced by setup_links_simple().
|
inline |
is atom2 the last atom of our chi angle ?
Referenced by setup_atom_links().
|
inline |
would we be breaking into a chi angle by adding atom2 to the tree now?
Referenced by setup_atom_links().
bool core::conformation::cis_omega_torsion_bin | ( | ppo_torsion_bin | torbin | ) |
References ppo_torbin_a, ppo_torbin_b, ppo_torbin_e, and ppo_torbin_g.
void core::conformation::copy_residue_coordinates_and_rebuild_missing_atoms | ( | Residue const & | source_rsd, |
Residue & | target_rsd, | ||
Conformation const & | conformation | ||
) |
Fills coords of target_rsd with coords from source_rsd of same atom_name, rebuilds others.
For building variant residues, eg
References core::conformation::Residue::atom(), core::conformation::Residue::atom_name(), core::conformation::Residue::chain(), core::conformation::Residue::fill_missing_atoms(), core::conformation::Residue::has(), core::conformation::Residue::name(), core::conformation::Residue::natoms(), core::conformation::Residue::seqpos(), TR(), and core::conformation::Atom::xyz().
void core::conformation::copy_residue_coordinates_and_rebuild_missing_atoms | ( | Residue const & | source_rsd, |
Residue & | target_rsd, | ||
Conformation const & | conformation, | ||
bool const | preserve_only_sidechain_dihedrals | ||
) |
Fills coords of target_rsd with coords from source_rsd of same atom_name, rebuilds others.
If preserve_only_sidechain_dihedrals is true, then this function only copies mainchain coordinates, and rebuilds all sidechain coordinates from scratch, setting side-chain dihedrals based on the source residue. Otherwise, if false, it copies all the atoms that it can from the source residue, then rebuilds the rest.
References core::conformation::Residue::atom(), core::conformation::Residue::atom_name(), core::conformation::Residue::chain(), core::conformation::Residue::chi(), core::conformation::Residue::fill_missing_atoms(), core::chemical::ResidueType::first_sidechain_atom(), core::conformation::Residue::has(), protocols::mean_field::min(), core::conformation::Residue::n_mainchain_atoms(), core::conformation::Residue::name(), core::conformation::Residue::natoms(), core::chemical::ResidueType::natoms(), core::conformation::Residue::nchi(), core::conformation::Residue::seqpos(), core::conformation::Residue::set_chi(), TR(), core::conformation::Residue::type(), and core::conformation::Atom::xyz().
Referenced by protocols::environment::EnvClaimBroker::add_chainbreak_variants(), core::pose::add_variant_type_to_residue(), protocols::simple_moves::ReportEffectivePKA::apply(), protocols::indexed_structure_store::apply_residue_entries_to_pose(), change_cys_state(), protocols::simple_filters::SidechainRmsdFilter::compute(), form_disulfide_helper(), protocols::residue_optimization::MetapatchEnumeration::generate_derived_types(), protocols::simple_moves::MutateResidue::make_mutation(), protocols::rotamer_recovery::RRComparerAutomorphicRMSD::measure_rotamer_recovery(), core::pose::remove_variant_type_from_residue(), replace_conformation_residue_copying_existing_coordinates(), core::pose::replace_pose_residue_copying_existing_coordinates(), and core::util::switch_to_residue_type_set().
void core::conformation::copy_residue_coordinates_and_rebuild_missing_atoms | ( | Residue const & | source_rsd, |
Residue & | target_rsd, | ||
utility::vector1< core::Size > const & | mapping, | ||
Conformation const & | conformation | ||
) |
Fills coords of target_rsd with coords from source_rsd using the provided mapping, rebuilds others The mapping is indexed by target_rsd atom index, giving source_rsd index or zero for not present.
References core::conformation::Residue::atom(), core::conformation::Residue::atom_name(), core::conformation::Residue::chain(), core::conformation::Residue::fill_missing_atoms(), core::conformation::Residue::name(), core::conformation::Residue::natoms(), core::conformation::Residue::seqpos(), TR(), and core::conformation::Atom::xyz().
void core::conformation::disulfide_bonds | ( | conformation::Conformation const & | conformation, |
utility::vector1< std::pair< Size, Size > > & | disulfides | ||
) |
Generate a list of all disulfide bonds in the conformation.
References core::conformation::Residue::atom_index(), core::chemical::ResidueConnection::atomno(), core::conformation::Residue::connect_map(), core::chemical::DISULFIDE, core::chemical::ResidueTypeBase::get_disulfide_atom_name(), core::conformation::Residue::has_variant_type(), core::chemical::ResidueType::is_disulfide_bonded(), core::chemical::ResidueType::n_possible_residue_connections(), core::chemical::ResConnID::resid(), core::conformation::Conformation::residue(), core::chemical::ResidueType::residue_connection(), core::conformation::Conformation::size(), TR(), and core::conformation::Residue::type().
Referenced by protocols::calc_taskop_movers::ForceDisulfidesMover::apply(), protocols::stepwise::legacy::modeler::protein::StepWiseProteinMinimizer::apply(), break_all_disulfides(), core::scoring::disulfides::DisulfideMatchingPotential::compute_matching_energy(), protocols::fold_from_loops::utils::Nub::get_nub_pieces(), protocols::grafting::insert_pose_into_pose(), protocols::fold_from_loops::NubInitioMover::make_unfolded_pose(), core::util::rebuild_fa_disulfides(), and protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::store_disulfides().
void core::conformation::disulfide_bonds | ( | core::conformation::Conformation const & | conformation, |
utility::vector1< std::pair< core::Size, core::Size > > & | disulfides | ||
) |
Generate a list of all disulfide bonds in the conformation.
References core::conformation::Residue::atom_index(), core::chemical::ResidueConnection::atomno(), core::conformation::Residue::connect_map(), core::chemical::DISULFIDE, core::chemical::ResidueTypeBase::get_disulfide_atom_name(), core::conformation::Residue::has_variant_type(), core::chemical::ResidueType::is_disulfide_bonded(), core::chemical::ResidueType::n_possible_residue_connections(), core::chemical::ResConnID::resid(), core::conformation::Conformation::residue(), core::chemical::ResidueType::residue_connection(), core::conformation::Conformation::size(), TR(), and core::conformation::Residue::type().
Referenced by protocols::calc_taskop_movers::ForceDisulfidesMover::apply(), protocols::stepwise::legacy::modeler::protein::StepWiseProteinMinimizer::apply(), break_all_disulfides(), core::scoring::disulfides::DisulfideMatchingPotential::compute_matching_energy(), protocols::fold_from_loops::utils::Nub::get_nub_pieces(), protocols::grafting::insert_pose_into_pose(), protocols::fold_from_loops::NubInitioMover::make_unfolded_pose(), core::util::rebuild_fa_disulfides(), and protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::store_disulfides().
core::id::TorsionID core::conformation::find_bond_torsion_with_nearest_orientation | ( | core::conformation::Conformation const & | conf, |
utility::vector1< core::id::TorsionID > const & | torsions, | ||
core::id::TorsionID const & | query_torsion | ||
) |
Return a nearby TorsionID with approximately the same 3D orientation, selected from the give TorsionIDs.
The downstream effects of a torsion move can be minimized by twisting a nearby torsion in the opposite direction with the same magnitude, resulting in a net "shearing" motion, if and only if the orientation of the two bonds are similar, that is, if the two bonds are approximately parallel. This function is useful for finding such a torsion from a supplied list of torsions.
<conf> | the Conformation |
<torsions> | a list of torsions to search |
<query_torsion> | the TorsionID to compare |
References core::conformation::Conformation::bond_orientation().
Referenced by protocols::simple_moves::ShearMover::setup_list().
void core::conformation::find_neighbors | ( | utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > | point_graph, |
core::Real | neighbor_cutoff, | ||
Strategy | strategy = AUTOMATIC |
||
) |
References AUTOMATIC, find_neighbors_3dgrid(), find_neighbors_naive(), find_neighbors_octree(), find_neighbors_stripe(), NAIVE, STRIPEHASH, and THREEDGRID.
Referenced by core::select::residue_selector::NumNeighborsSelector::apply(), protocols::forge::remodel::RemodelDesignMover::apply(), protocols::pmut_scan::PointMutScanDriver::calculate_neighbor_table(), core::conformation::Conformation::detect_disulfides(), and core::conformation::symmetry::SymmetricConformation::detect_disulfides().
void core::conformation::find_neighbors_3dgrid | ( | utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > | point_graph, |
core::Real | neighbor_cutoff | ||
) |
Create a 3D grid of points. O(N^3). For "spherical" conformations, Theta(N). Speeds neighbor detection in abinitio by a factor of 2. Definition: Spherical = span of x,y and z all O(N**1/3). Note circularity. Adendum: if the 3D grid used a list of point indices instead of a vector, then this would be Theta(N) for spherical conformations; however, with a vector, this is O(NlgN). With the additional assumption that each cube contains O(1) points, then this implementation is O(N). Such an assumption is unneccessary in the list implementation.
Shameless code duplication below based on Stuart's stl-map-based-neighbor-detection code. Note that the FArray3D is an index-from-1 data structure.
References protocols::mean_field::max(), protocols::mean_field::min(), and core::scoring::electron_density::square().
Referenced by find_neighbors(), and find_neighbors_restricted().
void core::conformation::find_neighbors_3dgrid_restricted | ( | utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > | point_graph, |
core::Real | neighbor_cutoff, | ||
utility::vector1< bool > const & | residue_selection | ||
) |
Create a 3D grid of points. O(N^3). For "spherical" conformations, Theta(N). Speeds neighbor detection in abinitio by a factor of 2. Definition: Spherical = span of x,y and z all O(N**1/3). Note circularity. Adendum: if the 3D grid used a list of point indices instead of a vector, then this would be Theta(N) for spherical conformations; however, with a vector, this is O(NlgN). With the additional assumption that each cube contains O(1) points, then this implementation is O(N). Such an assumption is unneccessary in the list implementation.
References protocols::mean_field::max(), protocols::mean_field::min(), and core::scoring::electron_density::square().
void core::conformation::find_neighbors_naive | ( | utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > | point_graph, |
core::Real | neighbor_cutoff | ||
) |
Referenced by find_neighbors().
void core::conformation::find_neighbors_naive_restricted | ( | utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > | point_graph, |
core::Real | neighbor_cutoff, | ||
utility::vector1< bool > const & | residue_selection | ||
) |
void core::conformation::find_neighbors_naive_surface | ( | utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > | point_graph, |
core::Real | neighbor_cutoff, | ||
utility::vector1< std::pair< Size, Size > > const & | non_surface_ranges, | ||
utility::vector1< bool > const & | is_surface | ||
) |
void core::conformation::find_neighbors_octree | ( | utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > | point_graph, |
core::Real | neighbor_cutoff, | ||
Strategy | strategy | ||
) |
Finds the residue neighbors efficiently using an octree-like spatial sort.
References protocols::mean_field::max(), protocols::mean_field::min(), OCTREE, and core::scoring::electron_density::square().
Referenced by find_neighbors().
void core::conformation::find_neighbors_octree_restricted | ( | utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > | point_graph, |
core::Real | neighbor_cutoff, | ||
utility::vector1< bool > const & | residue_selection, | ||
Strategy | strategy | ||
) |
Finds the residue neighbors efficiently using an octree-like spatial sort.
References protocols::mean_field::max(), protocols::mean_field::min(), OCTREE, and core::scoring::electron_density::square().
void core::conformation::find_neighbors_restricted | ( | utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > | point_graph, |
core::Real | neighbor_cutoff, | ||
utility::vector1< bool > const & | residue_selection, | ||
Strategy | strategy = AUTOMATIC |
||
) |
References AUTOMATIC, find_neighbors_3dgrid(), NAIVE, and THREEDGRID.
void core::conformation::find_neighbors_stripe | ( | utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > | point_graph, |
core::Real | neighbor_cutoff | ||
) |
Referenced by find_neighbors().
void core::conformation::form_disulfide | ( | Conformation & | conformation, |
Size | lower_res, | ||
Size | upper_res, | ||
bool const | preserve_d_residues, | ||
bool const | force_d_residues | ||
) |
Introduce cysteines at the specified location and define a disulfide bond between them.
Does not do the repacking & minimization required to place the disulfide correctly.
References core::conformation::Residue::atom_index(), core::chemical::ResidueType::atom_name(), core::chemical::ResidueConnection::atomno(), change_cys_state(), core::conformation::Residue::connect_atom(), core::conformation::Residue::connect_map(), core::conformation::Conformation::declare_chemical_bond(), core::chemical::DISULFIDE, form_disulfide_helper(), core::chemical::FULL_ATOM_t, core::chemical::ResidueTypeBase::get_disulfide_atom_name(), core::conformation::Residue::has_variant_type(), core::conformation::Conformation::is_fullatom(), core::chemical::ResidueType::n_possible_residue_connections(), core::conformation::Residue::name3(), core::chemical::ResConnID::resid(), core::conformation::Conformation::residue(), core::chemical::ResidueType::residue_connection(), core::conformation::Conformation::residue_type(), core::conformation::Conformation::residue_type_set_for_conf(), TR(), core::conformation::Residue::type(), and upper_is_symm_equivalent_of_lower().
Referenced by protocols::simple_moves::DisulfideInsertionMover::apply(), protocols::minimization_packing::DisulfideOptimizationMover::break_repack_reform(), protocols::forge::remodel::build_and_score_disulfide(), core::pose::fix_up_residue_type_variants(), protocols::cyclic_peptide::TryDisulfPermutations::generate_disulfides(), protocols::denovo_design::DisulfidizeMover::make_disulfide(), protocols::forge::remodel::RemodelDesignMover::make_disulfide(), protocols::forge::remodel::RemodelDesignMover::make_disulfide_fast(), and protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::rebuild_disulfides().
void core::conformation::form_disulfide_helper | ( | core::conformation::Conformation & | conformation, |
core::Size const | res_index, | ||
core::chemical::ResidueTypeSetCOP | restype_set, | ||
bool const | preserve_d_residues, | ||
bool const | force_d_residues | ||
) |
Helper function for the form_disulfide function.
This function ensures that as a residue is mutated to a disulfide-bonding residue type, all other variant types are preserved; it is used to avoid code duplication.
References core::chemical::aa_b3c, core::chemical::aa_cys, core::chemical::aa_dcs, copy_residue_coordinates_and_rebuild_missing_atoms(), core::conformation::ResidueFactory::create_residue(), core::chemical::ResidueProperties::get_list_of_variants(), core::chemical::ResidueType::is_alpha_aa(), core::chemical::ResidueType::is_beta_aa(), core::chemical::ResidueTypeBase::is_d_aa(), core::chemical::ResidueTypeBase::properties(), core::conformation::Conformation::replace_residue(), core::conformation::Conformation::residue(), core::conformation::Conformation::residue_type(), and core::conformation::Residue::type().
Referenced by form_disulfide().
void core::conformation::get_anchor_and_root_atoms | ( | conformation::Residue const & | anchor_rsd, |
conformation::Residue const & | root_rsd, | ||
kinematics::Edge const & | edge, | ||
Size & | anchor_atomno, | ||
Size & | root_atomno | ||
) |
Use this routine to deduce atom indices of connect atoms in the tree.
Determines the anchor and root atom indices based on residue types and the foldtree edge.
References core::conformation::Residue::atom_index(), core::kinematics::dir_jump, core::kinematics::Edge::downstream_atom(), get_anchor_atomno(), get_chemical_root_and_anchor_atomnos(), get_root_atomno(), core::kinematics::Edge::has_atom_info(), core::kinematics::Edge::is_chemical_bond(), core::kinematics::Edge::is_jump(), core::kinematics::Edge::is_polymer(), core::chemical::ResidueTypeBase::name(), core::kinematics::Edge::polymer_direction(), core::conformation::Residue::seqpos(), core::kinematics::Edge::start(), core::kinematics::Edge::stop(), core::conformation::Residue::type(), and core::kinematics::Edge::upstream_atom().
Referenced by protocols::rigid::RotateJumpAxisMover::apply(), build_chemical_edge(), build_jump_edge(), build_polymer_edge(), build_residue_tree(), get_residue_connections(), and promote_sameresidue_child_of_jump_atom().
int core::conformation::get_anchor_atomno | ( | conformation::Residue const & | anchor_rsd, |
Size const | seqpos, | ||
kinematics::FoldTree const & | fold_tree | ||
) |
Get the atom-index of the atom to which the residue at position seqpos should be anchored.
Get the atom-index of the atom to which the residue at position seqpos should be anchored in constructing the atomtree.
References core::conformation::Residue::atom_index(), core::kinematics::dir_jump, core::kinematics::FoldTree::get_residue_edge(), core::kinematics::Edge::has_atom_info(), core::kinematics::Edge::is_jump(), core::kinematics::Edge::is_peptide(), core::kinematics::Edge::polymer_direction(), core::kinematics::FoldTree::root(), core::conformation::Residue::seqpos(), core::kinematics::Edge::start(), core::kinematics::Edge::stop(), and core::kinematics::Edge::upstream_atom().
Referenced by get_anchor_and_root_atoms(), get_anchor_atomno(), protocols::forge::build::BuildManager::modify(), protocols::forge::build::SegmentInsert::modify_impl(), and protocols::forge::build::SegmentRebuild::modify_impl().
int core::conformation::get_anchor_atomno | ( | conformation::Residue const & | rsd, |
int const | dir | ||
) |
get anchor atom to which the atom-tree of next residue in the edge is attached.
References protocols::carbohydrates::backward, core::kinematics::dir_jump, protocols::carbohydrates::forward, get_anchor_atomno(), core::conformation::Residue::is_lower_terminus(), core::conformation::Residue::is_polymer(), core::conformation::Residue::is_upper_terminus(), core::conformation::Residue::lower_connect_atom(), core::conformation::Residue::mainchain_atom(), core::conformation::Residue::mainchain_atoms(), core::conformation::Residue::n_mainchain_atoms(), and core::conformation::Residue::upper_connect_atom().
void core::conformation::get_chemical_root_and_anchor_atomnos | ( | conformation::Residue const & | rsd_anchor, |
conformation::Residue const & | rsd_root, | ||
Size & | anchor_atom_no, | ||
Size & | root_atom_no | ||
) |
References core::chemical::ResidueConnection::atomno(), core::conformation::Residue::connect_map(), core::conformation::Residue::connections_to_residue(), core::chemical::ResConnID::connid(), core::conformation::Residue::is_bonded(), and core::conformation::Residue::residue_connection().
Referenced by get_anchor_and_root_atoms().
core::Size core::conformation::get_disulf_partner | ( | core::conformation::Conformation const & | conformation, |
core::Size const | res_index | ||
) |
Gets a disulfide-forming residue's partner in the disulfide bond.
References core::conformation::Residue::atom_index(), core::chemical::ResidueConnection::atomno(), core::conformation::Residue::connect_map(), core::chemical::ResidueTypeBase::get_disulfide_atom_name(), core::chemical::ResidueType::is_disulfide_bonded(), core::chemical::ResidueType::n_possible_residue_connections(), core::chemical::ResConnID::resid(), core::conformation::Conformation::residue(), core::chemical::ResidueType::residue_connection(), core::conformation::Conformation::size(), TR(), and core::conformation::Residue::type().
Referenced by protocols::minimization_packing::DisulfideOptimizationMover::apply(), protocols::simple_moves::MutateResidue::break_a_disulfide(), break_disulfide(), protocols::denovo_design::construct_poly_ala_pose(), and protocols::simple_moves::MutateResidue::make_mutation().
core::Size core::conformation::get_nearest_neighbor | ( | utility::pointer::shared_ptr< utility::graph::UpperEdgeGraph< Vertex, Edge > > | point_graph, |
core::Size | node_id, | ||
core::Real | neighbor_cutoff, | ||
Strategy | strategy = AUTOMATIC |
||
) |
void core::conformation::get_residue_connections | ( | conformation::Residue const & | new_rsd, |
kinematics::FoldTree const & | fold_tree, | ||
conformation::ResidueCOPs const & | residues, | ||
id::BondID & | new_rsd_in, | ||
utility::vector1< id::BondID > & | new_rsd_out | ||
) |
Get the incoming connection and all outgoing connections from a residue
References core::id::BondID::atom1, core::id::BondID::atom2, core::id::AtomID::BOGUS_ATOM_ID(), get_anchor_and_root_atoms(), core::kinematics::FoldTree::get_outgoing_edges(), core::kinematics::FoldTree::get_residue_edge(), get_root_residue_root_atomno(), core::kinematics::Edge::is_polymer(), core::kinematics::FoldTree::is_root(), core::kinematics::Edge::polymer_direction(), core::conformation::Residue::seqpos(), and core::kinematics::Edge::start().
Referenced by replace_residue_in_atom_tree().
core::conformation::ResidueOP core::conformation::get_residue_from_name | ( | std::string const & | name, |
std::string const & | residue_type_set | ||
) |
Returns a new residue based on a name.
References core::conformation::ResidueFactory::create_residue().
Referenced by protocols::ligand_docking::ga_ligand_dock::GALigandDock::apply(), and protocols::ligand_docking::ga_ligand_dock::GALigandDock::make_starting_pose_for_virtual_screening().
core::conformation::ResidueOP core::conformation::get_residue_from_name1 | ( | char | name1, |
bool | is_lower_terminus, | ||
bool | is_upper_terminus, | ||
bool | d_aa, | ||
std::string const & | residue_type_set | ||
) |
Returns a new residue based on a name1.
References core::chemical::ResidueTypeFinder::aa(), core::chemical::aa_from_oneletter_code(), core::conformation::ResidueFactory::create_residue(), core::chemical::get_D_equivalent(), core::chemical::ResidueTypeFinder::get_representative_type(), core::pose::is_lower_terminus(), core::pose::is_upper_terminus(), core::chemical::LOWER_TERMINUS_VARIANT, core::chemical::UPPER_TERMINUS_VARIANT, update_ResidueType_enum_files::variants, and core::chemical::ResidueTypeFinder::variants().
Referenced by core::scoring::atomic_depth::AtomicDepth::AtomicDepth(), and core::pack::guidance_scoreterms::sap::SapConstraintHelper::init().
int core::conformation::get_root_atomno | ( | conformation::Residue const & | rsd, |
int const | dir | ||
) |
get the root atom for building residue atom-tree given the folding direction "dir"
References protocols::carbohydrates::backward, core::kinematics::dir_jump, protocols::carbohydrates::forward, core::chemical::ResidueTypeBase::has_variant_type(), core::conformation::Residue::is_lower_terminus(), core::conformation::Residue::is_polymer(), core::conformation::Residue::is_upper_terminus(), core::conformation::Residue::lower_connect_atom(), core::conformation::Residue::mainchain_atom(), core::conformation::Residue::mainchain_atoms(), core::chemical::N_ACETYLATION, core::conformation::Residue::n_mainchain_atoms(), core::chemical::ResidueType::root_atom(), core::conformation::Residue::type(), and core::conformation::Residue::upper_connect_atom().
Referenced by build_residue_tree(), get_anchor_and_root_atoms(), get_root_residue_root_atomno(), core::conformation::Conformation::jump_atom_id(), and core::pack::scmin::ResidueAtomTreeCollection::ResidueAtomTreeCollection().
Size core::conformation::get_root_residue_root_atomno | ( | conformation::Residue const & | rsd, |
kinematics::FoldTree const & | fold_tree | ||
) |
Determine which atom to use as the root of the root residue in the atomtree. It is sometimes useful to be able to control the atom chosen as the root of the atomtree, eg in graphics. The logic below uses atom_info stored in the foldtree for jump edges emanating from the root residue to override the default atom (if the root residue is a jump_point and said atom_info exists)
References core::conformation::Residue::atom_index(), core::kinematics::dir_jump, get_root_atomno(), core::kinematics::Edge::has_atom_info(), core::kinematics::FoldTree::is_jump_point(), core::chemical::ResidueTypeBase::is_polymer(), core::kinematics::FoldTree::jump_edge(), core::kinematics::FoldTree::num_jump(), core::kinematics::FoldTree::root(), core::conformation::Residue::seqpos(), core::kinematics::Edge::start(), core::conformation::Residue::type(), and core::kinematics::Edge::upstream_atom().
Referenced by build_residue_tree(), get_residue_connections(), and protocols::stepwise::modeler::align::StepWisePoseAligner::get_root_triad_atom_id_map().
core::kinematics::RT core::conformation::get_rt_from_residue_pair | ( | core::conformation::Residue const & | res1, |
core::conformation::Residue const & | res2 | ||
) |
Get stub mapping that maps residue 1 to residue 2.
Coordinate frames for each defined by orient_atoms which defaults to
References get_stub_from_residue().
bool core::conformation::get_second_atom_from_connection | ( | core::Size & | resno, |
core::Size & | atomno, | ||
Residue const & | rsd, | ||
Conformation const & | conformation, | ||
core::Size const & | conn_id | ||
) |
Given a residue and a connection id, get the heavyatom adjacent to the atom that makes that connection.
Chooses mainchain over non-mainchain, and heavyatoms over non-heavyatoms. Returns true for FAILURE.
References core::chemical::ResidueType::atoms_are_bonded(), core::conformation::Residue::connected_residue_at_resconn(), core::chemical::ResidueType::n_possible_residue_connections(), core::conformation::Residue::natoms(), core::conformation::Conformation::residue(), core::chemical::ResidueType::residue_connect_atom_index(), core::conformation::Residue::residue_connect_atom_index(), core::conformation::Residue::residue_connection_conn_id(), core::conformation::Residue::seqpos(), and core::conformation::Residue::type().
Referenced by core::conformation::Conformation::backbone_torsion_angle_atoms_meta_aramid(), core::conformation::Conformation::backbone_torsion_angle_atoms_oligourea(), core::conformation::Conformation::backbone_torsion_angle_atoms_ortho_aramid(), and core::conformation::Conformation::backbone_torsion_angle_atoms_para_aramid().
core::kinematics::Stub core::conformation::get_stub_from_residue | ( | core::conformation::Residue const & | res | ) |
Get stub from orient_atoms.
This defaults to a stub with CA, N, C for canonical amino acids
References core::conformation::membrane::center, protocols::sic_dock::scores::nbr1(), protocols::sic_dock::scores::nbr2(), core::conformation::Residue::select_orient_atoms(), and core::conformation::Residue::xyz().
Referenced by get_rt_from_residue_pair().
ppo_torsion_bin core::conformation::get_torsion_bin | ( | core::Real | phi, |
core::Real | psi, | ||
core::Real | omega | ||
) |
determine the torsion bin for a given phi/psi/omega combination, assuming that omega is 180 if not specified
placed here to make it accessible to a wide range of applications, but it's quite possible that placing this code elsewhere would be better bin boundaries are currently hard-coded – ideally in the future these can be read from external files, and thus adapted if desired
References core::scoring::omega, ppo_torbin_A, ppo_torbin_a, ppo_torbin_B, ppo_torbin_b, ppo_torbin_E, ppo_torbin_e, ppo_torbin_G, ppo_torbin_g, and ppo_torbin_X.
Referenced by core::scoring::Ramachandran::init_rama_sampling_table(), core::scoring::Ramachandran2B::init_rama_sampling_table(), protocols::loops::loop_closure::kinematic_closure::KinematicMover::torsion_features_string(), and protocols::loops::loop_mover::LoopMover::torsion_features_string().
void core::conformation::idealize_hydrogens | ( | Residue & | res, |
Conformation const & | conf | ||
) |
References core::conformation::Residue::atom_name(), core::chemical::ICoorAtomID::atomno(), core::chemical::AtomICoor::build(), core::conformation::Residue::icoor(), core::chemical::ICoorAtomID::is_internal(), core::conformation::Residue::natoms(), core::conformation::Residue::nheavyatoms(), core::conformation::Residue::set_xyz(), and core::chemical::AtomICoor::stub_atom().
Referenced by protocols::simple_moves::chiral::ChiralMover::apply(), protocols::comparative_modeling::PartialThreadingMover::apply(), protocols::comparative_modeling::ThreadingMover::apply(), core::pack::rotamer_set::RotamerSet_::build_optimize_H_rotamers(), protocols::legacy_sewing::Assembly::to_multichain_pose(), and protocols::legacy_sewing::Assembly::to_pose().
void core::conformation::idealize_position | ( | Size const | seqpos, |
Conformation & | conformation | ||
) |
Idealize backbone and sidechain at seqpos.
References core::conformation::Conformation::append_polymer_residue_after_seqpos(), core::conformation::Conformation::append_residue_by_bond(), core::id::BB, core::conformation::Conformation::bond_angle(), core::conformation::Conformation::bond_length(), core::chemical::rna::CHI, core::conformation::Residue::chi(), core::conformation::Residue::clone(), core::conformation::ResidueFactory::create_residue(), core::conformation::Conformation::fold_tree(), core::kinematics::FoldTree::is_cutpoint(), core::conformation::Residue::is_lower_terminus(), core::conformation::Residue::is_polymer(), core::conformation::Residue::is_upper_terminus(), core::conformation::Residue::mainchain_atom(), core::conformation::Residue::mainchain_torsion(), core::conformation::Residue::n_mainchain_atoms(), core::conformation::Residue::nchi(), core::conformation::Conformation::prepend_polymer_residue_before_seqpos(), core::conformation::Conformation::replace_residue(), core::conformation::Conformation::residue(), core::conformation::Conformation::set_bond_angle(), core::conformation::Conformation::set_bond_length(), core::conformation::Conformation::set_torsion(), core::conformation::Conformation::size(), and core::conformation::Residue::type().
Referenced by protocols::loops::loop_closure::kinematic_closure::KinematicMover::apply(), protocols::simple_moves::a3b_hbs::A3BHbsPatcher::apply(), protocols::simple_moves::hbs::HbsPatcher::apply(), protocols::simple_moves::oop::OopPatcher::apply(), protocols::rbsegment_relax::FragInsertAndAlignMover::apply(), protocols::comparative_modeling::PartialThreadingMover::apply(), protocols::hybridization::MRMover::apply(), protocols::hybridization::CartesianHybridize::apply_frame(), protocols::hybridization::CartesianSampler::apply_frame(), protocols::seeded_abinitio::SegmentHybridizer::apply_frame(), protocols::idealize::basic_idealize(), protocols::star::Extender::extend_unaligned(), protocols::loops::idealize_loop(), protocols::relax::RangeRelaxMover::idealize_pose(), protocols::ub_e2c::ubi_e2c_modeler::initial_cter_perturbation(), core::fragment::make_pose_from_frags(), protocols::loops::loop_mover::perturb::LoopMover_Perturb_CCD::model_loop(), protocols::forge::build::Bridge::modify_impl(), protocols::forge::build::SegmentInsert::modify_impl(), protocols::forge::build::SegmentRebuild::modify_impl(), protocols::ub_e2c::ubi_e2c_modeler::monoub_initial_cter_perturbation(), protocols::jumping::remove_cut(), protocols::hybridization::InsertChunkMover::set_bb_xyz_aligned(), protocols::loops::set_extended_torsions_and_idealize_loops(), and protocols::abinitio::KinematicTaskControl::set_extended_torsions_and_idealize_loops().
void core::conformation::improper_build | ( | Residue const & | residue, |
core::Size | missing, | ||
core::Size | parent, | ||
core::Size | sibling1, | ||
core::Size | sibling2, | ||
Vector & | coordinate | ||
) |
void core::conformation::insert_ideal_bonds_at_polymer_junction | ( | Size const | seqpos, |
Conformation & | conformation | ||
) |
Sets the two bond angles and the bond length across the junction, rebuilds dependent atoms (eg O,H)
Just sets the two bond angles and the bond length between seqpos and seqpos+1
References core::conformation::Conformation::append_polymer_residue_after_seqpos(), core::conformation::Conformation::append_residue_by_bond(), core::conformation::Conformation::bond_angle(), core::conformation::Conformation::bond_length(), core::conformation::ResidueFactory::create_residue(), core::conformation::Conformation::fold_tree(), core::kinematics::FoldTree::is_cutpoint(), core::conformation::Residue::is_polymer(), core::conformation::Residue::is_upper_terminus(), core::conformation::Residue::mainchain_atom(), core::conformation::Residue::n_mainchain_atoms(), core::conformation::Conformation::rebuild_polymer_bond_dependent_atoms(), core::conformation::Conformation::residue(), core::conformation::Conformation::set_bond_angle(), core::conformation::Conformation::set_bond_length(), core::conformation::Conformation::size(), TR(), and core::conformation::Residue::type().
Referenced by protocols::loophash::LocalInserter_SimpleMin::make_local_bb_change_close_gaps(), and protocols::loops::loop_mover::perturb::LoopMover_Perturb_CCD::model_loop().
void core::conformation::insert_ideal_mainchain_bonds | ( | Size const | seqpos, |
Conformation & | conformation | ||
) |
References core::conformation::Conformation::append_polymer_residue_after_seqpos(), core::conformation::Conformation::append_residue_by_bond(), core::conformation::Conformation::bond_angle(), core::conformation::Conformation::bond_length(), core::conformation::ResidueFactory::create_residue(), core::conformation::Residue::is_lower_terminus(), core::conformation::Residue::is_polymer(), core::conformation::Residue::is_upper_terminus(), core::conformation::Residue::mainchain_atom(), core::conformation::Residue::n_mainchain_atoms(), core::conformation::Conformation::prepend_polymer_residue_before_seqpos(), core::conformation::Conformation::residue(), core::conformation::Conformation::set_bond_angle(), core::conformation::Conformation::set_bond_length(), core::conformation::Conformation::size(), and core::conformation::Residue::type().
void core::conformation::insert_partial_atom_ids_for_mainchain_torsion | ( | Residue const & | rsd, |
Size const | mainchain_torsion, | ||
std::set< id::PartialAtomID > & | atoms | ||
) |
For a given mainchain torsion, report the partial atom IDs that define it, inserting these partial atom IDs into a std::set (to avoid redundancy perhaps with other torsions that also depend on the same atoms).
Inserts the partial atom ids for atoms along the mainchain, retrieving the residue connection indices for the atoms that extend off into the lower- and upper residues from the ResConnIDs stored in the Residue's connect_map. Note that if torsion 1 is requested, then the input Residue must have a lower connection and that if a torsion within 2 chemical bonds of the end of the mainchain atoms for a residue is requested (e.g. psi for canonical AAs), then the input Residue must have an upper connection.
References core::conformation::Residue::connection_incomplete(), core::chemical::ResidueConnection::index(), core::conformation::Residue::lower_connect(), core::conformation::Residue::mainchain_atoms(), core::conformation::Residue::residue_connection_conn_id(), core::conformation::Residue::residue_connection_partner(), core::conformation::Residue::seqpos(), and core::conformation::Residue::upper_connect().
Referenced by core::scoring::RamaPrePro::atoms_w_dof_derivatives(), core::pack::dunbrack::cenrot::SingleResidueCenrotLibrary::atoms_w_dof_derivatives(), core::energy_methods::DNA_DihedralEnergy::atoms_with_dof_derivatives(), core::energy_methods::P_AA_pp_Energy::atoms_with_dof_derivatives(), core::energy_methods::RamachandranEnergy::atoms_with_dof_derivatives(), core::pack::dunbrack::PeptoidGeneralDOFReporter::insert_atoms_defining_dof(), core::pack::dunbrack::MainchainTorsionReporter::insert_atoms_defining_dof(), and core::pack::dunbrack::PeptideTorsionReporter::insert_atoms_defining_dof().
void core::conformation::insert_residue_into_atom_tree | ( | conformation::Residue const & | new_rsd, |
kinematics::FoldTree const & | fold_tree, | ||
conformation::ResidueCOPs const & | residues, | ||
kinematics::AtomTree & | atom_tree | ||
) |
Inserts/ appends new residue subtree into an existing atomtree.
References core::kinematics::FoldTree::nres(), replace_residue_in_atom_tree(), core::conformation::Residue::seqpos(), core::kinematics::AtomTree::size(), and core::kinematics::AtomTree::update_sequence_numbering().
Referenced by core::conformation::Conformation::append_residue(), core::conformation::Conformation::insert_polymer_residue(), core::conformation::Conformation::insert_residue_by_bond(), and core::conformation::Conformation::insert_residue_by_jump().
chemical::ResidueTypeCOP core::conformation::inv_virtual_type_for_conf | ( | core::conformation::Conformation const & | conformation | ) |
Return the appropritate ResidueType for the inverse virtual residue for the "mode" (fullatom, centroid ...) the conformation is in.
When at all possible, use core::pose::get_restype_for_pose() instead, as that can use more pose-specific residue type information, if any.
References core::chemical::FULL_ATOM_t, core::chemical::MIXED_t, core::conformation::Conformation::residue_type_set_for_conf(), core::conformation::Conformation::residue_typeset_mode(), and TR().
Referenced by core::conformation::symmetry::setup_symmetric_conformation().
chemical::rings::AxEqDesignation core::conformation::is_atom_axial_or_equatorial | ( | Residue const & | residue, |
uint | query_atom | ||
) |
Is the query atom in this residue axial or equatorial or neither?
This function calculates an average plane and determines whether the coordinates of a given atom are axial or equatorial to it (or neither). The ring is requested from the Residue.
<residue> | The Residue containing the atoms in question, which must have exactly one ring. |
<query_atom> | The index of the atom in question. |
References is_atom_axial_or_equatorial_to_ring(), core::chemical::ResidueType::n_rings(), core::chemical::rings::NEITHER, core::chemical::ResidueType::ring_atoms(), TR(), and core::conformation::Residue::type().
chemical::rings::AxEqDesignation core::conformation::is_atom_axial_or_equatorial_to_ring | ( | Residue const & | residue, |
core::uint | query_atom, | ||
utility::vector1< core::uint > const & | ring_atoms | ||
) |
Is the query atom in this residue axial or equatorial to the given ring or neither?
This function calculates an average plane and determines whether the coordinates of a given atom are axial or equatorial to it (or neither). The attachment atom is auto-detected.
<residue> | The Residue containing the atoms in question. |
<query_atom> | The index of the atom in question. |
<ring_atoms> | A list of indices for the atoms of a monocyclic ring system in sequence. |
References core::chemical::rings::is_atom_axial_or_equatorial_to_ring(), core::chemical::rings::NEITHER, position_of_atom_on_ring(), TR(), and core::conformation::Residue::xyz().
Referenced by is_atom_axial_or_equatorial(), core::pose::is_atom_axial_or_equatorial_to_ring(), and core::conformation::Residue::show().
bool core::conformation::is_disulfide_bond | ( | conformation::Conformation const & | conformation, |
Size | residueA_pos, | ||
Size | residueB_pos | ||
) |
Find whether there is a disulfide defined between two residues.
We define a disulfide to exist between a pair of residues iff
References protocols::comparative_modeling::features::A, core::chemical::element::B, and core::conformation::Conformation::residue().
Referenced by core::util::rebuild_disulfide().
bool core::conformation::is_ideal_position | ( | Size const | seqpos, |
Conformation const & | conformation, | ||
Real | theta_epsilon = 0.005 , |
||
Real | D_epsilon = 0.02 |
||
) |
Return true if position contains an ideal geometry up to some epsilon.
@params seqpos - sequence position @params conformation - conformation object @params theta_epsilon - permitted deviation from ideal bond angles, in Radians @params D_epsilon - permitted deviation from ideal bond length
References core::conformation::Conformation::append_residue_by_bond(), core::kinematics::AtomTree::atom(), core::conformation::Residue::atom_name(), core::conformation::Conformation::atom_tree(), core::conformation::ResidueFactory::create_residue(), core::id::D, core::conformation::Conformation::dof(), core::conformation::Conformation::fold_tree(), core::kinematics::FoldTree::is_cutpoint(), core::kinematics::tree::Atom::is_jump(), core::conformation::Residue::is_lower_terminus(), core::conformation::Residue::is_polymer(), core::conformation::Residue::is_upper_terminus(), core::conformation::Residue::natoms(), core::conformation::Conformation::residue(), core::conformation::Conformation::safely_append_polymer_residue_after_seqpos(), core::conformation::Conformation::safely_prepend_polymer_residue_before_seqpos(), core::conformation::Conformation::size(), core::id::THETA, TR(), and core::conformation::Residue::type().
Referenced by core::pose::is_ideal_position(), protocols::features::ProteinResidueConformationFeatures::report_features(), protocols::features::ResidueConformationFeatures::report_features(), and protocols::features::PoseConformationFeatures::report_features_implementation().
ppo_torsion_bin core::conformation::map_char_to_torsion_bin | ( | char | torbin | ) |
returns the torsion bin that the input character represents
References ppo_torbin_A, ppo_torbin_a, ppo_torbin_B, ppo_torbin_b, ppo_torbin_E, ppo_torbin_e, ppo_torbin_G, ppo_torbin_g, ppo_torbin_U, and ppo_torbin_X.
Referenced by map_string_to_torsion_bin_string().
torsion_bin_string core::conformation::map_string_to_torsion_bin_string | ( | std::string const & | torstring | ) |
convert a string of characters into a vector of the internally recognized ppo_torsion_bin enumeration
utility::excn::EXCN_MsgException | if any of the input characters in this string are invalid |
References char_valid_as_torsion_bin(), map_char_to_torsion_bin(), and core::id::to_string().
Referenced by protocols::loops::loop_mover::refine::LoopMover_Refine_KIC::apply(), and protocols::loops::loop_mover::perturb::LoopMover_Perturb_KIC::model_loop().
char core::conformation::map_torsion_bin_to_char | ( | ppo_torsion_bin | torbin | ) |
convert a torsion bin to a character s.t. that character can be converted back to a torsion bin
References ppo_torbin_A, ppo_torbin_a, ppo_torbin_B, ppo_torbin_b, ppo_torbin_E, ppo_torbin_e, ppo_torbin_G, ppo_torbin_g, and ppo_torbin_X.
bool core::conformation::missing_stubs_build | ( | core::Size | ii, |
Residue const & | residue, | ||
utility::vector1< bool > const & | missing, | ||
Vector & | coordinate | ||
) |
References core::conformation::Residue::aa(), core::scoring::packstat::old::angles, core::conformation::Residue::atom_name(), core::chemical::ICoorAtomID::atomno(), core::chemical::AtomICoor::d(), core::conformation::Residue::icoor(), core::chemical::AtomICoor::is_internal(), core::conformation::Residue::natoms(), core::chemical::AtomICoor::phi(), core::chemical::AtomICoor::stub_atom(), core::chemical::AtomICoor::stub_atom1(), core::chemical::AtomICoor::stub_atom2(), core::chemical::AtomICoor::stub_atom3(), core::chemical::AtomICoor::theta(), TR(), and core::conformation::Residue::type().
Referenced by core::conformation::Residue::fill_missing_atoms().
id::AtomID core::conformation::named_atom_id_to_atom_id | ( | id::NamedAtomID const & | named_atom_id, |
conformation::Residue const & | rsd | ||
) |
References core::id::NamedAtomID::atom(), core::conformation::Residue::atom_index(), and core::id::NamedAtomID::rsd().
Referenced by protocols::rna::denovo::movers::RNA_DeNovoProtocolMover::constraint_setup(), core::import_pose::RNA_DeNovoSetup::de_novo_setup_from_options(), protocols::rna::denovo::coarse::CoarseRNA_LoopCloser::figure_out_dof_ids_and_offsets(), protocols::rna::denovo::coarse::CoarseRNA_LoopCloser::figure_out_forward_backward_res_by_backtracking(), core::scoring::nmr::pcs::PCSData::init_pcs_data_from_file(), core::scoring::nmr::pre::PREData::init_pre_data_from_file(), core::fragment::rna::FullAtomRNA_Fragments::insert_fragment(), core::scoring::constraints::AmbiguousNMRDistanceConstraint::map_to_CEN(), named_stub_id_to_stub_id(), core::scoring::constraints::parse_NMR_name(), core::scoring::constraints::parse_NMR_name_old(), core::scoring::constraints::CoordinateConstraint::read_def(), core::scoring::constraints::AtomPairConstraint::read_def(), protocols::constraints_additional::COMCoordinateConstraint::remapped_clone(), core::scoring::constraints::AngleConstraint::remapped_clone(), core::scoring::constraints::AtomPairConstraint::remapped_clone(), core::scoring::constraints::AtomToAxisConstraint::remapped_clone(), core::scoring::constraints::CoordinateConstraint::remapped_clone(), protocols::rna::denovo::RNA_DeNovoPoseInitializer::setup_fold_tree_legacy(), protocols::rna::denovo::RNA_DeNovoPoseInitializer::setup_jumps(), protocols::rna::denovo::movers::RNA_Minimizer::setup_movemap(), and protocols::rna::denovo::movers::RNA_Minimizer::update_atom_level_domain_map_with_extra_minimize_res().
id::StubID core::conformation::named_stub_id_to_stub_id | ( | id::NamedStubID const & | named_stub_id, |
conformation::Residue const & | rsd | ||
) |
std::ostream & core::conformation::operator<< | ( | std::ostream & | os, |
Conformation const & | conf | ||
) |
std::ostream & core::conformation::operator<< | ( | std::ostream & | os, |
Residue const & | res | ||
) |
References core::conformation::Residue::show().
std::ostream & core::conformation::operator<< | ( | std::ostream & | out, |
Atom const & | atom | ||
) |
References core::conformation::membrane::out, and core::conformation::Atom::show().
void core::conformation::orient_residue_for_ideal_bond | ( | Residue & | moving_rsd, |
chemical::ResidueConnection const & | moving_connection, | ||
Residue const & | fixed_rsd, | ||
chemical::ResidueConnection const & | fixed_connection, | ||
Conformation const & | conformation, | ||
bool | lookup_bond_length | ||
) |
References protocols::comparative_modeling::features::A, core::conformation::Residue::actcoord(), core::conformation::Residue::atom_type_index(), core::chemical::ResidueConnection::atomno(), core::chemical::element::B, core::chemical::AtomICoor::build(), core::chemical::FA_STANDARD, core::chemical::ResidueConnection::icoor(), core::chemical::ChemicalManager::ideal_bond_length_set(), core::chemical::AtomICoor::is_internal(), core::conformation::Residue::natoms(), core::conformation::Residue::set_xyz(), core::chemical::AtomICoor::stub_atom2(), TR(), core::chemical::ICoorAtomID::xyz(), and core::conformation::Residue::xyz().
Referenced by core::conformation::Conformation::append_polymer_residue_after_seqpos(), core::conformation::Conformation::append_residue_by_bond(), core::conformation::Conformation::insert_residue_by_bond(), core::conformation::symmetry::SymmetricConformation::prepend_polymer_residue_before_seqpos(), and core::conformation::Conformation::prepend_polymer_residue_before_seqpos().
core::uint core::conformation::position_of_atom_on_ring | ( | Residue const & | residue, |
core::uint | query_atom, | ||
utility::vector1< core::uint > const & | ring_atoms | ||
) |
What is the attachment position of the query atom on the given ring?
<residue> | The Residue containing the atoms in question. |
<query_atom> | The index of the atom in question. |
References core::conformation::Residue::get_adjacent_heavy_atoms().
Referenced by core::scoring::carbohydrates::get_CHI_energy_function_linkage_type_for_psi_for_residue_in_pose(), and is_atom_axial_or_equatorial_to_ring().
std::ostream& core::conformation::print_atom | ( | id::AtomID const & | id, |
Conformation const & | conf, | ||
std::ostream & | os | ||
) |
Helper function for below
References core::conformation::Residue::atom_name(), core::conformation::Residue::name(), core::conformation::Conformation::residue(), and core::conformation::Residue::seqpos().
Referenced by show_atom_tree().
void core::conformation::print_node | ( | std::ostream & | out, |
int | residue_num, | ||
int | atom_num, | ||
core::conformation::Residue const & | res, | ||
std::string const & | extras = "" |
||
) |
void core::conformation::print_node | ( | std::ostream & | out, |
int | residue_num, | ||
int | atom_num, | ||
core::Vector const & | atom_xyz, | ||
core::chemical::ResidueType const & | res, | ||
std::string const & | extras = "" |
||
) |
TWO FUNCTIONS STOLEN FROM IAN: and slightly modified.
References core::chemical::ResidueType::atom_name(), core::chemical::ResidueType::atom_type(), protocols::loops::extras, core::chemical::AtomType::name(), core::chemical::ResidueTypeBase::name3(), and core::conformation::membrane::out.
Referenced by print_node(), core::conformation::ConformationKinWriter::write_coords(), and core::conformation::ResidueKinWriter::write_rsd_coords().
void core::conformation::print_node | ( | std::ostream & | out, |
int | residue_num, | ||
std::string | atom_name, | ||
core::conformation::Residue const & | res, | ||
std::string const & | extras = "" |
||
) |
void core::conformation::promote_sameresidue_child_of_jump_atom | ( | kinematics::Edge const & | edge, |
conformation::ResidueCOPs const & | residues, | ||
kinematics::AtomPointer2D const & | atom_pointer | ||
) |
Moves the first same-residue child of the jump atom corresponding to edge into first place in the child list.
References get_anchor_and_root_atoms(), core::kinematics::Edge::is_jump(), core::kinematics::Edge::start(), core::kinematics::Edge::stop(), and TR().
void core::conformation::promote_sameresidue_child_of_jump_atom | ( | kinematics::Edge const & | edge, |
conformation::ResidueCOPs const & | residues, | ||
kinematics::AtomTree & | atom_tree | ||
) |
Moves the first same-residue child of the jump atom corresponding to edge into first place in the child list.
if ( debug ) { BondID old_rsd_in; vector1< BondID > old_rsd_out; get_residue_connections( old_rsd, fold_tree, residues, old_rsd_in, old_rsd_out ); debug_assert( new_rsd_in.atom1 == old_rsd_in.atom1 && new_rsd_out.size() == old_rsd_out.size() ); for ( Size i=1; i<= new_rsd_out.size(); ++i ) { debug_assert( new_rsd_out[i].atom2 == old_rsd_out[i].atom2 ); } }
References get_anchor_and_root_atoms(), core::kinematics::Edge::is_jump(), core::kinematics::AtomTree::promote_sameresidue_nonjump_child(), core::kinematics::Edge::start(), and core::kinematics::Edge::stop().
Referenced by build_tree(), and replace_residue_in_atom_tree().
chemical::ResidueType const& core::conformation::reference_from_restype_ptr | ( | chemical::ResidueTypeCOP | rsd_type | ) |
This function enforces the fact that ResidueTypes must be constructed with non-null-pointer ResidueTypeCOPs.
This must be a function as the initialization of the Residue's rsd_type_ reference must occur in the constructor.
ppo_torsion_bin core::conformation::remap_cis_omega_torsion_bins_to_trans | ( | ppo_torsion_bin | torbin | ) |
References ppo_torbin_A, ppo_torbin_a, ppo_torbin_B, ppo_torbin_b, ppo_torbin_E, ppo_torbin_e, ppo_torbin_G, ppo_torbin_g, and ppo_torbin_X.
Referenced by protocols::loops::loop_closure::kinematic_closure::TabooSamplingKinematicPerturber::get_random_phi_psi_for_residue(), protocols::loops::loop_closure::kinematic_closure::NeighborDependentTabooSamplingKinematicPerturber::get_random_phi_psi_for_residue(), and protocols::loops::loop_closure::kinematic_closure::TorsionRestrictedKinematicPerturber::perturb_chain().
void core::conformation::remove_lower_terminus_type_from_conformation_residue | ( | conformation::Conformation & | conformation, |
Size const | seqpos | ||
) |
References core::chemical::LOWER_TERMINUS_VARIANT, core::chemical::LOWERTERM_TRUNC_VARIANT, and remove_variant_type_from_conformation_residue().
Referenced by protocols::loop_grower::LoopGrower::apply(), protocols::loop_grower::LoopComparator::fill_pose(), protocols::forge::build::SegmentInsert::init(), protocols::forge::build::SegmentSwap::init(), core::conformation::symmetry::SymmetricConformation::safely_prepend_polymer_residue_before_seqpos(), core::conformation::Conformation::safely_prepend_polymer_residue_before_seqpos(), protocols::loop_grower::LoopGrower::single_grow(), and protocols::loop_grower::LoopGrower::update_to_stored().
void core::conformation::remove_upper_terminus_type_from_conformation_residue | ( | conformation::Conformation & | conformation, |
Size const | seqpos | ||
) |
References remove_variant_type_from_conformation_residue(), core::chemical::UPPER_TERMINUS_VARIANT, and core::chemical::UPPERTERM_TRUNC_VARIANT.
Referenced by protocols::loop_grower::LoopGrower::apply(), protocols::loop_grower::LoopComparator::fill_pose(), protocols::forge::build::SegmentInsert::init(), protocols::forge::build::SegmentSwap::init(), core::conformation::symmetry::SymmetricConformation::safely_append_polymer_residue_after_seqpos(), core::conformation::Conformation::safely_append_polymer_residue_after_seqpos(), protocols::loop_grower::LoopGrower::single_grow(), and protocols::loop_grower::LoopGrower::update_to_stored().
void core::conformation::remove_variant_type_from_conformation_residue | ( | conformation::Conformation & | conformation, |
chemical::VariantType const | variant_type, | ||
Size const | seqpos | ||
) |
Construct a non-variant of an existing conformation residue.
E.g., remove a terminus variant, and replace the original in pose.
References core::chemical::ResidueTypeBase::mode(), replace_conformation_residue_copying_existing_coordinates(), core::conformation::Conformation::residue(), core::conformation::Conformation::residue_type_set_for_conf(), and core::conformation::Residue::type().
Referenced by remove_lower_terminus_type_from_conformation_residue(), and remove_upper_terminus_type_from_conformation_residue().
void core::conformation::replace_conformation_residue_copying_existing_coordinates | ( | conformation::Conformation & | conformation, |
Size const | seqpos, | ||
chemical::ResidueType const & | new_rsd_type | ||
) |
helper function for residue replacement/residuetype switching
References copy_residue_coordinates_and_rebuild_missing_atoms(), core::conformation::ResidueFactory::create_residue(), core::conformation::Conformation::replace_residue(), and core::conformation::Conformation::residue().
Referenced by add_variant_type_to_conformation_residue(), and remove_variant_type_from_conformation_residue().
void core::conformation::replace_residue_in_atom_tree | ( | conformation::Residue const & | new_rsd, |
kinematics::FoldTree const & | fold_tree, | ||
conformation::ResidueCOPs const & | residues, | ||
kinematics::AtomTree & | atom_tree | ||
) |
Helper function for conformation routines.
Helper function for conformation routines. Uses fold_tree to deduce the incoming/outgoing connections for the new residue and the old residue We want it to be the case that the tree we get after this call is the same one that we would have gotten by calling build_tree
References build_residue_tree(), get_residue_connections(), core::kinematics::FoldTree::get_residue_edge(), core::kinematics::Edge::is_jump(), core::kinematics::FoldTree::is_jump_point(), core::kinematics::FoldTree::is_root(), core::kinematics::Edge::keep_stub_in_residue(), promote_sameresidue_child_of_jump_atom(), core::kinematics::AtomTree::replace_residue_subtree(), and core::conformation::Residue::seqpos().
Referenced by insert_residue_into_atom_tree(), and core::conformation::Conformation::replace_residue().
void core::conformation::residue_point_graph_from_conformation | ( | Conformation const & | conformation, |
PointGraph & | pg | ||
) |
References core::conformation::Residue::nbr_atom(), core::conformation::Conformation::residue(), core::conformation::Conformation::size(), and core::conformation::Residue::xyz().
Referenced by core::select::residue_selector::NumNeighborsSelector::apply(), protocols::task_operations::RestrictNonSurfaceToRepackingOperation::apply(), core::select::util::calc_interacting_vector(), protocols::pmut_scan::PointMutScanDriver::calculate_neighbor_table(), protocols::toolbox::CalcInterNeighborGroup::compute(), core::pack::interaction_graph::SurfacePotential::compute_pose_hpatch_score(), core::pack::create_packer_graph(), protocols::pose_metric_calculators::SequenceComparison::fill_num_neighbors(), core::scoring::Energies::fill_point_graph(), core::scoring::solid_surface::SurfaceEnergies::fill_point_graph(), core::scoring::symmetry::SymmetricEnergies::fill_point_graph(), core::select::util::find_jump_partners_within_CB_cutoff(), core::select::util::find_neighbors_within_CB_cutoff(), protocols::pose_metric_calculators::NeighborhoodByDistanceCalculator::recompute(), protocols::pose_metric_calculators::NeighborsByDistanceCalculator::recompute(), core::pose::metrics::simple_calculators::InterfaceNeighborDefinitionCalculator::recompute(), core::scoring::NeighborList::setup(), and protocols::simple_moves::setup_dme_point_graph().
void core::conformation::set_chi_according_to_coordinates | ( | conformation::Residue & | rotamer | ) |
rotamer chi-update from coords useful for building rotamers from coordinates
hokey "update chi from coordinates" useful for when the coordinates are known for a rotamer (specifically, a residue living outside of a conformation object); after the coordinates are set, the chis have to be updated – that won't happen automatically.
References core::conformation::Residue::chi(), core::conformation::Residue::chi_atoms(), core::conformation::Residue::is_protein(), core::conformation::Residue::nchi(), and core::conformation::Residue::xyz().
Referenced by core::pack::rotamers::SingleLigandRotamerLibrary::build_base_rotamers(), core::pack::rotamer_set::RotamerSet_::build_optimize_H_rotamers(), protocols::motifs::load_build_position_data(), and core::scoring::nmr::NMRDummySpinlabelConformer::NMRDummySpinlabelConformer().
void core::conformation::setup_atom_links | ( | int const | atom1, |
kinematics::Links const & | full_links, | ||
utility::vector1< bool > & | is_done, | ||
utility::vector1< bool > const & | is_mainchain, | ||
utility::vector1< bool > const & | is_chi, | ||
utility::vector1< bool > const & | is_hydrogen, | ||
utility::vector1< utility::vector1< Size > > const & | chi_atoms, | ||
kinematics::Links & | new_links | ||
) |
set correct order for how atoms are linked to each other.
this function is called recursively.
References chi_continuation(), chi_interruption(), and protocols::sic_dock::scores::nbr.
Referenced by setup_links().
void core::conformation::setup_corresponding_atoms | ( | id::AtomID_Map< id::AtomID > & | atom_map, |
conformation::Residue const & | rsd1, | ||
conformation::Residue const & | rsd2 | ||
) |
set up a map to match mainchain atoms from residue1 to residue2
only map by atom number, not by identity currently.
References core::conformation::Residue::atom_name(), core::chemical::ResidueConnection::atomno(), core::conformation::Residue::atoms(), core::conformation::Residue::chi_atoms(), core::conformation::Residue::is_DNA(), core::conformation::Residue::is_RNA(), core::conformation::Residue::mainchain_atoms(), core::conformation::Residue::n_possible_residue_connections(), core::conformation::Residue::name1(), core::chemical::ResidueTypeBase::name3(), core::conformation::Residue::natoms(), core::chemical::ResidueType::residue_connection(), core::conformation::Residue::seqpos(), core::id::AtomID_Map< T >::set(), and core::conformation::Residue::type().
void core::conformation::setup_links | ( | conformation::Residue const & | rsd, |
int const | root_atomno, | ||
kinematics::Links & | links | ||
) |
given the root_atomno, set up rules for how other atoms are linked for this residue a wrapper function calling setup_atom_links recursively .
References core::conformation::Residue::atom_index(), core::conformation::Residue::atom_name(), core::conformation::Residue::atom_type(), core::conformation::Residue::chi_atoms(), core::chemical::CUTPOINT_LOWER, core::chemical::CUTPOINT_UPPER, core::conformation::Residue::has(), core::conformation::Residue::has_variant_type(), core::chemical::AtomType::is_hydrogen(), core::conformation::Residue::mainchain_atoms(), core::conformation::Residue::natoms(), setup_atom_links(), setup_links_simple(), and TR().
Referenced by build_residue_tree().
void core::conformation::setup_links_simple | ( | conformation::Residue const & | rsd, |
kinematics::Links & | links | ||
) |
simply fill the "links" by adding, for each atom, its bonded neighbors
References check_good_neighbor(), core::conformation::Residue::cut_bond_neighbor(), core::conformation::Residue::natoms(), and core::conformation::Residue::nbrs().
Referenced by setup_links().
void core::conformation::show_atom_tree | ( | kinematics::tree::Atom const & | atom, |
Conformation const & | conf, | ||
std::ostream & | os | ||
) |
id::NamedStubID core::conformation::stub_id_to_named_stub_id | ( | id::StubID const & | stub_id, |
conformation::Residue const & | rsd | ||
) |
|
static |
Referenced by core::conformation::Conformation::add_disulfide_bond(), core::conformation::carbohydrates::align_virtual_atoms_in_carbohydrate_residue(), core::conformation::Conformation::align_virtual_atoms_in_carbohydrate_residue(), core::conformation::Conformation::append_residue(), protocols::simple_moves::a3b_hbs::A3BHbsPatcher::apply(), protocols::simple_moves::hbs::HbsPatcher::apply(), protocols::simple_moves::oop::OopMover::apply(), protocols::simple_moves::oop::OopPatcher::apply(), protocols::simple_moves::oop::OopRandomPuckMover::apply(), protocols::simple_moves::oop::OopRandomSmallMover::apply(), protocols::simple_moves::triazolamer::TriazolamerMover::apply(), protocols::simple_moves::triazolamer::TriazolamerRandomSmallMover::apply(), protocols::simple_moves::chiral::ChiralMover::apply(), core::conformation::Residue::apply_transform_downstream(), atom_id_to_named_atom_id(), core::conformation::Conformation::branch_connection_torsion_angle_atoms(), build_tree(), change_cys_state(), core::conformation::Residue::connect_atom(), core::conformation::Residue::connection_distance(), core::conformation::Residue::copy_residue_connections(), copy_residue_coordinates_and_rebuild_missing_atoms(), core::conformation::membrane::SpanningTopology::create_from_spanfile(), core::conformation::membrane::SpanningTopology::create_from_structure(), core::conformation::Conformation::detect_bonds(), core::conformation::Conformation::detect_disulfides(), core::conformation::Conformation::detect_pseudobonds(), disulfide_bonds(), core::conformation::membrane::membrane_geometry::Bicelle::fa_elec_lipid(), core::conformation::membrane::membrane_geometry::DoubleVesicle::fa_elec_lipid(), core::conformation::membrane::membrane_geometry::Vesicle::fa_elec_lipid(), core::conformation::membrane::membrane_geometry::Bicelle::fa_elec_lipid_deriv(), core::conformation::membrane::membrane_geometry::DoubleVesicle::fa_elec_lipid_deriv(), core::conformation::membrane::membrane_geometry::Vesicle::fa_elec_lipid_deriv(), core::conformation::membrane::SpanningTopology::fill_from_spanfile(), core::conformation::membrane::SpanningTopology::fill_from_structure(), core::conformation::Conformation::fill_missing_atoms(), core::conformation::Residue::fill_missing_atoms(), core::conformation::carbohydrates::find_seqpos_of_saccharides_child_residue_at(), core::conformation::carbohydrates::find_seqpos_of_saccharides_parent_residue(), core::conformation::Residue::first_adjacent_heavy_atom(), core::conformation::Conformation::fold_tree(), form_disulfide(), protocols::residue_optimization::MetapatchEnumeration::generate_derived_types(), protocols::residue_optimization::MetapatchEnumeration::generate_metapatched_variants(), core::conformation::carbohydrates::get_branching_residues(), core::conformation::carbohydrates::get_carbohydrate_residues_and_tips_of_branch(), protocols::simple_moves::chiral::get_chiral_residue_type(), get_disulf_partner(), core::conformation::carbohydrates::get_downstream_residue_that_this_torsion_moves(), core::conformation::carbohydrates::get_glycosidic_bond_residues(), core::conformation::carbohydrates::get_glycosidic_torsion(), core::conformation::carbohydrates::get_linkage_position_of_saccharide_residue(), protocols::helix_capper::HelixNCapperMover::get_Ncap_scores(), core::conformation::carbohydrates::GlycanTreeSet::get_node(), core::conformation::carbohydrates::GlycanTree::get_node(), core::conformation::carbohydrates::get_non_NU_TorsionID_from_AtomIDs(), core::conformation::carbohydrates::get_reference_atoms_for_1st_omega(), core::conformation::carbohydrates::get_reference_atoms_for_2nd_omega(), core::conformation::carbohydrates::get_reference_atoms_for_phi(), core::conformation::carbohydrates::get_reference_atoms_for_psi(), core::conformation::Conformation::get_torsion_angle_atom_ids(), core::conformation::carbohydrates::GlycanTreeSet::get_tree(), core::conformation::carbohydrates::has_exocyclic_glycosidic_linkage(), core::conformation::membrane::ImplicitLipidInfo::initialize_implicit_lipid_electricfield_parameters(), insert_ideal_bonds_at_polymer_junction(), core::conformation::Residue::inter_residue_connection_partner(), inv_virtual_type_for_conf(), is_atom_axial_or_equatorial(), is_atom_axial_or_equatorial_to_ring(), is_ideal_position(), core::conformation::membrane::Span::is_valid(), core::conformation::membrane::SpanningTopology::is_valid(), core::conformation::membrane::MembraneInfo::MembraneInfo(), missing_stubs_build(), core::conformation::Conformation::modifiable_residue_type_set_for_conf(), protocols::ncbb::ncbb_design_main_loop(), core::conformation::carbohydrates::GlycanTreeSet::on_length_change(), core::conformation::Residue::orient_onto_residue(), orient_residue_for_ideal_bond(), promote_sameresidue_child_of_jump_atom(), core::conformation::Conformation::reset_residue_type_set_for_conf(), core::conformation::Residue::Residue(), core::conformation::Conformation::residue_type_set_for_conf(), core::conformation::Conformation::residue_typeset_mode(), core::conformation::Conformation::residues_append(), core::conformation::membrane::membrane_geometry::DoubleVesicle::set_distance(), protocols::helix_capper::HelixNCapperMover::set_excluded_positions(), core::conformation::membrane::membrane_geometry::Bicelle::set_inner_radius(), core::conformation::membrane::membrane_geometry::DoubleVesicle::set_inner_radius(), core::conformation::membrane::MembraneInfo::set_membrane_jump(), core::conformation::membrane::membrane_geometry::Bicelle::set_outer_radius(), core::conformation::membrane::membrane_geometry::DoubleVesicle::set_outer_radius(), core::conformation::Conformation::set_polymeric_connection(), core::conformation::membrane::membrane_geometry::Bicelle::set_protein_slice_diameter(), core::conformation::Conformation::set_torsion(), core::conformation::Conformation::set_torsion_angle(), core::conformation::Conformation::setup_glycan_trees(), core::conformation::carbohydrates::GlycanTreeSet::setup_glycan_trees(), setup_links(), core::conformation::membrane::Span::show(), core::conformation::membrane::SpanningTopology::show(), core::conformation::Conformation::show_residue_connections(), protocols::residue_optimization::MetapatchEnumeration::tabooed(), core::conformation::Conformation::torsion_angle(), core::conformation::Residue::update_connections_to_other_residue(), core::conformation::membrane::membrane_geometry::Bicelle::update_inner_radius(), core::conformation::Conformation::update_noncanonical_connection(), core::conformation::membrane::membrane_geometry::DoubleVesicle::update_radii(), core::conformation::membrane::membrane_geometry::Vesicle::update_radius(), virtual_type_for_conf(), and core::conformation::membrane::SpanningTopology::write_spanfile().
void core::conformation::update_cutpoint_virtual_atoms_if_connected | ( | core::conformation::Conformation & | conf, |
core::Size const | cutpoint_res, | ||
bool | recurse | ||
) |
Given a conformation and a position that may or may not be CUTPOINT_UPPER or CUTPOINT_LOWER, determine whether this position has either of these variant types, and if it does, determine whether it's connected to anything. If it is, update the C-OVL1-OVL2 bond lengths and bond angle (for CUTPOINT_LOWER) or OVU1-N bond length (for CUTPOINT_UPPER) to match any potentially non-ideal geometry in the residue to which it's bonded.
Requires a little bit of special-casing for gamma-amino acids. Throws an exception if the residue to which a CUTPOINT_LOWER is bonded does not have an "N" and a "CA" or "C4". Safe to call repeatedly, or if cutpoint variant types are absent; in these cases, the function does nothing.
References core::conformation::Residue::atom_index(), core::conformation::Residue::atom_name(), core::chemical::ICoorAtomID::atomno(), core::chemical::AtomICoor::build(), check_good_cutpoint_neighbour(), core::conformation::Residue::connected_residue_at_lower(), core::conformation::Residue::connected_residue_at_upper(), core::chemical::CUTPOINT_LOWER, core::chemical::CUTPOINT_UPPER, core::chemical::AtomICoor::d(), core::conformation::Residue::has_variant_type(), core::chemical::ResidueConnection::icoor(), core::conformation::Residue::icoor(), core::chemical::ResidueType::is_carbohydrate(), core::conformation::Residue::is_RNA(), core::conformation::Residue::lower_connect(), core::chemical::AtomICoor::phi(), core::conformation::Conformation::residue(), core::conformation::Conformation::set_xyz(), core::chemical::AtomICoor::stub_atom1(), core::chemical::AtomICoor::stub_atom2(), core::chemical::AtomICoor::stub_atom3(), core::chemical::AtomICoor::theta(), core::conformation::Residue::type(), core::conformation::Conformation::update_actcoord(), core::conformation::Residue::upper_connect(), and core::conformation::Residue::xyz().
Referenced by core::conformation::Conformation::declare_chemical_bond(), and core::pose::update_cutpoint_virtual_atoms_if_connected().
bool core::conformation::upper_is_symm_equivalent_of_lower | ( | core::conformation::Conformation const & | conformation, |
core::Size const | lower_res, | ||
core::Size const | upper_res | ||
) |
Another helper function for the form_disulfide function.
Returns true if and only if the conformation is symmetric and upper_res is a symmetric copy of lower_res.
References core::conformation::Conformation::get_self_ptr().
Referenced by form_disulfide().
chemical::ResidueTypeCOP core::conformation::virtual_type_for_conf | ( | core::conformation::Conformation const & | conformation | ) |
Return the appropritate ResidueType for the virtual residue for the "mode" (fullatom, centroid ...) the conformation is in.
When at all possible, use core::pose::virtual_type_for_pose() instead, as that can use more pose-specific residue type information, if any.
References core::chemical::FULL_ATOM_t, core::chemical::MIXED_t, core::conformation::Conformation::residue_type_set_for_conf(), core::conformation::Conformation::residue_typeset_mode(), and TR().
Referenced by protocols::environment::EnvClaimBroker::add_virtual_residues(), core::conformation::symmetry::SymmetricConformation::recalculate_transforms(), and core::conformation::symmetry::setup_symmetric_conformation().
void core::conformation::write_kinemage_header | ( | std::ostream & | ostr, |
Size const | kin_number, | ||
std::string const & | title, | ||
Vector const & | ctr | ||
) |
Referenced by core::conformation::ResidueKinWriter::write_kin_header().