Rosetta
|
A class for defining a type of residue. More...
#include <ResidueType.hh>
Public Member Functions | |
~ResidueType () override | |
destructor More... | |
ResidueTypeCOP | get_self_ptr () const |
self pointers More... | |
ResidueTypeOP | get_self_ptr () |
ResidueTypeCAP | get_self_weak_ptr () const |
ResidueTypeAP | get_self_weak_ptr () |
Size | natoms () const override |
number of atoms More... | |
Size | nheavyatoms () const override |
number of heavy atoms More... | |
Size | n_hbond_acceptors () const |
number of hbond_acceptors More... | |
Size | n_hbond_donors () const |
number of hbond_donors More... | |
Size | nbonds () const override |
number of bonds More... | |
Size | n_virtual_atoms () const override |
Counts the number of virtual atoms and returns the count. More... | |
Size | last_backbone_atom () const |
index of the last backbone heavy atom More... | |
Size | first_sidechain_atom () const |
index of the first sidechain atom (heavy or hydrogen) More... | |
Size | first_sidechain_hydrogen () const |
index of the first sidehchain hydrogen More... | |
Size | nbr_atom () const |
get nbr_atom used to define residue-level neighbors More... | |
Real | nbr_radius () const |
get nbr_radius_ used to define residue-level neighbors More... | |
core::Real | mass () const |
get the molecular weight of this residue More... | |
bool | has_shadow_atoms () const |
Returns true if this residue has shadow atoms, false otherwise. More... | |
Size | atom_being_shadowed (Size atom_shadowing) const |
Return the index of the atom that the "atom_shadowing" atom is shadowing; returns zero if the "atom_shadowing" atom is not shadowing anyone. More... | |
AtomIndices const & | attached_H_begin () const |
for all heavy atoms, index numbers of their first attached Hydrogen More... | |
AtomIndices const & | attached_H_end () const |
for all heavy atoms, index numbers of their last attached Hydrogen More... | |
void | get_metal_binding_atoms (AtomIndices &metal_binding_indices) const |
Gets indices of all atoms that can form bonds to metals. More... | |
AtomIndices const & | all_bb_atoms () const |
Indices of all backbone atoms, hydrogens and heavyatoms. More... | |
AtomIndices const & | all_sc_atoms () const |
Indices of all sidechain atoms, hydrogens and heavyatoms. More... | |
AtomIndices const & | Haro_index () const |
return indices of aromatic Hydrogens More... | |
AtomIndices const & | Hpol_index () const |
return indices of polar Hydrogens More... | |
AtomIndices const & | Hpos_polar () const |
indices of polar hydrogens as Hbond donors More... | |
AtomIndices const & | Hpos_apolar () const |
indices of non-polar hydrogens as potential carbon Hbond donors More... | |
AtomIndices const & | Hpos_polar_sc () const |
AtomIndices const & | accpt_pos () const |
indices of atoms as Hbond acceptors More... | |
AtomIndices const & | accpt_pos_sc () const |
indices of atoms as Hbond acceptors More... | |
bool | has (std::string const &atom_name) const override |
is this atom present in this residue? More... | |
std::string const & | atom_name (Size const atomno) const |
get atom name by index More... | |
Size | atom_index (std::string const &atom_name) const |
get atom index by name More... | |
AtomType const & | atom_type (Size const atomno) const |
Get the chemical atom_type for this atom by it index number in this residue. More... | |
core::Size | atom_type_index (core::Size atomno) const |
ElementCOP | element_type (core::Size atomno) const |
core::chemical::element::Elements | element (core::Size atomno) const |
Convenience function to go directly to the element enum. More... | |
int | path_distance (Size at1, Size at2) const |
path distance (number of bonds separated) between a pair of atoms More... | |
utility::vector1< int > const & | path_distance (Size atom) const |
shortest path distance for an atom to all other residue atoms More... | |
utility::vector1< utility::vector1< int > > const & | path_distances () const |
accessor of path_distance_ data for this residue, which is a 2D array More... | |
Size | attached_H_begin (Size const atom) const |
index number of the first attached Hydrogen on an atom More... | |
Size | attached_H_end (Size const atom) const |
index number of the last attached Hydrogen on an atom More... | |
bool | heavyatom_has_polar_hydrogens (Size atomno) const |
bool | heavyatom_is_an_acceptor (Size atomno) const |
bool | atom_is_polar_hydrogen (Size atomno) const |
bool | atom_is_aro_hydrogen (Size atomno) const |
AtomIndices const & | mainchain_atoms () const |
indices of all mainchain atoms More... | |
Size | mainchain_atom (Size const mainchain_index) const |
index of mainchain atom More... | |
int | formal_charge (Size const atomno) const |
core::Real | atom_charge (Size const atomno) const |
core::Vector | ideal_xyz (Size const atomno) const |
core::Vector | ideal_xyz (std::string const &atomname) const |
bool | atom_is_backbone (Size const atomno) const |
is a backbone atom (heavy or hydrogen)? More... | |
bool | atom_is_sidechain (Size const atomno) const |
bool | atom_is_hydrogen (Size const atomno) const |
quick lookup: is the atom with the given index a hydrogen or not? Atoms are sorted so that heavy atoms come first and hydrogen atoms come last. More... | |
bool | is_virtual (Size const atomno) const |
Check if atom is virtual. More... | |
bool | is_repulsive (Size const atomno) const |
Check if atom is repulsive. More... | |
bool | atom_has_property (Size const atomno, AtomProperty const property) const |
AtomProperties const & | atom_properties (Size const atomno) const |
Get the AtomicProperities object for the atom. (Note this is only the manually set properties, not all the properties of the atom.) More... | |
void | show_all_atom_names (std::ostream &out) const override |
Size | nbonds (Size atom) const |
number of bonds for given atom More... | |
Size | number_bonded_hydrogens (Size const atomno) const |
indicates how many proton bonded neighbors an atom has More... | |
Size | number_bonded_heavyatoms (Size const atomno) const |
indicates how many heavyatom bonded neighbors an atom has More... | |
AtomIndices const & | bonded_neighbor (Size const atomno) const |
indices of the bonded neighbors for an atom More... | |
utility::vector1< std::pair< core::Size, core::Size > > | bonds () const |
Returns a list of all pairs of atoms which are bonded. This returned list should only have only one entry per bond (So [1,2] and [2,1] will not both be present.) More... | |
bool | atoms_are_bonded (core::Size const atomindex1, core::Size const atomindex2) const |
Indicates whether or not two atom indices have a chemical bond linking them. More... | |
utility::vector1< BondName > const & | bonded_neighbor_types (Size const atomno) const |
utility::vector1< BondRingness > const & | bonded_neighbor_ringnesses (Size const atomno) const |
BondName | bond_type (core::Size const atomindex1, core::Size const atomindex2) const |
Returns the type of bond between the atoms Will return UnknownBond for something which isn't bonded. More... | |
BondRingness | bond_ringness (core::Size const atomindex1, core::Size const atomindex2) const |
Returns whether the bond between the atoms is in a ring. Will return UnknownRingness for something which isn't bonded. More... | |
AtomIndices const & | cut_bond_neighbor (Size const atomno) const |
indices of the bonded neighbors for an atom More... | |
AtomIndices const & | nbrs (Size const atomno) const |
indices of the bonded neighbors for an atom, shortcut for bonded_neighbor(atomno) More... | |
Size | nchi () const |
number of chi angles More... | |
Size | n_nus () const |
Return number of nu (internal ring) angles. More... | |
Size | n_rings () const |
Return the number of rings in this residue. More... | |
Size | ndihe () const |
Return the number of intraresidue dihedrals. This covers all pairs of atoms that are separated by four bonds, and all pairs of intervening atoms. More... | |
Size | n_proton_chi () const |
number of proton chis More... | |
bool | is_proton_chi (Size const chino) const |
number of proton chis More... | |
Size | proton_chi_2_chi (Size proton_chi_id) const |
translate proton_chi to global chi More... | |
Size | chi_2_proton_chi (Size chi_index) const |
utility::vector1< Real > const & | proton_chi_samples (Size proton_chi) const |
utility::vector1< Real > const & | proton_chi_extra_samples (Size proton_chi) const |
utility::vector1< std::pair< Real, Real > > const & | chi_rotamers (Size const chino) const |
all rotamers bins (mean, std) for a given chi angle More... | |
AtomIndices const & | chi_atoms (Size const chino) const |
indices of the atoms which are used to define a given chi angle (chino) More... | |
utility::vector1< AtomIndices > const & | chi_atoms () const |
indices of the atoms which are used to define all the chi angles More... | |
AtomIndices const & | nu_atoms (core::uint const nu_index) const |
Return indices of the atoms used to define a given nu (internal ring) angle. More... | |
utility::vector1< AtomIndices > const & | nu_atoms () const |
Return list of indices of the atoms used to define all the nu (internal ring) angles. More... | |
AtomIndices const & | ring_atoms (uint const ring_num) const |
Return list of indices of the atoms within this residue's nth cycle, not counting virtual atoms. More... | |
utility::vector1< AtomIndices > const & | ring_atoms () const |
Return list of indices of the atoms within this residue's cycles, not counting virtual atoms. More... | |
bool | is_ring_atom (uint const ring_num, uint const atom_id) const |
Return whether this atom is in a particular ring. More... | |
core::chemical::rings::RingSaturationType | ring_saturation_type (uint const ring_num) const |
Return the saturation level of this residue's nth cycle. More... | |
utility::vector1< core::chemical::rings::RingSaturationType > const & | ring_saturation_types () const |
Return the saturation level for all of this residue's cycles. More... | |
utility::vector1< std::string > const & | lowest_ring_conformers () const |
For each ring, what's the lowest conformer? More... | |
utility::vector1< utility::vector1< std::string > > const & | low_ring_conformers () const |
Low-energy ring conformers for each ring. More... | |
utility::vector1< Size > const & | last_controlling_chi () const |
Read access to the last_controlling_chi_ array. More... | |
Size | last_controlling_chi (Size atomno) const |
The last_controlling_chi for an atom. 0 if an atom is controlled by no chi. More... | |
utility::vector1< AtomIndices > const & | atoms_last_controlled_by_chi () const |
Read access to the atoms_last_controlled_by_chi_ array. More... | |
AtomIndices const & | atoms_last_controlled_by_chi (Size chi) const |
Read access to the Atoms last controlled by a particular chi. More... | |
core::Size | root_atom () const |
get root_atom used as the base of the icoor tree. More... | |
AtomICoor const & | icoor (Size const atm) const |
AtomICoord of an atom. More... | |
Size | atom_base (Size const atomno) const |
get index of an atom's base atom More... | |
Size | abase2 (Size const atomno) const |
get index of an atom's second base atom More... | |
void | debug_dump_icoor () const |
Dump out atomnames and icoor values. More... | |
MMAtomType const & | mm_atom_type (Size const atomno) const |
Get the MM atom_type for this atom by its index number in this residue. More... | |
std::string const & | mm_name (core::Size atomno) const |
core::Size | mm_atom_type_index (core::Size atomno) const |
gasteiger::GasteigerAtomTypeDataCOP | gasteiger_atom_type (core::Size atomno) const |
Get the Gasteiger atom type for this atom Can be null if the atom type isn't set. More... | |
utility::vector1< core::Size > const & | bonded_orbitals (Size const atomno) const |
indices of the orbitals bonded to an atom More... | |
AtomIndices const & | atoms_with_orb_index () const |
orbitals::ICoorOrbitalData const & | orbital_icoor_data (Size const orbital_index) const |
orbitals::ICoorOrbitalData const & | new_orbital_icoor_data (Size const orbital_index) const |
core::chemical::rings::RingConformerSetCOP | ring_conformer_set (core::uint ring_num) const |
Return a pointer to the object containing the set of ring conformers possible for this residue's nth cycle. More... | |
core::Size | n_ring_conformer_sets () const |
ResidueConnection const & | lower_connect () const |
Size | lower_connect_id () const |
Size | lower_connect_atom () const |
index number of the atom which connects to the lower connection More... | |
ResidueConnection const & | upper_connect () const |
Size | upper_connect_id () const |
Size | upper_connect_atom () const |
index number of the atom which connects to the upper connection More... | |
utility::vector1< uint > | branch_connect_atoms () const |
Return a list of indices of atoms at non-polymer connections. More... | |
utility::vector1< std::string > | branch_connect_atom_names () const |
Return a list of names of atoms at non-polymer connections. More... | |
Size | n_possible_residue_connections () const |
number of ResidueConnections, counting polymeric residue connections More... | |
Size | n_polymeric_residue_connections () const |
Size | n_non_polymeric_residue_connections () const |
ResidueConnection const & | residue_connection (Size const i) const |
Get a ResidueConection. More... | |
bool | atom_forms_residue_connection (Size const atomid) const |
Does an atom form any inter-residue chemical bonds? More... | |
Size | n_residue_connections_for_atom (Size const atomid) const |
How many inter-residue chemical bonds does a particular atom form? More... | |
Size | residue_connection_id_for_atom (Size const atomid) const |
Convenience access function for the residue connection at a particular atom; requires that there is exactly one residue connection at this atom. More... | |
utility::vector1< Size > const & | residue_connections_for_atom (Size const atomid) const |
bool | residue_connection_is_polymeric (Size const resconn_id) const |
Size | residue_connect_atom_index (Size const resconn_id) const |
bool | atom_depends_on_lower_polymeric_connection (core::Size const atom_index) const |
Does an atom with a given index have an icoor that depends, directly or indirectly, on the lower polymeric connection? More... | |
bool | atom_depends_on_upper_polymeric_connection (core::Size const atom_index) const |
Does an atom with a given index have an icoor that depends, directly or indirectly, on the upper polymeric connection? More... | |
bool | atom_depends_on_polymeric_connection (core::Size const atom_index) const |
Does an atom with a given index have an icoor that depends, directly or indirectly, on the upper or lower polymeric connection? More... | |
bool | atom_depends_on_connection (core::Size const atom_index, core::Size const connection_id) const |
Does an atom with a given index have an icoor that depends, directly or indirectly, on a particular connection ID? More... | |
bool | requires_actcoord () const |
require actcoord? More... | |
AtomIndices const & | actcoord_atoms () const |
get indices for atoms used to define actcoord More... | |
bool | is_sidechain_thiol () const |
is thiol? More... | |
bool | is_disulfide_bonded () const |
is disulfide? More... | |
bool | is_sidechain_amine () const |
is sidechain amine? More... | |
bool | is_alpha_aa () const |
Is this an alpha-amino acid? More... | |
bool | is_beta_aa () const |
Is this a beta-amino acid? More... | |
bool | is_gamma_aa () const |
Is this a gamma-amino acid? More... | |
bool | is_water () const |
is this a water residue type? More... | |
bool | is_virtualizable_by_packer () const |
Is this a residue type that can be virtualized or devirtualized by the packer? More... | |
bool | is_oligourea () const |
Is this an oligourea? More... | |
bool | is_aramid () const |
Is this an aramid? More... | |
bool | is_ortho_aramid () const |
Is this an ortho-aramid? More... | |
bool | is_meta_aramid () const |
Is this a meta-aramid? More... | |
bool | is_para_aramid () const |
Is this a para-aramid? More... | |
bool | is_pre_methylene_ortho_aramid () const |
Is this an ortho-aramid? More... | |
bool | is_pre_methylene_meta_aramid () const |
Is this a meta-aramid? More... | |
bool | is_pre_methylene_para_aramid () const |
Is this a para-aramid? More... | |
bool | is_post_methylene_ortho_aramid () const |
Is this an ortho-aramid? More... | |
bool | is_post_methylene_meta_aramid () const |
Is this a meta-aramid? More... | |
bool | is_post_methylene_para_aramid () const |
Is this a para-aramid? More... | |
bool | is_pre_methylene_post_methylene_ortho_aramid () const |
Is this an ortho-aramid? More... | |
bool | is_pre_methylene_post_methylene_meta_aramid () const |
Is this a meta-aramid? More... | |
bool | is_pre_methylene_post_methylene_para_aramid () const |
Is this a para-aramid? More... | |
bool | is_sri () const |
Is this one of SRI's special heteropolymer building blocks? More... | |
bool | is_triazolemer () const |
Is this a triazolemer? More... | |
bool | is_mirrored_type () const |
Is this a D_AA, R_PEPTOID, or L_RNA? More... | |
bool | is_n_methylated () const |
Is this residue N-methylated? More... | |
bool | is_TNA () const |
is TNA? More... | |
bool | is_PNA () const |
is PNA? More... | |
bool | is_coarse () const |
is coarse? More... | |
bool | is_NA () const |
is Nucleic Acid? More... | |
bool | is_purine () const |
is purine? More... | |
bool | is_pyrimidine () const |
is pyrimidine? More... | |
bool | is_solvent () const |
Is this a solvent molecule (SOLVENT property)? More... | |
bool | is_canonical_nucleic () const |
Is this a canonical nucleic acid (CANONICAL_NUCLEIC property)? More... | |
bool | is_canonical_aa () const |
Is this a canonical amino acid (CANONICAL_AA property)? More... | |
bool | is_canonical () const |
Is this a canonical residue type (nucleic acid or amino acid)? More... | |
bool | is_carbohydrate () const |
is carbohydrate? More... | |
bool | is_ligand () const |
is ligand? More... | |
bool | is_lipid () const |
is lipid? More... | |
bool | is_metal () const |
Return true if this residue type is a metal ion, false otherwise. More... | |
bool | is_metalbinding () const |
Return true if this residue type is a type that can bind to a metal ion (e.g. His, Asp, Cys, etc.), false otherwise. More... | |
bool | is_membrane () const |
is membrane? More... | |
bool | is_surface () const |
is surface? (e.g. enamel) More... | |
bool | has_sc_orbitals () const |
does this residue have sidechain orbitals? More... | |
bool | is_polar () const |
is polar? More... | |
bool | is_charged () const |
is charged? More... | |
bool | is_aromatic () const |
is aromatic? More... | |
bool | is_cyclic () const |
is cyclic? More... | |
bool | is_terminus () const |
is terminus? More... | |
bool | is_lower_terminus () const |
is lower terminus? More... | |
bool | is_upper_terminus () const |
is upper terminus? More... | |
bool | is_branch_point () const |
is a branch-point residue? More... | |
bool | is_acetylated_nterminus () const |
is acetylated n terminus More... | |
bool | is_methylated_cterminus () const |
is methylated c terminus More... | |
bool | is_virtual_residue () const |
Check if residue is 'VIRTUAL_RESIDUE' This ONLY checks the VIRTUAL_RESIDUE PROPERTY! More... | |
bool | is_inverted_virtual_residue () const |
Check if atom is an inverted virtual. More... | |
bool | is_VRT1 () const |
Check if residue is 'VRT1'. More... | |
bool | is_TP3 () const |
Check if residue is a TP3 water. More... | |
bool | is_adduct () const |
is an adduct-modified residue? More... | |
bool | is_N_substituted () const |
is N-substituted? Returns true if this aa is aa_pro or aa_dpr, N-methyl amino acid, peptoid, or proline-like oligourea, false otherwise More... | |
bool | has_polymer_dependent_groups () const |
Does this type have groups (not just single atoms) that are polymer-bond dependent? More... | |
bool | is_base_type () const override |
Is this ResidueTypeBase a base type? More... | |
ResidueTypeCOP | get_base_type_cop () const override |
Get a pointer to this ResidueTypeBase's base ResidueTypeBase. More... | |
core::chemical::rna::RNA_Info const & | RNA_info () const |
core::chemical::carbohydrates::CarbohydrateInfoCOP | carbohydrate_info () const |
Return the CarbohydrateInfo object containing sugar-specific properties for this residue. More... | |
dihedral_atom_set const & | dihedral (Size const dihe) const |
Return the indices for the set of atoms that define a particular intraresidue dihedral. More... | |
utility::vector1< Size > const & | dihedrals_for_atom (Size atomno) const |
Returns the list of all of the indices of all the intraresidue dihedrals a particular atom is involved in. Useful for calculating the derivatives for an atom. More... | |
bondangle_atom_set const & | bondangle (Size const bondang) const |
Return the indices for the set of atoms that define a particular intraresidue angle. More... | |
utility::vector1< Size > const & | bondangles_for_atom (Size atomno) const |
Returns the list of all of the indices of all the intraresidue bond angles a particular atom is involved in. Useful for calculating the derivatives for an atom. More... | |
Size | num_bondangles () const |
get number of intraresidue bond angles More... | |
void | print_bondangles () const |
print intraresidue bond angles to standard out More... | |
void | print_pretty_path_distances () const |
print chemical-bond path distances to standard out More... | |
utility::vector1< two_atom_set > const & | atoms_within_one_bond_of_a_residue_connection (Size resconn) const |
Returns a list of those atoms within one bond of a residue connection. For residue connection i, its position in this array is a list of pairs of atom-id's, the first of which is always the id for the atom forming residue connection i. More... | |
utility::vector1< std::pair< Size, Size > > const & | within1bonds_sets_for_atom (Size atomid) const |
Returns a list of pairs for atom# atomid where first == the residue_connection id that lists atomid as being within one bond of a residue connection, and second == the index of the entry containing this atom in the atoms_within_one_bond_of_a_residue_connection_[ first ] array. Useful for calculating the derivatives for an atom. More... | |
utility::vector1< three_atom_set > const & | atoms_within_two_bonds_of_a_residue_connection (Size resconn) const |
Returns the list of those atoms within two bonds of residue connection # resconn. Each entry in this list is a triple of atom-id's, the first of which is always the id for the atom forming residue connection resconn. More... | |
utility::vector1< std::pair< Size, Size > > | within2bonds_sets_for_atom (Size atomid) const |
Returns a list of pairs for atom # atomid where first == the residue_connection id that lists this atom as being within two bonds of a residue connection, and second == the index of the entry containing this atom in the atoms_within_two_bonds_of_a_residue_connection_[ first ] array. Useful for calculating the derivatives for an atom. More... | |
void | select_orient_atoms (Size ¢er, Size &nbr1, Size &nbr2) const |
Selects three atoms for orienting this residue type. More... | |
void | select_orient_atoms_standard_logic (Size ¢er, Size &nbr1, Size &nbr2, bool const ignore_virtuals) const |
Pick atoms to use for orienting one Residue onto another, using standard logic. More... | |
std::tuple< Size, Size, Size > | select_orient_atoms () const |
Selects three atoms for orienting this residue type. More... | |
void | show (std::ostream &output=std::cout, bool output_atomic_details=false) const override |
Generate string representation of ResidueType for debugging purposes. More... | |
template<typename MemFn , typename Ptr > | |
utility::signals::Link | attach_destruction_obs (MemFn fn, Ptr ptr) const |
attach RestypeDestructionEvent observer function More... | |
template<typename MemFn , typename Ptr > | |
bool | detach_destruction_obs (MemFn fn, Ptr ptr) const |
detach RestypeDestructionEvent observer function More... | |
utility::vector1< std::string > const & | get_metal_binding_atoms () const |
![]() | |
TypeSetMode | mode () const |
AtomTypeSet const & | atom_type_set () const |
access by reference the atomset for which this residue is constructed More... | |
AtomTypeSetCOP | atom_type_set_ptr () const |
access by const pointer the atomset for which this residue is constructed More... | |
ElementSet const & | element_set () const |
access by reference the element set for which this residue is constructed More... | |
ElementSetCOP | element_set_ptr () const |
access by const pointer the element set for which this residue is constructed More... | |
MMAtomTypeSetCOP | mm_atom_types_ptr () const |
gasteiger::GasteigerAtomTypeSetCOP | gasteiger_atom_typeset () const |
void | set_gasteiger_atom_typeset (gasteiger::GasteigerAtomTypeSetCOP setting) |
orbitals::OrbitalTypeSetCOP | orbital_types_ptr () const |
Get the MM atom_type for this atom by its index number in this residue. More... | |
void | set_orbital_typeset (orbitals::OrbitalTypeSetCOP setting) |
bool | has_orbital_types () const |
Does this residue type define orbital types? More... | |
signed long int | net_formal_charge () const |
Get the nominal net formal charge on this residue type. More... | |
void | net_formal_charge (signed long int charge_in) |
Set the nominal net formal charge on this residue type. More... | |
utility::vector1< std::string > const & | get_metal_binding_atoms () const |
std::string const & | get_disulfide_atom_name () const |
Gets disulfide atom name. More... | |
void | set_disulfide_atom_name (std::string const &n) |
Sets disulfide atom name. More... | |
std::map< std::string, std::string > const & | atom_aliases () const |
returns atom aliases More... | |
std::string const & | atom_alias (std::string const &name) const |
returns atom alias More... | |
std::map< std::string, std::string > const & | canonical_atom_aliases () const |
returns atom aliases More... | |
std::string const & | canonical_atom_alias (std::string const &name) const |
returns atom alias More... | |
Orbital const & | orbital (Size const orbital_index) const |
Orbital const & | orbital (std::string const &orbital_name) const |
orbitals::OrbitalType const & | orbital_type (Size const orbital_index) const |
Size | n_orbitals () const |
number of orbitals More... | |
bool | has_orbital (std::string const &orbital_name) const |
is this orbital present in this residue? More... | |
core::Size | orbital_index (std::string const &name) const |
get orbital index by name More... | |
ResidueProperties const & | properties () const |
Access the collection of properties for this ResidueTypeBase. More... | |
void | set_properties (ResiduePropertiesOP properties) |
Set the collection of properties for this ResidueTypeBase. More... | |
void | add_property (std::string const &property) |
Add a property to this ResidueTypeBase. More... | |
void | add_property (core::chemical::ResidueProperty const property) |
Add a property to this ResidueType, by properties enum. More... | |
void | set_adduct_flag (bool adduct_in) |
void | add_numeric_property (std::string const &tag, core::Real value) |
Add a numeric property. More... | |
void | add_string_property (std::string const &tag, std::string value) |
Add a string property. More... | |
void | delete_property (std::string const &property) |
Delete a property of this ResidueType. More... | |
void | delete_property (core::chemical::ResidueProperty const property) |
Delete a property of this ResidueType, by properties enum. More... | |
void | set_metapatched () |
Set that this is a metapatched ResidueType. More... | |
bool | is_metapatched () const |
Get whether this is a metapatched ResidueType. More... | |
bool | is_polymer () const |
is polymer? More... | |
bool | is_protein () const |
is protein? More... | |
bool | is_DNA () const |
is DNA? More... | |
bool | is_RNA () const |
is RNA? More... | |
bool | is_d_aa () const |
is this a d-amino acid? More... | |
bool | is_l_aa () const |
is this an l-amino acid? More... | |
bool | is_d_rna () const |
is this a d-RNA? More... | |
bool | is_l_rna () const |
is this an l-RNA? More... | |
bool | is_peptoid () const |
is peptoid? More... | |
bool | is_r_peptoid () const |
Is this a peptoid with a chiral side-chain with "R" chirality? More... | |
bool | is_s_peptoid () const |
Is this a peptoid with a chiral side-chain with "S" chirality? More... | |
bool | is_achiral_backbone () const |
is this an achiral backbone? More... | |
bool | is_achiral_sidechain () const |
Does this have an achiral sidechain? More... | |
bool | has_property (std::string const &property) const |
Generic property access. More... | |
bool | has_property (ResidueProperty const property) const |
Generic property access, by ResidueProperty. More... | |
core::Real | get_numeric_property (std::string const &tag) const |
Get a numeric property, if it exists. More... | |
std::string | get_string_property (std::string const &tag) const |
Get a string property, if it exists. More... | |
void | add_variant_type (VariantType const variant_type) |
Add a variant type to this ResidueTypeBase. More... | |
void | add_variant_type (std::string const &variant_type) |
Add a variant type to this ResidueTypeBase by string. More... | |
void | remove_variant_type (VariantType const variant_type) |
Remove a variant type to this ResidueTypeBase. More... | |
void | remove_variant_type (std::string const &variant_type) |
Remove a variant type to this ResidueTypeBase by string. More... | |
bool | has_variant_type (VariantType const variant_type) const |
Generic variant access. More... | |
bool | has_variant_type (std::string const &variant_type) const |
Generic variant access by string. More... | |
void | enable_custom_variant_types () |
Turn on the ability to create VariantTypes "on-the-fly". More... | |
utility::vector1< std::string > | variant_types () const |
get all the variant types for this ResidueTypeBase More... | |
utility::vector1< VariantType > | variant_type_enums () const |
Get a vector of VariantType enums for this ResidueTypeBase. More... | |
utility::vector1< std::string > const & | custom_variant_types () const |
Get a list of custom VariantType strings for this ResidueTypeBase (by const reference). More... | |
void | aa (AA const &type) |
set our aa-type (could be "UNK") More... | |
void | aa (std::string const &type) |
set our aa-type (could be "UNK") More... | |
void | backbone_aa (std::string const &type) |
AA to use for backbone scoring. More... | |
void | backbone_aa (core::chemical::AA const type) |
Set AA to use for backbone scoring directly (without string conversion). More... | |
void | base_analogue (std::string const &type) |
NA to use for base-specific generalization (can be more forgiving than na_analogue for new NA backbones) More... | |
void | na_analogue (std::string const &type) |
NA to use for fragment sampling and some scoring purposes. More... | |
std::string const & | base_name () const |
Get this ResidueTypeBase's base name (shared with other residue types with the same base type). More... | |
std::string const & | name () const |
get our (unique) residue name More... | |
void | base_name (std::string const &base_name_in) |
Set this ResidueTypeBase's base name (shared with other residue types with the same base type). More... | |
void | name (std::string const &name_in) |
set our (unique) residue name More... | |
std::string const & | name3 () const |
get our 3letter code. This is set in the ResidueTypeBase .params file through the IO_STRING tag along with the name1 string NOTE: The "name3" is not necessarily three characters long. e.g. Metal ions may be only two characters. More... | |
void | name3 (std::string const &name_in) |
set our 3letter code More... | |
char | name1 () const |
get our 1letter code. This is set in the ResidueTypeBase .params file through the IO_STRING tag along with the name3 string. More... | |
void | name1 (char const code) |
set our 1letter code More... | |
std::string | interchangeability_group () const |
get our interchangeability-group id. Used to determine if two residue types are equivalent, except for their variant status. E.g. ResidueTypeBases ALA and ALA_Nterm would be part of the same interchangeability group. This has a degree of subjectivity; are TYR and pTYR in the same interchangeability group? Probably not. This data can be specified in the ResidueTypeBases .params file with the INTERCHANGEABILITY_GROUP tag. More... | |
void | interchangeability_group (std::string const &setting) |
set our interchangeability-group id More... | |
void | remap_pdb_atom_names (bool rename) |
Turn on geometry-based atom renaming when loading this residue type from PDB files. More... | |
bool | remap_pdb_atom_names () const |
Are we using geometry-based atom renaming when loading this residue type from PDB. More... | |
AA const & | aa () const |
our traditional residue type, if any More... | |
AA const & | backbone_aa () const |
Returns the amino acid type to be used for backbone scoring (rama and p_aa_pp). More... | |
AA const & | base_analogue () const |
Returns the nucleic acid type to be used for base features. More... | |
AA const & | na_analogue () const |
Returns the nucleic acid type to be used for fragment sampling/scoring. More... | |
void | rotamer_library_specification (rotamers::RotamerLibrarySpecificationOP) |
rotamers::RotamerLibrarySpecificationCOP | rotamer_library_specification () const |
rotamers::RotamerLibrarySpecificationOP | rotamer_library_specification_nonconst () |
Nonconst access to the RotamerLibrarySpecification. More... | |
void | strip_rotamer_library_specification () |
Remove any rotamer library specifications attached to this ResidueTypeBase. More... | |
bool | force_nbr_atom_orient () const |
dihedral methods More... | |
void | force_nbr_atom_orient (bool force_orient) |
Set force_nbr_atom_orient_, used to control orient atoms selected by select_orient_atoms. More... | |
std::string const & | get_rama_prepro_mainchain_torsion_potential_name (bool const pre_proline_position) const |
Get the key name for the mainchain torsion potential used by the RamaPrePro score term. More... | |
bool | mainchain_potentials_match (ResidueTypeBase const &other) const |
Do the rama_prepro mainchain torsion potentials of this residue match another? More... | |
void | set_rama_prepro_mainchain_torsion_potential_name (std::string const &name_in, bool const pre_proline_position) |
Set the key name for the mainchain torsion potential used by the RamaPrePro score term. More... | |
std::string const & | get_rama_prepro_map_file_name (bool const pre_proline_position) const |
Get the file name for the mainchain torsion potential used by the RamaPrePro score term. More... | |
void | set_rama_prepro_map_file_name (std::string const &filename_in, bool const pre_proline_position) |
Set the file name for the mainchain torsion potential used by the RamaPrePro score term. More... | |
bool | defines_custom_rama_prepro_map (bool const pre_proline_position) const |
Returns true if and only if (a) this is not a base type, AND (b) there is a rama_prepro_mainchain_torsion_map_file_name_ defined for this ResidueTypeBase (which is presumably different from that of the base type). More... | |
void | reset_mainchain_torsion_potential_names () |
Set the names of the mainchain torsion potential maps to use to "". More... | |
utility::vector1< Adduct > const & | defined_adducts () const |
get the adducts defined for this residue More... | |
void | add_adduct (Adduct &adduct_in) |
void | report_adducts () const |
Static Public Member Functions | |
static ResidueTypeCOP | make (MutableResidueType const &residue_type) |
Make a ResidueType from a Modifiable residue type. More... | |
Private Member Functions | |
ResidueType () | |
ResidueType (MutableResidueType const &residue_type) | |
Make (most of) a ResidueType from a MutableResidueType Use ResidueType::make() instead. More... | |
ResidueType (ResidueType const &residue_type)=delete | |
make a copy of this ResidueType More... | |
ResidueTypeOP | clone () const =delete |
make a copy More... | |
ResidueTypeOP | placeholder_clone () const =delete |
make a copy More... | |
ResidueType & | operator= (ResidueType const &src)=delete |
Copies <src> into the ResidueType. More... | |
utility::vector1< core::Size > | setup_atom_ordering (MutableResidueType const &source) |
Determine how to map the numeric indices of MutableResidueType to this ResidueType. ( As the MutableResidueType is const, we can assume a decent mapping here. ) More... | |
void | copy_atom_info (MutableResidueType const &source, utility::vector1< core::Size > const &old_to_new) |
Iterate through the atoms, filling out the various atom info vectors. More... | |
void | copy_other_info (MutableResidueType const &source, utility::vector1< core::Size > const &old_to_new) |
Fill in various other information which is being copied over from the MutableResidueType. More... | |
void | initialize_derived_data () |
Precalculate other derived data from data already present. More... | |
void | update_derived_data () |
Do other pre-calculation checks, not for otherwise uninitialized variables, but for data consistency or otherwise "incorrectly" set values. More... | |
void | auto_assign_nu_atoms () |
If a ring has been added but no nu angles have been defined, automatically assign them. More... | |
void | define_mainchain_atoms () |
If a polymer without explicitly set mainchain atoms, determine a list of main chain atoms by shortest path from LOWER to UPPER. More... | |
void | update_ring_conformer_sets () |
Update the ring conformer sets derived information. More... | |
void | update_last_controlling_chi () |
compute the last controlling chi for an atom during the update_derived_data() stage. The last controlling chi is the furthest chi downstream of the mainchain which can change the location of an atom. More... | |
void | note_chi_controls_atom (Size chi, Size atomno) |
Recursive subroutine invoked by update_last_controlling_chi(). More... | |
void | update_polymer_dependent_groups () |
Determine which atoms are polymer bond-dependent. More... | |
void | update_nonpolymer_dependent_groups () |
Determine which atoms are nonpolymer bond-dependent. More... | |
void | update_ncaa_rotamer_library_specification_if_present () |
If there is an NCAARotamerLibrarySpecification, ensure that the rotamer backbone dependicies have been set. If they have not, set them to all mainchain torsions except omega (the final, inter-residue torsion). More... | |
void | self_pointer_updates () |
Do updates which need a valid get_self_ptr() (And thus can't be called from the constructor.) More... | |
void | perform_checks () const |
Final check of ResidueType data, called by ResidueType::make(). More... | |
Private Attributes | |
Size | natoms_ |
Size | nbonds_ |
Size | nheavyatoms_ |
The number of heavy atoms. More... | |
Size | n_hbond_acceptors_ |
The number of hbond_acceptors. More... | |
Size | n_hbond_donors_ |
number of hbond_donors More... | |
Size | n_backbone_heavyatoms_ |
number of backbone heavy atoms More... | |
Size | first_sidechain_hydrogen_ |
the index of first sidechain hydrogen atom More... | |
utility::vector1< std::string > | atom_names_ |
std::map< std::string, core::Size > | atom_name_to_index_ |
utility::vector1< AtomType > | vec_atom_types_ |
The types for each atom. More... | |
utility::vector1< core::Size > | vec_atom_type_indexes_ |
utility::vector1< ElementCOP > | elements_ |
utility::vector1< core::Size > | mm_atom_type_index_ |
utility::vector1< core::Size > | gasteiger_atom_type_index_ |
utility::vector1< int > | formal_charge_ |
utility::vector1< core::Real > | partial_charge_ |
utility::vector1< core::Vector > | ideal_xyz_ |
utility::vector1< AtomPropertiesOP > | atomic_properties_ |
utility::vector1< AtomICoor > | icoor_ |
Internal coordinates on how to build the given atom. More... | |
utility::vector1< AtomIndices > | bonded_neighbor_ |
For each atom, list the other atom indices it's bonded to. More... | |
utility::vector1< utility::vector1< BondName > > | bonded_neighbor_type_ |
What is the bond type of the bond connecting the equivalent entry in bonded_neighbor_? More... | |
utility::vector1< utility::vector1< BondRingness > > | bonded_neighbor_ringness_ |
What is the ringness type of the bond connecting the equivalent entry in bonded_neighbor_? More... | |
utility::vector1< Size > | attached_H_begin_ |
indices of each heavyatom's first attached hydrogen More... | |
utility::vector1< Size > | attached_H_end_ |
indices of each heavyatom's last attached hydrogen More... | |
utility::vector1< dihedral_atom_set > | dihedral_atom_sets_ |
Data for the mm potentials. List all of the intra-residue dihedral angles and bond angles. vector of sets of atoms that make up dihedral angles in the residue Data for the mm potentials. More... | |
utility::vector1< utility::vector1< Size > > | dihedrals_for_atom_ |
all intra-residue dihedral angles that each atom "participates" in More... | |
utility::vector1< bondangle_atom_set > | bondangle_atom_sets_ |
vector of sets of atoms that make up bond angles in the residue More... | |
utility::vector1< utility::vector1< Size > > | bondangles_for_atom_ |
??? More... | |
utility::vector1< Size > | last_controlling_chi_ |
Data for controlling chi. Computed in update_last_controlling_chi() for each atom 0 means an atom whose location is not determined by any chi. More... | |
utility::vector1< AtomIndices > | atoms_last_controlled_by_chi_ |
for chi i, the list of atoms last controlled by i E.g. chi2 on LEU list cd1, 1hd1, 1hd2, 1hd3, cd2, 2hd1, 2hd2, 2hd3, and hg1 More... | |
utility::vector1< utility::vector1< Size > > | bonded_orbitals_ |
For each atom, which orbitals are bonded to it. More... | |
AtomIndices | atoms_with_orb_index_ |
indices of atoms with orbitals More... | |
AtomIndices | Haro_index_ |
indices of haro hydrogens More... | |
AtomIndices | Hpol_index_ |
indices of hpolar hydrogens More... | |
AtomIndices | accpt_pos_ |
indices of Hbond acceptor positions More... | |
AtomIndices | Hpos_polar_ |
indices of polar Hydrogens for Hbond donors More... | |
AtomIndices | Hpos_apolar_ |
indices of apolar hydrogens More... | |
AtomIndices | accpt_pos_sc_ |
indices of Hbond acceptor positions that are part of the sidechain must be a subset of the atoms listed in the accpt_pos_ array More... | |
AtomIndices | Hpos_polar_sc_ |
indices of polar Hydrogens for Hbond donors that are part of the sidechain must be a subset of the atoms listed in the Hpos_polar_ array More... | |
AtomIndices | all_bb_atoms_ |
Indices of all backbone atoms, hydrogens and heavyatoms. More... | |
AtomIndices | all_sc_atoms_ |
Indices of all sidechain atoms, hydrogens and heavyatoms. More... | |
utility::vector1< bool > | heavyatom_has_polar_hydrogens_ |
Is this atom a heavyatom with polar hydrogens attached? More... | |
utility::vector1< utility::vector1< core::Size > > | chi_atoms_ |
utility::vector1< bool > | is_proton_chi_ |
Is the corresponding chi in chi_atoms_ a proton chi? More... | |
utility::vector1< Size > | proton_chis_ |
Indices of the chi_atoms_ vector for proton chis. More... | |
utility::vector1< Size > | chi_2_proton_chi_ |
A "map" of chi indices to proteon_chi indices. More... | |
utility::vector1< utility::vector1< Real > > | proton_chi_samples_ |
For a proton chi, the primary samples to diversify the rotamer library with. More... | |
utility::vector1< utility::vector1< Real > > | proton_chi_extra_samples_ |
For a proton chi, how to handle extra ex_ levels. More... | |
utility::vector1< utility::vector1< std::pair< Real, Real > > > | chi_rotamers_ |
Additional non-Dunbrack rotamer bins. More... | |
utility::vector1< AtomIndices > | nu_atoms_ |
AtomIndex of four atoms to build each nu angle. More... | |
utility::vector1< AtomIndices > | ring_atoms_ |
AtomIndex of all ring atoms, not counting virtual atoms. More... | |
utility::vector1< core::chemical::rings::RingSaturationType > | ring_saturation_types_ |
The saturation type of each ring in this residue. More... | |
utility::vector1< rings::RingConformerSetOP > | ring_conformer_sets_ |
The sets of all possible ring conformers, one per ring. More... | |
utility::vector1< std::string > | lowest_ring_conformer_ |
Lowest-energy ring conformer for each ring. More... | |
utility::vector1< utility::vector1< std::string > > | low_ring_conformers_ |
Low-energy ring conformers for each ring. More... | |
utility::vector1< utility::vector1< int > > | path_distance_ |
number of bonds separated between any pair of atoms in this residue More... | |
core::Size | root_atom_ |
Atom at the nominal root of the ICOOR tree. More... | |
core::Size | nbr_atom_ |
Real | nbr_radius_ |
radius cutoff to define neighbors More... | |
Real | mass_ |
utility::vector1< ResidueConnection > | residue_connections_ |
Vector of inter-residue connections expected for this residuetype NOW includes the polymer connections, as well as disulf-type connections. More... | |
utility::vector1< utility::vector1< Size > > | atom_2_residue_connection_map_ |
Mapping of atom indicies to residue connections. More... | |
utility::vector1< utility::vector1< two_atom_set > > | atoms_within_one_bond_of_a_residue_connection_ |
For calculating inter-residue bond angle and bond torsion energies, it is useful to have a list of those atoms within one bond of a residue connection atom. For residue connection i, its position in this array is a list of pairs of atom-id's, the first of which is always the id for the atom forming residue connection i. More... | |
utility::vector1< utility::vector1< std::pair< Size, Size > > > | within1bonds_sets_for_atom_ |
For atom i, its position in this vector is a list of pairs where first == the residue_connection id that lists this atom as being within one bond of a residue connection, and second == the index of the entry containing this atom in the atoms_within_one_bond_of_a_residue_connection_[ first ] array. More... | |
utility::vector1< utility::vector1< three_atom_set > > | atoms_within_two_bonds_of_a_residue_connection_ |
For calculating inter-residue bond torsion energies, it is useful to have a list of those atoms within two bonds of a residue connection atom. For residue connection i, its position in this array is a list of triples of atom-id's, the first of which is always the id for the atom forming residue connection i. More... | |
utility::vector1< utility::vector1< std::pair< Size, Size > > > | within2bonds_sets_for_atom_ |
For atom i, its position in this vector is a list of pairs where first == the residue_connection id that lists this atom as being within two bonds of a residue connection, and second == the index of the entry containing this atom in the atoms_within_two_bonds_of_a_residue_connection_[ first ] array. More... | |
Size | lower_connect_id_ |
Polymer lower connections. More... | |
Size | upper_connect_id_ |
Polymer upper connections. More... | |
Size | n_non_polymeric_residue_connections_ |
Number of non-polymeric residue connections. More... | |
Size | n_polymeric_residue_connections_ |
Number of polymeric residue connections. More... | |
ResidueTypeCOP | base_type_cop_ |
Const-access owning pointer to the base residue type. More... | |
core::chemical::rna::RNA_InfoOP | rna_info_ |
A container for properties unique to RNA. More... | |
core::chemical::carbohydrates::CarbohydrateInfoOP | carbohydrate_info_ |
A container for residue properties unique to carbohydrates. More... | |
utility::vector1< Size > | atom_base_indices_ |
Index version of atom_base_. More... | |
utility::vector1< Size > | abase2_indices_ |
Index version of abase2_. More... | |
AtomIndices | mainchain_atoms_indices_ |
Index version of mainchain_atoms_. More... | |
AtomIndices | actcoord_atoms_indices_ |
Index version of actcoord_atoms_. More... | |
utility::vector1< AtomIndices > | cut_bond_neighbor_indices_ |
Index version of cut_bond_neighbor_. More... | |
utility::vector1< Size > | atom_shadowed_indices_ |
Index version of atom_shadowed_. More... | |
bool | has_polymer_dependent_groups_ |
Does this ResidueType have groups with icoors that depend, directly or indirectly, on polymeric bonds? More... | |
utility::vector1< bool > | atom_depends_on_lower_polymeric_connection_ |
vector of length corresponding to number of atoms indicating whether each atom is dependent on the lower polymer bond. More... | |
utility::vector1< bool > | atom_depends_on_upper_polymeric_connection_ |
vector of length corresponding to number of atoms indicating whether each atom is dependent on the upper polymer bond. More... | |
utility::vector1< utility::vector1< bool > > | atom_depends_on_connection_ |
An outer vector indexed to connection ID, and an inner vector indexed to atom ids. "True" means that the atom id for the inner vector depends on the connection ID for the outer. More... | |
utility::signals::BufferedSignalHub< void, RestypeDestructionEvent > | destruction_obs_hub_ |
Who needs to be told if this ResidueType is destroyed? More... | |
Additional Inherited Members | |
![]() | |
ResidueTypeBase () | |
ResidueTypeBase (AtomTypeSetCOP atom_types, ElementSetCOP element_types, MMAtomTypeSetCOP mm_atom_types, orbitals::OrbitalTypeSetCOP orbital_types) | |
constructor More... | |
ResidueTypeBase (ResidueTypeBase const &)=default | |
ResidueTypeBase & | operator= (ResidueTypeBase const &)=default |
Copies <src> into the ResidueTypeBase. More... | |
void | atom_type_set (AtomTypeSetCOP setting) |
utility::vector1< std::string > & | metal_binding_atoms () |
std::map< std::string, std::string > & | atom_aliases () |
returns atom aliases More... | |
std::map< std::string, std::string > & | canonical_atom_aliases () |
returns atom aliases More... | |
utility::vector1< OrbitalOP > & | get_orbitals () |
std::map< std::string, int > & | get_orbitals_index () |
AA const & | backbone_aa_raw () const |
AA const & | base_analogue_raw () const |
AA const & | na_analogue_raw () const |
A class for defining a type of residue.
This class contains the "chemical" information for residues as well as the ideal xyz and internal coordinates for a residue (generated xyz coordinates are found in core/conformation/Residue.hh). A ResidueType in Rosetta can be a ligand, DNA, amino acid, or basically anything. ResidueTypes are generated through .params files, which are read from the database chemical/residue_types. For ligands, a parameter has to be provided to rosetta through the -extra_res_fa flag. Primary data are set through the residue_io.cc class. The primary data that are set are: atoms, mmatoms, orbitals, and properties of the particular ResidueType. These properties can be modified through patches, which create new ResidueTypes, and are controlled through PatchOperations.cc.
When a ResidueType is initially created, it's created as a MutableResidueType, which represents the data as an atom graph, which facilitates atomistic modification. This class (the plain ResidueType class) is a "finalized" version of the ResidueType, which doesn't permit modification, and is the main class used by most Rosetta simulations. It's created from a MutableResidueType, and for efficiency represents the data as a "struct of vectors" representation.
Correspondingly, the main representation of atoms is different between the classes. Whereas the MutableResidueType uses an opaque "vertex descriptor" to identify atoms, the plain ResidueType class uses an integer index. The order of atoms is well-defined, with heavy atoms coming before hydrogens, and backbone atoms coming before sidechain atoms. (and hydrogens in the same order as the heavyatoms they're connected to).
Properties: Properties of a residue include things like DNA, PROTEIN, CHARGED, etc. These properties indicate the type of residue it is and what properties are associated with the residue. They are set when read in. To add new ResidueProperties, add them to core/chemical/residue_properties/general_properties.list.
Orbitals: Orbitals are indexed separately from atoms. They function much the same way as atoms, except for some key differences. To find atoms bonded to orbitals, you must provide the atom index, not the orbital index. (I haven't figured out how to get the reverse to work because of the separate indices.) Orbital xyz coordinates are not updated when atom coordinates are. This is to keep speed consistent with just having atoms. To output the orbitals, use the flag -output_orbitals.
|
privatedefault |
Referenced by make().
|
private |
Make (most of) a ResidueType from a MutableResidueType Use ResidueType::make() instead.
The construction of a ResidueType from a MutableResidueType happens in several stages
References copy_atom_info(), copy_other_info(), initialize_derived_data(), core::chemical::ResidueTypeBase::name(), setup_atom_ordering(), update_derived_data(), and core::chemical::MutableResidueType::validate_residue_type().
|
privatedelete |
make a copy of this ResidueType
|
override |
destructor
References destruction_obs_hub_.
get index of an atom's second base atom
References abase2_indices_, and atom_base_indices_.
Referenced by core::conformation::Residue::abase2().
|
inline |
indices of atoms as Hbond acceptors
References accpt_pos_.
Referenced by core::conformation::Residue::accpt_pos().
|
inline |
indices of atoms as Hbond acceptors
References accpt_pos_sc_.
Referenced by core::conformation::Residue::accpt_pos_sc().
|
inline |
get indices for atoms used to define actcoord
References actcoord_atoms_indices_.
Referenced by core::conformation::Residue::actcoord_atoms(), core::chemical::MutableResidueType::copy_other_info(), core::conformation::Residue::update_actcoord(), and core::chemical::write_topology_file().
|
inline |
Indices of all backbone atoms, hydrogens and heavyatoms.
References all_bb_atoms_.
Referenced by core::conformation::Residue::all_bb_atoms(), core::scoring::elec::FA_ElecEnergy::backbone_backbone_energy(), core::scoring::elec::FA_ElecEnergy::backbone_sidechain_energy(), core::scoring::sasa::get_sc_bb_sasa(), core::scoring::sasa::get_sc_bb_sasa_per_res(), and protocols::match::MatcherTask::initialize_occupied_space_bounding_box_from_command_line().
|
inline |
Indices of all sidechain atoms, hydrogens and heavyatoms.
References all_sc_atoms_.
Referenced by protocols::simple_moves::chiral::ChiralMover::apply(), core::scoring::elec::FA_ElecEnergy::backbone_sidechain_energy(), protocols::constraint_generator::HydrogenBondConstraintGenerator::compute_valid_atoms(), core::scoring::sasa::get_sc_bb_sasa(), core::scoring::sasa::get_sc_bb_sasa_per_res(), and core::scoring::elec::FA_ElecEnergy::sidechain_sidechain_energy().
get index of an atom's base atom
References atom_base_indices_.
Referenced by core::util::add_constraints_to_metal(), core::conformation::Residue::apply_transform_downstream(), core::conformation::Residue::atom_base(), protocols::sewing::hashing::LigandBindingResPlacer::best_rotamer_for_residue(), core::scoring::hbonds::create_rotamer_descriptor(), core::scoring::disulfides::DisulfideAtomIndices::DisulfideAtomIndices(), core::energy_methods::LinearChainbreakEnergy::do_score_ovp(), protocols::generalized_kinematic_closure::GeneralizedKIC::get_path(), core::pose::rna::get_phosphate_atom_and_neighbor_list(), note_chi_controls_atom(), perform_checks(), core::conformation::Residue::resolve_partial_atom_id(), core::chemical::rna::RNA_Info::rna_note_chi_controls_atom(), core::chemical::rna::RNA_Info::rna_update_last_controlling_chi(), select_orient_atoms(), select_orient_atoms_standard_logic(), core::conformation::Residue::set_chi(), core::conformation::Residue::set_d(), core::conformation::Residue::set_theta(), update_last_controlling_chi(), and core::chemical::ResidueTypeKinWriter::write_restype().
Return the index of the atom that the "atom_shadowing" atom is shadowing; returns zero if the "atom_shadowing" atom is not shadowing anyone.
References atom_shadowed_indices_.
Referenced by core::chemical::MutableResidueType::copy_atom_info(), core::energy_methods::IdealParametersDatabase::create_parameters_for_restype(), core::energy_methods::RingClosureEnergy::eval_residue_derivatives(), core::io::pose_from_sfr::PoseFromSFRBuilder::pass_3_verify_sufficient_backbone_atoms(), core::energy_methods::RingClosureEnergy::residue_energy(), and core::chemical::write_topology_file().
|
inline |
References partial_charge_.
Referenced by core::conformation::Residue::atomic_charge(), core::scoring::sasa::SasaCalc::calc_per_res_sasas(), protocols::ligand_docking::ComputeLigandRDF::compute_rdf(), core::chemical::MutableResidueType::copy_atom_info(), core::scoring::facts::FACTSRsdTypeInfo::initialize_parameters(), core::scoring::PQR::PQR(), core::pose::rna::print_torsion_info(), core::chemical::ResidueDatabaseIO::report_residue_type_atom(), show(), core::scoring::PoissonBoltzmannPotential::write_pqr(), core::chemical::ResidueTypeKinWriter::write_restype(), and core::chemical::write_topology_file().
bool core::chemical::ResidueType::atom_depends_on_connection | ( | core::Size const | atom_index, |
core::Size const | connection_id | ||
) | const |
Does an atom with a given index have an icoor that depends, directly or indirectly, on a particular connection ID?
References atom_depends_on_connection_, atom_index(), n_possible_residue_connections(), and natoms().
Referenced by core::conformation::Conformation::rebuild_residue_connection_dependent_atoms().
bool core::chemical::ResidueType::atom_depends_on_lower_polymeric_connection | ( | core::Size const | atom_index | ) | const |
Does an atom with a given index have an icoor that depends, directly or indirectly, on the lower polymeric connection?
References atom_depends_on_lower_polymeric_connection_, atom_index(), core::chemical::ResidueTypeBase::is_polymer(), and natoms().
Referenced by core::conformation::Residue::atom_depends_on_lower().
bool core::chemical::ResidueType::atom_depends_on_polymeric_connection | ( | core::Size const | atom_index | ) | const |
Does an atom with a given index have an icoor that depends, directly or indirectly, on the upper or lower polymeric connection?
References atom_depends_on_lower_polymeric_connection_, atom_depends_on_upper_polymeric_connection_, atom_index(), core::chemical::ResidueTypeBase::is_polymer(), and natoms().
bool core::chemical::ResidueType::atom_depends_on_upper_polymeric_connection | ( | core::Size const | atom_index | ) | const |
Does an atom with a given index have an icoor that depends, directly or indirectly, on the upper polymeric connection?
References atom_depends_on_upper_polymeric_connection_, atom_index(), core::chemical::ResidueTypeBase::is_polymer(), and natoms().
Referenced by core::conformation::Residue::atom_depends_on_upper().
|
inline |
Does an atom form any inter-residue chemical bonds?
References atom_2_residue_connection_map_.
Referenced by core::conformation::carbohydrates::find_seqpos_of_saccharides_child_residue_at().
bool core::chemical::ResidueType::atom_has_property | ( | Size const | atomno, |
AtomProperty const | property | ||
) | const |
References atomic_properties_.
Referenced by is_virtual(), and core::chemical::Metapatch::meets_requirements().
|
inline |
get atom index by name
References atom_name(), atom_name_to_index_, is_membrane(), core::chemical::ResidueTypeBase::is_protein(), and core::chemical::ResidueTypeBase::name().
Referenced by protocols::rna::movers::RNAThreadAndMinimizeMover::accomodate_length_change(), protocols::cyclic_peptide::crosslinker::OctahedralMetal_Helper::add_angle_constraints(), protocols::cyclic_peptide::crosslinker::SquarePlanarMetal_Helper::add_angle_constraints(), protocols::cyclic_peptide::crosslinker::TetrahedralMetal_Helper::add_angle_constraints(), protocols::cyclic_peptide::crosslinker::TrigonalPlanarMetal_Helper::add_angle_constraints(), protocols::cyclic_peptide::crosslinker::TrigonalPyramidalMetal_Helper::add_angle_constraints(), protocols::relax::add_coordinate_constraint_func_atoms(), protocols::protein_interface_design::movers::add_coordinate_constraints(), protocols::cyclic_peptide::crosslinker::SquarePlanarMetal_Helper::add_dihedral_constraint_to_stream(), protocols::splice::Splice::add_dihedral_constraints(), protocols::splice::SpliceManager::add_dihedral_constraints(), protocols::cyclic_peptide::crosslinker::TrigonalPlanarMetal_Helper::add_dihedral_constraints(), protocols::cyclic_peptide::crosslinker::One_Four_BBMB_Helper::add_linker_asymmetric(), protocols::cyclic_peptide::crosslinker::TBMB_Helper::add_linker_asymmetric(), protocols::cyclic_peptide::crosslinker::One_Four_BBMB_Helper::add_linker_symmetric(), protocols::cyclic_peptide::crosslinker::TBMB_Helper::add_linker_symmetric(), protocols::ligand_docking::ga_ligand_dock::GALigandDock::add_macrocycle_constraints(), protocols::hybridization::add_non_protein_cst(), protocols::stepwise::modeler::align::StepWisePoseAligner::add_to_atom_id_map_after_checks(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::align_and_calculate_rmsd(), protocols::cyclic_peptide::CycpepRigidBodyPermutationMover::align_cycpep_pose_to_original_pose(), protocols::denovo_design::movers::AlignResiduesMover::align_residues(), protocols::hybridization::TMalign::alignment2AtomMap(), core::pack::rotamer_set::WaterAnchorInfo::anchor_atom(), protocols::anchored_design::AnchorMoversData::anchor_noise_constraints_setup(), protocols::cyclic_peptide::CreateAngleConstraint::apply(), protocols::cyclic_peptide::CreateDistanceConstraint::apply(), protocols::cyclic_peptide::CreateTorsionConstraint::apply(), protocols::domain_assembly::AddAssemblyConstraints::apply(), protocols::farnesyl::InstallFarnesylMover::apply(), protocols::farnesyl::SampleFarnesylMover::apply(), protocols::hybridization::DomainAssembly::apply(), protocols::ncbb::ResidueReplacementRebuildMover::apply(), protocols::simple_moves::chiral::ChiralMover::apply(), protocols::antibody::GraftOneCDRLoop::apply(), protocols::antibody_legacy::GraftOneMover::apply(), protocols::constraint_generator::TerminiConstraintGenerator::apply(), protocols::fldsgn::SheetConstraintGenerator::apply(), protocols::fold_from_loops::constraint_generator::AutomaticSheetConstraintGenerator::apply(), protocols::simple_moves::DeclareBond::apply(), protocols::nmr::pre::PREMover::apply(), protocols::stepwise::legacy::modeler::rna::apply_chi_cst(), protocols::enzdes::EnzdesFlexibleRegion::assemble_enzdes_fragdata(), atom_depends_on_connection(), atom_depends_on_lower_polymeric_connection(), atom_depends_on_polymeric_connection(), atom_depends_on_upper_polymeric_connection(), core::conformation::Residue::atom_index(), protocols::constraint_generator::AtomPairConstraintGenerator::atoms_to_constrain(), protocols::dna::DesignProteinBackboneAroundDNA::backrub(), core::scoring::elec::GroupElec::build_groupinfo(), protocols::LoopRebuild::build_loop_with_ccd_closure(), core::io::pose_from_sfr::PoseFromSFRBuilder::build_pdb_info_2_temps(), protocols::stepwise::sampler::rigid_body::RigidBodyStepWiseSampler::calculate_jump(), core::chemical::SetPolymerConnectAtom::changes_connections_on(), core::chemical::ConnectSulfurAndMakeVirtualProton::changes_connections_on(), core::chemical::AddConnectAndTrackingVirt::changes_connections_on(), core::chemical::AddConnectDeleteChildProton::changes_connections_on(), core::pack::guidance_scoreterms::voids_penalty_energy::VoidsPenaltyVoxelGrid::compute_burial(), protocols::fldsgn::MatchResidues::compute_comb(), protocols::frag_picker::scores::GunnCost::compute_gunn(), protocols::simple_moves::GunnCost::compute_gunn(), protocols::flxbb::constraints_NtoC(), protocols::flxbb::constraints_sheet(), core::chemical::RefConvert< core::Size >::convert(), copy_other_info(), protocols::cyclic_peptide::crosslinker::correct_thioether_virtuals(), core::simple_metrics::per_residue_metrics::PerResidueRMSDMetric::create_atom_id_map(), protocols::fldsgn::SheetConstraintGenerator::create_bb_dihedral_constraint(), protocols::constraint_generator::DistanceConstraintGenerator::create_constraint(), protocols::match::Matcher::create_ds_builder(), core::energy_methods::IdealParametersDatabase::create_parameters_for_restype(), protocols::constraint_generator::HydrogenBondConstraintGenerator::create_residue_constraint(), core::conformation::Conformation::detect_disulfides(), core::conformation::symmetry::SymmetricConformation::detect_disulfides(), core::select::util::determine_whether_point_is_buried(), protocols::stepwise::modeler::align::StepWisePoseAligner::do_checks(), protocols::constraint_generator::existing_atoms(), protocols::stepwise::sampler::rna::RNA_KinematicCloser::figure_out_dof_ids_and_offsets(), core::scoring::dssp::fill_hbond_bb_pair_score_dssp(), core::io::pose_from_sfr::PoseFromSFRBuilder::fill_name_map(), protocols::constraint_movers::AddConstraintsToCurrentConformationMover::find_best_anchor(), protocols::denovo_design::DisulfidizeMover::find_current_disulfides(), protocols::abinitio::abscript::fix_mainchain_connect(), protocols::topology_broker::fix_mainchain_connect(), protocols::loops::fix_with_coord_cst(), protocols::constraint_movers::AddConstraintsToCurrentConformationMover::generate_atom_pair_constraints(), protocols::topology_broker::CoordConstraintClaimer::generate_constraints(), protocols::constraint_movers::AddConstraintsToCurrentConformationMover::generate_coordinate_constraints(), core::pose::motif::get_AIDs(), core::io::pose_to_sfr::PoseToStructFileRepConverter::get_connectivity_annotation_info(), core::io::pose_to_sfr::PoseToStructFileRepConverter::get_link_record(), protocols::hybridization::InsertChunkMover::get_local_sequence_mapping(), core::scoring::elec::CountPairRepMap::get_map(), get_metal_binding_atoms(), protocols::jumping::get_pairing_geometry(), core::scoring::dssp::get_pairing_geometry(), protocols::qsar::scoring_grid::ShapeGrid::get_point_score(), core::io::pose_to_sfr::PoseToStructFileRepConverter::get_ssbond_record(), protocols::stepwise::modeler::rna::get_surrounding_O2prime_hydrogen(), protocols::cyclic_peptide::PeptideStubMover::handle_lower_terminus(), protocols::cyclic_peptide::PeptideStubMover::handle_termini_and_store_terminal_dihedrals(), core::chemical::ICoorAtomID::ICoorAtomID(), ideal_xyz(), core::scoring::constraints::BasePairConstraint::init_subsidiary_constraints(), protocols::chemically_conjugated_docking::UBQ_GTPaseMover::initialize(), protocols::match::upstream::UpstreamResTypeGeometry::initialize_from_residue_type(), protocols::stepwise::modeler::StepWiseConnectionSampler::initialize_generic_polymer_bond_sampler(), protocols::noesy_assign::initialize_group_list(), core::scoring::facts::FACTSRsdTypeInfo::initialize_intrascale(), protocols::stepwise::modeler::StepWiseConnectionSampler::initialize_protein_bond_sampler(), core::conformation::Conformation::insert_residue_by_bond(), protocols::simple_filters::JumpEvaluator::JumpEvaluator(), protocols::enzdes::EnzdesFlexibleRegion::minimize_region(), protocols::motifs::Motif::Motif(), core::pose::named_atom_id_to_atom_id(), core::chemical::Selector_UPPER_ATOM::operator[](), core::conformation::Residue::orient_onto_residue(), core::scoring::constraints::ConstraintIO::parse_atom_pair_constraint(), core::scoring::constraints::ConstraintIO::parse_coordinate_constraint(), core::scoring::constraints::parse_NMR_name_old(), protocols::stepwise::modeler::rna::phosphate::PhosphateMover::pass_clash_check(), protocols::anchored_design::AnchoredDesignMover::perturb_anchor(), protocols::cyclic_peptide::CycpepRigidBodyPermutationMover::perturb_cycpep_pose_orientation(), protocols::cyclic_peptide::crosslinker::TMA_Helper::place_tma_asymmetric(), protocols::cyclic_peptide::crosslinker::TMA_Helper::place_tma_symmetric(), core::chemical::pretty_print_atomicoor(), core::import_pose::RNA_JumpMover::random_jump_change(), core::scoring::constraints::ConstraintIO::read_cst_angles(), core::scoring::constraints::ConstraintIO::read_cst_atom_pairs(), core::scoring::constraints::ConstraintIO::read_cst_coordinates(), protocols::constraints_additional::BindingSiteConstraint::read_def(), protocols::constraints_additional::COMCoordinateConstraint::read_def(), core::scoring::constraints::BigBinConstraint::read_def(), protocols::evaluation::PCA::read_structure(), core::io::pose_from_sfr::PoseFromSFRBuilder::refine_pose(), protocols::fibril::reorient_extended_fibril(), core::scoring::constraints::requires_CB_mapping(), protocols::ligand_docking::LigandBaseProtocol::restrain_protein_Calphas(), protocols::symmetry::SymmetrySlider::rg(), core::select::util::select_coord_for_residue(), select_orient_atoms_standard_logic(), protocols::cyclic_peptide::crosslinker::Metal_HelperBase::set_metal_bond_length(), protocols::cyclic_peptide::crosslinker::set_up_thioether_constraints(), protocols::cyclic_peptide::crosslinker::set_up_thioether_variants(), core::pose::copydofs::setup_atom_id_map_match_atom_names(), core::pose::rna::setup_base_pair_constraints(), protocols::rna::denovo::setup_coarse_chainbreak_constraints(), core::energy_methods::GoapRsdType::setup_connectivity(), protocols::simple_moves::CyclizationMover::setup_constraints(), core::scoring::constraints::FabConstraint::setup_csts(), core::scoring::constraints::SiteConstraint::setup_csts(), core::scoring::constraints::SiteConstraintResidues::setup_csts(), core::pose::toolbox::AtomLevelDomainMap::setup_movemap(), core::scoring::cryst::PhenixInterface::stealBfactorsFromFile(), protocols::fldsgn::MatchResidues::superimpose_comb(), core::scoring::superimpose_polymer_heavyatoms(), core::scoring::lDDT_Calculator::lDDT_Cache::swap_indexes(), protocols::denovo_design::movers::RotateSegmentMover::target_atoms(), protocols::chemically_conjugated_docking::ubq_ras_distance(), protocols::chemically_conjugated_docking::ubq_ras_rotation_angle(), and core::chemical::rna::RNA_Info::update_derived_rna_data().
|
inline |
References vec_atom_types_.
Referenced by show(), and update_derived_data().
|
inline |
is a backbone atom (heavy or hydrogen)?
References first_sidechain_hydrogen_, n_backbone_heavyatoms_, natoms(), and nheavyatoms_.
Referenced by core::conformation::Residue::atom_is_backbone(), protocols::cyclic_peptide::PeptideInternalHbondsMetric::count_hbonds(), core::scoring::hbonds::create_rotamer_descriptor(), core::pose::motif::get_backbone_reference_frame_atomids_with_downstream(), core::scoring::orbitals::OrbitalsScore::get_orb_orb_E(), core::scoring::facts::FACTSRsdTypeInfo::initialize_intrascale(), core::conformation::Residue::place(), core::chemical::ResidueDatabaseIO::report_residue_type_atom(), core::scoring::constraints::requires_CB_mapping(), select_orient_atoms_standard_logic(), core::scoring::lkball::setup_water_builders_for_residue_type(), and core::scoring::orbitals::surrogate_atom_for_orbital().
|
inline |
quick lookup: is the atom with the given index a hydrogen or not? Atoms are sorted so that heavy atoms come first and hydrogen atoms come last.
References natoms(), and nheavyatoms_.
Referenced by protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::align_and_calculate_rmsd(), protocols::helical_bundle_predict::HelicalBundlePredictApplication::align_to_native_pose(), protocols::cyclic_peptide::SymmetricCycpepAlign::align_to_origin(), core::conformation::Residue::atom_is_hydrogen(), core::chemical::AddConnectDeleteChildProton::changes_connections_on(), core::energy_methods::YHHPlanarityEnergy::defines_score_for_rsd(), core::pose::motif::get_backbone_reference_frame_atomids_with_downstream(), core::scoring::is_protein_sidechain_heavyatom(), core::conformation::Residue::place(), core::io::pose_from_sfr::PoseFromSFRBuilder::refine_pose(), show(), and core::scoring::superimpose_polymer_heavyatoms().
|
inline |
References vec_atom_types_.
Referenced by core::conformation::Residue::atom_is_polar_hydrogen(), core::scoring::elec::GroupElec::build_groupinfo(), protocols::cyclic_peptide::PeptideInternalHbondsMetric::count_hbonds(), core::pose::motif::get_backbone_reference_frame_atomids_with_downstream(), core::scoring::sasa::SasaMethod::is_polar_atom(), and show().
|
inline |
|
inline |
get atom name by index
References atom_names_, core::chemical::ResidueTypeBase::name(), and core::id::to_string().
Referenced by protocols::cyclic_peptide::crosslinker::OctahedralMetal_Helper::add_angle_constraints(), protocols::cyclic_peptide::crosslinker::SquarePlanarMetal_Helper::add_angle_constraints(), protocols::cyclic_peptide::crosslinker::TetrahedralMetal_Helper::add_angle_constraints(), protocols::cyclic_peptide::crosslinker::TrigonalPlanarMetal_Helper::add_angle_constraints(), protocols::cyclic_peptide::crosslinker::TrigonalPyramidalMetal_Helper::add_angle_constraints(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::add_bondangle_perturbation(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::add_bondlength_perturbation(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::add_closebond_logic_isopeptide(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::add_closebond_logic_thioether_lariat(), protocols::cyclic_peptide::crosslinker::SquarePlanarMetal_Helper::add_dihedral_constraint_to_stream(), protocols::cyclic_peptide::crosslinker::TrigonalPlanarMetal_Helper::add_dihedral_constraints(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::align_and_calculate_rmsd(), protocols::cyclic_peptide::CycpepRigidBodyPermutationMover::align_cycpep_pose_to_original_pose(), protocols::stepwise::monte_carlo::mover::AddMover::append_residue(), protocols::helical_bundle::FitSimpleHelix::apply(), protocols::metal_interface::RemoveMetalConnectionsMover::apply(), protocols::simple_moves::chiral::ChiralMover::apply(), protocols::backrub::BackrubMover::apply(), core::pose::rna::RNA_IdealCoord::apply_coords(), atom_index(), core::conformation::Residue::atom_name(), core::chemical::Metapatch::atoms(), protocols::rna::denovo::coarse::CoarseRNA_LoopCloser::backtrack(), protocols::stepwise::modeler::rna::base_atoms_square_deviation(), protocols::sewing::hashing::LigandBindingResPlacer::best_rotamer_for_residue(), branch_connect_atom_names(), protocols::stepwise::sampler::rigid_body::RigidBodyStepWiseSampler::calculate_jump(), core::scoring::SplitUnfoldedTwoBodyPotential::calculate_residue_emap(), protocols::denovo_design::connection::AreConnectablePredicate::check_distance(), core::scoring::rna::data::RNA_DMS_Potential::check_hbonded(), protocols::stepwise::modeler::align::StepWisePoseAligner::check_matching_atom_names(), core::chemical::rna::chi1_torsion_atom(), core::pack::guidance_scoreterms::voids_penalty_energy::VoidsPenaltyVoxelGrid::compute_burial(), core::chemical::MutableResidueType::copy_atom_info(), protocols::stepwise::modeler::protein::StepWiseProteinBackboneSampler::copy_coords(), core::simple_metrics::per_residue_metrics::PerResidueRMSDMetric::create_atom_id_map(), protocols::stepwise::modeler::align::StepWisePoseAligner::create_coordinate_constraint_atom_id_map(), core::scoring::ResidueExclParams::create_excl_info(), core::energy_methods::IdealParametersDatabase::create_parameters_for_restype(), debug_dump_icoor(), core::chemical::rna::default_jump_atom(), core::conformation::Conformation::detect_bonds(), core::conformation::Conformation::detect_pseudobonds(), protocols::stepwise::modeler::align::StepWisePoseAligner::do_checks(), core::scoring::methods::dfire::DFIRE_Potential::eval_dfire_pair_energy(), core::pack::figure_out_repackable_residues(), core::io::pose_from_sfr::PoseFromSFRBuilder::fill_name_map(), core::io::silent::BinarySilentStruct::fill_struct(), core::chemical::find_best_match(), core::chemical::rna::first_base_atom(), core::conformation::form_disulfide(), core::chemical::formatted_icoord_tree(), protocols::cyclic_peptide::CycpepRigidBodyPermutationMover::generate_cycpep_pose_copy(), core::energy_methods::IdealParametersDatabase::generate_impropers_map_res(), protocols::stepwise::modeler::align::StepWisePoseAligner::get_calc_rms_atom_id_map(), core::io::pose_to_sfr::PoseToStructFileRepConverter::get_link_record(), protocols::stepwise::modeler::rna::checker::RNA_VDW_BinChecker::get_matching_res_in_VDW_rep_screen_pose(), core::chemical::rna::get_rna_base_centroid(), protocols::stepwise::modeler::align::StepWisePoseAligner::get_root_triad_atom_id_map(), has(), core::chemical::heavy_atom_names_match(), protocols::denovo_design::components::StructureDataFactory::infer_from_pose(), core::pose::rna::initialize_atoms_for_which_we_need_new_dofs(), core::pose::toolbox::AtomID_Mapper::initialize_from_pose(), core::scoring::facts::FACTSRsdTypeInfo::initialize_intrascale(), core::scoring::facts::FACTSRsdTypeInfo::initialize_parameters(), core::pose::rna::is_cutpoint_closed_atom(), core::energy_methods::IdealParametersDatabase::lookup_angle_legacy(), core::energy_methods::IdealParametersDatabase::lookup_bondangle_buildideal(), core::energy_methods::IdealParametersDatabase::lookup_bondlength_buildideal(), core::energy_methods::IdealParametersDatabase::lookup_length_legacy(), core::energy_methods::IdealParametersDatabase::lookup_torsion_legacy(), core::pose::make_pose_from_sequence(), core::pose::MiniPose::MiniPose(), protocols::drug_design::ConformationSelectionToRDMol::Mol(), protocols::stepwise::modeler::rna::StepWiseRNA_CombineLongLoopFilterer::moving_res_contact_filter(), core::chemical::ICoorAtomID::name(), core::conformation::Residue::orient_onto_residue(), protocols::stepwise::modeler::align::StepWisePoseAligner::output_atom_id_map(), protocols::dna::PDBOutput::output_buried_unsatisfied_hbonds(), core::io::pose_from_sfr::PoseFromSFRBuilder::pass_3_verify_sufficient_backbone_atoms(), perform_checks(), core::conformation::Residue::place(), protocols::stepwise::monte_carlo::mover::AddMover::prepend_residue(), protocols::cyclic_peptide::PeptideStubMover::preserve_old_mainchain_torsions(), core::chemical::pretty_print_atomicoor(), protocols::stepwise::modeler::rna::print_atom_info(), print_bondangles(), protocols::ligand_docking::print_buried_unsat_Hbonds(), core::chemical::print_chis(), protocols::rna::denovo::print_hbonds(), protocols::stepwise::modeler::rna::print_individual_atom_info(), protocols::rna::denovo::print_internal_coords(), core::conformation::print_node(), protocols::match::output::print_node(), print_pretty_path_distances(), protocols::stepwise::modeler::rna::print_torsion_info(), core::pose::rna::print_torsion_info(), protocols::denovo_design::rebuild_missing_atoms(), core::io::pose_from_sfr::PoseFromSFRBuilder::refine_pose(), core::io::pose_from_sfr::remap_names_on_geometry(), core::pose::toolbox::AtomID_Mapper::renumber_after_variant_changes(), core::chemical::ResidueDatabaseIO::report_residue_type_atom(), core::chemical::ResidueDatabaseIO::report_residue_type_icoor(), core::scoring::methods::MMBondAngleEnergy::score_atom_centrally(), core::scoring::mm::score_atom_centrally(), core::io::pose_from_sfr::score_mapping(), protocols::hybridization::InsertChunkMover::set_bb_xyz_aligned(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::set_up_cterm_isopeptide_cyclization_mover(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::set_up_nterm_isopeptide_cyclization_mover(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::set_up_sidechain_isopeptide_cyclization_mover(), protocols::cyclic_peptide::crosslinker::set_up_thioether_bond_mover(), core::pose::copydofs::setup_atom_id_map_match_atom_names(), core::scoring::lkball::LKBallDatabase::setup_atom_weights(), core::energy_methods::GoapRsdType::setup_connectivity(), core::pose::carbohydrates::setup_existing_glycans(), protocols::stepwise::legacy::modeler::rna::StepWiseWorkingParametersSetup::setup_fold_tree(), protocols::stepwise::modeler::rna::setup_suite_atom_id_map(), core::scoring::lkball::setup_water_builders_for_residue_type(), show(), core::scoring::constraints::AngleConstraint::show_violations(), core::scoring::constraints::AmbiguousNMRDistanceConstraint::show_violations(), core::scoring::constraints::AtomPairConstraint::show_violations(), core::scoring::constraints::CoordinateConstraint::show_violations(), core::scoring::constraints::DihedralConstraint::show_violations(), core::scoring::constraints::DihedralPairConstraint::show_violations(), core::scoring::constraints::DistancePairConstraint::show_violations(), core::scoring::constraints::LocalCoordinateConstraint::show_violations(), core::scoring::superimpose_polymer_heavyatoms(), core::chemical::rna::RNA_Info::update_derived_rna_data(), protocols::magnesium::update_mg_hoh_fold_tree(), protocols::stepwise::modeler::align::StepWisePoseAligner::update_superimpose_atom_id_map(), protocols::stepwise::modeler::rna::checker::RNA_VDW_BinChecker::update_VDW_screen_bin(), core::chemical::ResidueTypeKinWriter::write_restype(), and core::chemical::write_topology_file().
|
inline |
Get the AtomicProperities object for the atom. (Note this is only the manually set properties, not all the properties of the atom.)
References atomic_properties_.
Referenced by core::chemical::MutableResidueType::copy_atom_info().
Get the chemical atom_type for this atom by it index number in this residue.
If we want the atom_type index (integer), we get this from the conformation::Atom itself, as seen in the code below
References vec_atom_types_.
Referenced by protocols::simple_moves::ConstrainToIdealMover::add_bond_angle_constraint(), protocols::simple_moves::ConstrainToIdealMover::add_bond_dihedral_constraint(), protocols::simple_moves::ConstrainToIdealMover::add_bond_length_constraint(), protocols::simple_moves::chiral::ChiralMover::apply(), protocols::generalized_kinematic_closure::filter::GeneralizedKICfilter::apply_loop_bump_check(), core::conformation::Residue::atom_type(), core::scoring::elec::GroupElec::build_groupinfo(), protocols::rna::movers::bump_check(), core::scoring::SplitUnfoldedTwoBodyPotential::calculate_residue_emap(), core::chemical::AutomorphismIterator::can_pair(), core::pack::interaction_graph::SurfacePotential::compute_pose_hpatch_score(), protocols::ligand_docking::ComputeLigandRDF::compute_rdf(), protocols::constraint_generator::HydrogenBondConstraintGenerator::compute_valid_atoms(), core::chemical::MutableResidueType::copy_atom_info(), protocols::motif_grafting::movers::MotifGraftMover::count_clashes_between_two_poses(), core::io::pose_to_sfr::PoseToStructFileRepConverter::determine_atom_indices(), core::scoring::methods::MMBondAngleEnergy::eval_atom_derivative(), core::scoring::methods::MMBondLengthEnergy::eval_atom_derivative(), core::scoring::methods::MMBondAngleEnergy::eval_intrares_energy(), core::scoring::methods::MMBondLengthEnergy::eval_intrares_energy(), core::pack::figure_out_repackable_residues(), core::scoring::orbitals::OrbitalsScore::get_E_haro_one_way(), core::scoring::orbitals::OrbitalsScore::get_E_hpol_one_way(), core::scoring::orbitals::OrbitalsScore::get_orb_orb_E(), core::io::pose_to_sfr::PoseToStructFileRepConverter::grab_conect_records_for_atom(), core::scoring::facts::FACTSRsdTypeInfo::initialize_intrascale(), core::scoring::facts::FACTSRsdTypeInfo::initialize_parameters(), protocols::features::HBondFeatures::insert_hbond_dehydron_row(), is_repulsive(), core::conformation::Residue::is_repulsive(), is_virtual(), core::conformation::Residue::is_virtual(), protocols::ligand_docking::rdf::RDFBinaryOrbitalFunction::operator()(), protocols::stepwise::modeler::rna::phosphate_base_phosphate_square_deviation(), print_bondangles(), core::conformation::print_node(), protocols::match::output::print_node(), core::pose::rna::print_torsion_info(), protocols::pose_metric_calculators::SemiExplicitWaterUnsatisfiedPolarsCalculator::recompute(), protocols::simple_pose_metric_calculators::BuriedUnsatisfiedPolarsCalculator::recompute(), protocols::features::AtomAtomPairFeatures::report_atom_pairs(), core::chemical::ResidueDatabaseIO::report_residue_type_atom(), core::scoring::methods::MMBondLengthEnergy::residue_pair_energy(), core::pack::interaction_graph::HPatchBackgroundNode< V, E, G >::set_rotamer(), core::pack::interaction_graph::HPatchNode< V, E, G >::set_rotamers(), core::scoring::lkball::LKBallDatabase::setup_atom_weights(), core::scoring::lkball::setup_water_builders_for_residue_type(), protocols::buns::BuriedUnsatisfiedPolarsCalculator2::single_bunsat_thorough_check(), core::chemical::ResidueTypeKinWriter::write_restype(), and core::chemical::write_topology_file().
|
inline |
References vec_atom_type_indexes_.
Referenced by protocols::match::bump_grid_to_enclose_pose(), copy_atom_info(), core::scoring::ResidueExclParams::create_excl_info(), core::pose::rna::print_torsion_info(), protocols::features::AtomAtomPairFeatures::report_atom_pairs(), core::conformation::Residue::Residue(), and show().
bool core::chemical::ResidueType::atoms_are_bonded | ( | core::Size const | atom_index1, |
core::Size const | atom_index2 | ||
) | const |
Indicates whether or not two atom indices have a chemical bond linking them.
Note that this assumes that the Rosetta machinery is set up so that if atom 1 is bonded to atom 2, atom 2 is bonded to atom 1. This function breaks if that assumption breaks.
References nbrs().
Referenced by core::conformation::Conformation::atoms_are_bonded(), and core::conformation::get_second_atom_from_connection().
|
inline |
Read access to the atoms_last_controlled_by_chi_ array.
References atoms_last_controlled_by_chi_.
Referenced by protocols::match::upstream::UpstreamResTypeGeometry::initialize_from_residue_type(), and core::chemical::rna::RNA_Info::update_derived_rna_data().
|
inline |
Read access to the Atoms last controlled by a particular chi.
References atoms_last_controlled_by_chi_.
|
inline |
|
inline |
Returns a list of those atoms within one bond of a residue connection. For residue connection i, its position in this array is a list of pairs of atom-id's, the first of which is always the id for the atom forming residue connection i.
References atoms_within_one_bond_of_a_residue_connection_.
Referenced by core::energy_methods::IdealParametersDatabase::create_parameters_for_restype(), core::scoring::methods::MMBondAngleEnergy::eval_atom_derivative(), core::scoring::methods::MMTorsionEnergy::eval_atom_derivative(), core::energy_methods::CartesianBondedEnergy::eval_interresidue_angle_derivs_two_from_rsd1(), core::energy_methods::CartesianBondedEnergy::eval_interresidue_angle_derivs_two_from_rsd2(), core::energy_methods::CartesianBondedEnergy::eval_interresidue_angle_energies_two_from_rsd1(), core::energy_methods::CartesianBondedEnergy::eval_interresidue_angle_energies_two_from_rsd2(), core::scoring::methods::MMTorsionEnergy::eval_intrares_derivatives(), core::scoring::GenericBondedPotential::eval_residue_pair_energy_and_derivative_angle(), core::scoring::GenericBondedPotential::eval_residue_pair_energy_and_derivative_improper(), core::scoring::GenericBondedPotential::eval_residue_pair_energy_and_derivative_torsion(), protocols::features::ProteinBondGeometryFeatures::report_interres_angles(), core::scoring::methods::MMBondAngleEnergy::residue_pair_energy(), core::scoring::methods::MMTorsionEnergy::residue_pair_energy(), and protocols::simple_moves::CyclizationMover::setup_constraints().
|
inline |
Returns the list of those atoms within two bonds of residue connection # resconn. Each entry in this list is a triple of atom-id's, the first of which is always the id for the atom forming residue connection resconn.
References atoms_within_two_bonds_of_a_residue_connection_.
Referenced by core::scoring::methods::MMTorsionEnergy::eval_atom_derivative(), core::scoring::methods::MMTorsionEnergy::eval_intrares_derivatives(), core::scoring::GenericBondedPotential::eval_residue_pair_energy_and_derivative_torsion(), core::scoring::methods::MMTorsionEnergy::residue_pair_energy(), and protocols::simple_moves::CyclizationMover::setup_constraints().
|
inline |
attach RestypeDestructionEvent observer function
fn | pointer to observer's unary member function with signature void( RestypeDestructionEvent const & ) |
ptr | RAW pointer to observer object |
References destruction_obs_hub_.
Referenced by core::scoring::elec::CountPairRepMap::get_map(), core::scoring::facts::FACTSRsdTypeMap::get_type_info(), core::scoring::lkball::LKBallDatabase::initialize_residue_type(), core::energy_methods::IdealParametersDatabase::parameters_for_restype(), and core::scoring::custom_pair_distance::PairFuncMap::set_atom_pair_func().
|
inline |
for all heavy atoms, index numbers of their first attached Hydrogen
References attached_H_begin_.
Referenced by core::conformation::Residue::attached_H_begin(), core::scoring::dssp::fill_hbond_bb_pair_score_dssp(), protocols::stepwise::modeler::polar_hydrogens::PolarHydrogenPacker::get_possible_hbond_acceptors(), protocols::minimization_packing::MinimalRotamer::has_ideal_geometry(), protocols::pose_metric_calculators::SemiExplicitWaterUnsatisfiedPolarsCalculator::recompute(), protocols::simple_pose_metric_calculators::NumberHBondsCalculator::recompute(), protocols::minimization_packing::MinimalRotamer::record_internal_geometry(), and core::scoring::orbitals::surrogate_atom_for_orbital().
index number of the first attached Hydrogen on an atom
References attached_H_begin_.
|
inline |
for all heavy atoms, index numbers of their last attached Hydrogen
References attached_H_end_.
Referenced by core::conformation::Residue::attached_H_end(), core::scoring::dssp::fill_hbond_bb_pair_score_dssp(), protocols::stepwise::modeler::polar_hydrogens::PolarHydrogenPacker::get_possible_hbond_acceptors(), protocols::minimization_packing::MinimalRotamer::has_ideal_geometry(), protocols::pose_metric_calculators::SemiExplicitWaterUnsatisfiedPolarsCalculator::recompute(), protocols::simple_pose_metric_calculators::NumberHBondsCalculator::recompute(), and protocols::minimization_packing::MinimalRotamer::record_internal_geometry().
index number of the last attached Hydrogen on an atom
References attached_H_end_.
|
private |
If a ring has been added but no nu angles have been defined, automatically assign them.
If a ring has been added but no nu angles have been defined, automatically assign them.
Don't even bother trying if there are multiple rings. The creator of the .params file needs to add the definitions manually.
References n_nus(), n_rings(), nu_atoms(), nu_atoms_, ring_atoms(), and ring_atoms_.
Referenced by copy_other_info().
BondRingness core::chemical::ResidueType::bond_ringness | ( | core::Size const | atomindex1, |
core::Size const | atomindex2 | ||
) | const |
Returns whether the bond between the atoms is in a ring. Will return UnknownRingness for something which isn't bonded.
References bonded_neighbor_, bonded_neighbor_ringness_, and core::chemical::UnknownRingness.
Referenced by core::chemical::MutableResidueType::copy_atom_info(), core::scoring::GenericBondedPotential::eval_residue_energy_and_derivative_torsion(), core::scoring::GenericBondedPotential::eval_residue_pair_energy_and_derivative_torsion(), protocols::ligand_docking::ga_ligand_dock::LigandConformer::update_conf(), protocols::ligand_docking::ga_ligand_dock::LigandConformer::update_ligand_conf(), and protocols::ligand_docking::ga_ligand_dock::LigandConformer::update_ligchi_types().
BondName core::chemical::ResidueType::bond_type | ( | core::Size const | atomindex1, |
core::Size const | atomindex2 | ||
) | const |
Returns the type of bond between the atoms Will return UnknownBond for something which isn't bonded.
References bonded_neighbor_, bonded_neighbor_type_, and core::chemical::UnknownBond.
Referenced by core::chemical::MutableResidueType::copy_atom_info(), core::scoring::GenericBondedPotential::eval_residue_energy_and_derivative_torsion(), core::scoring::GenericBondedPotential::eval_residue_pair_energy_and_derivative_torsion(), core::energy_methods::IdealParametersDatabase::generate_impropers_map_res(), core::io::pose_to_sfr::PoseToStructFileRepConverter::grab_conect_records_for_atom(), protocols::ligand_docking::ga_ligand_dock::LigandAligner::perturb_lig(), protocols::ligand_docking::ga_ligand_dock::perturb_ligand_torsions(), protocols::ligand_docking::ga_ligand_dock::LigandAligner::randomize_lig(), protocols::ligand_docking::ga_ligand_dock::LigandConformer::update_conf(), protocols::ligand_docking::ga_ligand_dock::LigandConformer::update_ligand_conf(), protocols::ligand_docking::ga_ligand_dock::LigandConformer::update_ligchi_types(), and core::chemical::write_topology_file().
|
inline |
Return the indices for the set of atoms that define a particular intraresidue angle.
References bondangle_atom_sets_.
Referenced by core::energy_methods::IdealParametersDatabase::create_parameters_for_restype(), core::scoring::methods::MMBondAngleEnergy::eval_atom_derivative(), core::scoring::methods::MMBondAngleEnergy::eval_intrares_energy(), core::scoring::GenericBondedPotential::eval_residue_energy_and_derivative_angle(), core::scoring::mm::MMBondAngleResidueTypeParam::init(), and protocols::features::ProteinBondGeometryFeatures::report_intrares_angles().
|
inline |
Returns the list of all of the indices of all the intraresidue bond angles a particular atom is involved in. Useful for calculating the derivatives for an atom.
References bondangles_for_atom_.
Referenced by core::scoring::methods::MMBondAngleEnergy::eval_atom_derivative().
AtomIndices const & core::chemical::ResidueType::bonded_neighbor | ( | Size const | atomno | ) | const |
indices of the bonded neighbors for an atom
References bonded_neighbor_.
Referenced by protocols::simple_moves::chiral::ChiralMover::apply(), core::conformation::Residue::apply_transform_downstream(), core::conformation::Residue::bonded_neighbor(), core::scoring::sasa::SasaCalc::calc_per_res_sasas(), define_mainchain_atoms(), core::energy_methods::IdealParametersDatabase::generate_impropers_map_res(), core::scoring::mm::MMBondAngleResidueTypeParam::init(), initialize_derived_data(), protocols::drug_design::ConformationSelectionToRDMol::Mol(), core::conformation::Residue::nbrs(), nbrs(), note_chi_controls_atom(), number_bonded_heavyatoms(), core::chemical::ResidueDatabaseIO::report_residue_type_bond(), core::chemical::rna::RNA_Info::rna_note_chi_controls_atom(), core::chemical::rna::RNA_Info::rna_update_last_controlling_chi(), core::io::pose_from_sfr::score_mapping(), select_orient_atoms(), select_orient_atoms_standard_logic(), core::scoring::orbitals::surrogate_atom_for_orbital(), update_derived_data(), update_last_controlling_chi(), and core::chemical::ResidueTypeKinWriter::write_restype().
utility::vector1< BondRingness > const & core::chemical::ResidueType::bonded_neighbor_ringnesses | ( | Size const | atomno | ) | const |
References bonded_neighbor_ringness_.
Referenced by protocols::drug_design::ConformationSelectionToRDMol::Mol().
|
inline |
indices of the orbitals bonded to an atom
References bonded_orbitals_.
Referenced by core::conformation::Residue::assign_orbitals(), core::conformation::Residue::bonded_orbitals(), core::chemical::MutableResidueType::copy_atom_info(), and core::conformation::Residue::update_orbital_coords().
utility::vector1< std::pair< core::Size, core::Size > > core::chemical::ResidueType::bonds | ( | ) | const |
Returns a list of all pairs of atoms which are bonded. This returned list should only have only one entry per bond (So [1,2] and [2,1] will not both be present.)
References bonded_neighbor_, and nbonds_.
Referenced by core::chemical::MutableResidueType::copy_atom_info(), core::energy_methods::IdealParametersDatabase::generate_impropers_map_res(), core::io::pose_from_sfr::remap_names_on_geometry(), and core::io::pose_from_sfr::score_mapping().
utility::vector1< std::string > core::chemical::ResidueType::branch_connect_atom_names | ( | ) | const |
Return a list of names of atoms at non-polymer connections.
References atom_name(), and branch_connect_atoms().
Referenced by core::pose::append_pose_with_glycan_residues(), and show().
utility::vector1< uint > core::chemical::ResidueType::branch_connect_atoms | ( | ) | const |
Return a list of indices of atoms at non-polymer connections.
References lower_connect_id_, n_non_polymeric_residue_connections_, n_possible_residue_connections(), residue_connect_atom_index(), and upper_connect_id_.
Referenced by branch_connect_atom_names().
core::chemical::carbohydrates::CarbohydrateInfoCOP core::chemical::ResidueType::carbohydrate_info | ( | ) | const |
Return the CarbohydrateInfo object containing sugar-specific properties for this residue.
References carbohydrate_info_.
Referenced by protocols::carbohydrates::LinkageConformerMover::apply(), core::conformation::Residue::carbohydrate_info(), core::pose::Pose::chain_sequence(), and core::pack::palette::PackerPalette::saccharide_backbones_are_compatible().
References chi_2_proton_chi_.
Referenced by core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::chisamples_for_rotamer_and_chi(), core::chemical::MutableResidueType::copy_other_info(), protocols::match::upstream::FullChiSampleSet::expand_non_dunbrack_chi(), and protocols::rotamer_recovery::RRComparerChiDiff::measure_rotamer_recovery().
|
inline |
indices of the atoms which are used to define all the chi angles
References chi_atoms_.
Referenced by perform_checks(), and update_last_controlling_chi().
|
inline |
indices of the atoms which are used to define a given chi angle (chino)
References chi_atoms_.
Referenced by protocols::minimization_packing::MinimalRotamer::atom_is_ideal(), protocols::stepwise::modeler::polar_hydrogens::check_if_proton_chi_atom(), protocols::simple_moves::check_if_proton_chi_atom(), core::chemical::rna::chi1_torsion_atom_index(), core::conformation::Residue::chi_atoms(), protocols::minimization_packing::MinimalRotamer::chi_matches_coords(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::chisamples_for_rotamer_and_chi(), core::chemical::MutableResidueType::copy_other_info(), core::energy_methods::YHHPlanarityEnergy::defines_score_for_rsd(), protocols::stepwise::modeler::align::StepWisePoseAligner::do_checks(), core::pack::rotamers::SingleBasicRotamerLibrary::fill_rotamer_vector(), core::chemical::rna::first_base_atom_index(), protocols::match::upstream::FullChiSampleSet::FullChiSampleSet(), protocols::match::upstream::UpstreamResTypeGeometry::initialize_from_residue_type(), protocols::ligand_docking::ga_ligand_dock::LigandAligner::perturb_lig(), protocols::ligand_docking::ga_ligand_dock::perturb_ligand_torsions(), core::chemical::print_chis(), protocols::ligand_docking::ga_ligand_dock::LigandAligner::randomize_lig(), core::chemical::ResidueDatabaseIO::report_residue_type_chi(), core::conformation::Residue::Residue(), core::chemical::rna::RNA_Info::rna_update_last_controlling_chi(), core::conformation::Residue::set_chi(), core::conformation::Residue::set_d(), core::conformation::Residue::set_theta(), protocols::ligand_docking::ResidueTorsionRestraints::setup_constraints(), protocols::stepwise::legacy::modeler::rna::StepWiseWorkingParametersSetup::setup_fold_tree(), protocols::ligand_docking::torsion_constraints_from_mean_sd(), core::chemical::rna::RNA_Info::update_derived_rna_data(), core::chemical::ResidueTypeKinWriter::write_restype(), and core::chemical::write_topology_file().
|
inline |
all rotamers bins (mean, std) for a given chi angle
References chi_rotamers_.
Referenced by core::conformation::Residue::chi_rotamers(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::chisamples_for_rotamer_and_chi(), core::chemical::MutableResidueType::copy_other_info(), protocols::ligand_docking::get_ligand_torsion_constraints(), core::pack::dunbrack::SingleResidueDunbrackLibrary::n_rotamer_bins_for_aa(), core::chemical::ResidueDatabaseIO::report_residue_type_chi_rotamer(), protocols::ligand_docking::torsion_constraints_from_chi_rotamers(), and core::chemical::write_topology_file().
|
privatedelete |
make a copy
|
private |
Iterate through the atoms, filling out the various atom info vectors.
This function updates most of the atomistic data in the ResidueType, by iterating over the atoms in the proper order
References accpt_pos_, accpt_pos_sc_, core::chemical::MutableResidueType::all_atoms(), all_bb_atoms_, all_sc_atoms_, core::chemical::MutableResidueType::atom(), core::chemical::AtomType::atom_has_orbital(), core::chemical::MutableResidueType::atom_index(), atom_name_to_index_, atom_names_, core::chemical::Atom::atom_type_index(), atom_type_index(), core::chemical::ResidueTypeBase::atom_type_set(), core::chemical::ResidueTypeBase::atom_type_set_ptr(), atomic_properties_, atoms_with_orb_index_, core::chemical::MutableResidueType::bond(), core::chemical::Bond::bond_name(), bonded_neighbor_, bonded_neighbor_ringness_, bonded_neighbor_type_, core::chemical::MutableResidueType::bonded_neighbors(), core::chemical::Atom::bonded_orbitals(), bonded_orbitals_, core::chemical::Atom::charge(), core::chemical::Bond::cut_bond(), cut_bond_neighbor_indices_, core::chemical::Atom::element_type(), elements_, first_sidechain_hydrogen_, core::chemical::Atom::formal_charge(), formal_charge_, core::chemical::Atom::gasteiger_atom_type(), gasteiger_atom_type_index_, core::chemical::ResidueTypeBase::gasteiger_atom_typeset(), Haro_index_, heavyatom_has_polar_hydrogens_, Hpol_index_, Hpos_apolar_, Hpos_polar_, Hpos_polar_sc_, core::chemical::Atom::ideal_xyz(), ideal_xyz_, core::chemical::AtomType::is_acceptor(), core::chemical::AtomType::is_donor(), core::chemical::AtomType::is_haro(), core::chemical::AtomType::is_hydrogen(), core::chemical::AtomType::is_polar_hydrogen(), core::chemical::AtomType::is_virtual(), core::chemical::Atom::is_virtual(), mass_, mm_atom_type_index_, core::chemical::ResidueTypeBase::mm_atom_types_ptr(), core::chemical::Atom::mm_name(), n_backbone_heavyatoms_, n_hbond_acceptors_, n_hbond_donors_, core::chemical::Atom::name(), core::chemical::ResidueTypeBase::name(), natoms_, nbonds_, partial_charge_, core::chemical::Atom::properties(), core::chemical::Bond::ringness(), core::chemical::TR(), vec_atom_type_indexes_, and vec_atom_types_.
Referenced by ResidueType().
|
private |
Fill in various other information which is being copied over from the MutableResidueType.
References abase2_indices_, accpt_pos_, core::chemical::MutableResidueType::actcoord_atoms(), actcoord_atoms_indices_, core::chemical::MutableResidueType::all_atoms(), core::chemical::MutableResidueType::atom(), atom_2_residue_connection_map_, core::chemical::ResidueTypeBase::atom_aliases(), atom_base_indices_, atom_index(), core::chemical::MutableResidueType::atom_index(), atom_name_to_index_, atom_names_, atom_shadowed_indices_, auto_assign_nu_atoms(), bonded_neighbor_, chi_2_proton_chi_, core::chemical::MutableResidueType::chi_atom_vds(), chi_atoms_, core::chemical::MutableResidueType::chi_rotamers(), chi_rotamers_, core::chemical::MutableICoorRecord::d(), define_mainchain_atoms(), core::chemical::MutableResidueType::get_atom_name_to_vd_map(), core::chemical::Atom::icoor(), core::chemical::MutableResidueConnection::icoor(), icoor_, core::chemical::MutableResidueType::is_proton_chi(), is_proton_chi_, core::chemical::MutableResidueType::low_ring_conformers(), low_ring_conformers_, core::chemical::MutableResidueType::lower_connect_id(), lower_connect_id_, core::chemical::MutableResidueType::lowest_ring_conformer(), lowest_ring_conformer_, core::chemical::MutableResidueType::mainchain_atoms(), mainchain_atoms_indices_, n_non_polymeric_residue_connections_, core::chemical::MutableResidueType::n_nus(), core::chemical::MutableResidueType::n_polymeric_residue_connections(), n_polymeric_residue_connections_, core::chemical::MutableResidueType::n_possible_residue_connections(), core::chemical::MutableResidueType::n_proton_chi(), core::chemical::MutableResidueType::n_rings(), core::chemical::ResidueTypeBase::name(), core::chemical::MutableResidueType::natoms(), natoms_, nbr_atom_, core::chemical::MutableResidueType::nbr_radius(), nbr_radius_, core::chemical::MutableResidueType::nbr_vertex(), nbrs(), core::chemical::MutableResidueType::nchi(), core::chemical::MutableResidueType::nu_atoms(), nu_atoms_, core::scoring::pair, core::chemical::MutableICoorRecord::phi(), proton_chi_extra_samples_, core::chemical::MutableResidueType::proton_chi_extra_samples_for_chi(), proton_chi_samples_, core::chemical::MutableResidueType::proton_chi_samples_for_chi(), proton_chis_, core::chemical::MutableResidueType::residue_connection(), residue_connections_, core::chemical::MutableResidueType::ring_atoms(), ring_atoms_, core::chemical::MutableResidueType::ring_saturation_type(), ring_saturation_types_, core::chemical::MutableResidueType::root_atom(), root_atom_, core::chemical::MutableResidueType::shadow_atoms(), core::chemical::MutableICoorRecord::stub_atom1(), core::chemical::MutableICoorRecord::stub_atom2(), core::chemical::MutableICoorRecord::stub_atom3(), core::chemical::MutableICoorRecord::theta(), core::id::to_string(), core::chemical::MutableResidueType::upper_connect_id(), upper_connect_id_, and core::chemical::MutableResidueConnection::vertex().
Referenced by ResidueType().
|
inline |
indices of the bonded neighbors for an atom
References cut_bond_neighbor_indices_.
Referenced by core::chemical::MutableResidueType::copy_atom_info(), core::conformation::Residue::cut_bond_neighbor(), core::chemical::ResidueDatabaseIO::report_residue_type_cut_bond(), and core::chemical::write_topology_file().
void core::chemical::ResidueType::debug_dump_icoor | ( | ) | const |
Dump out atomnames and icoor values.
References atom_name(), ideal_xyz(), core::chemical::ResidueTypeBase::name3(), natoms(), core::chemical::pretty_print_atomicoor(), and core::chemical::TR().
|
private |
If a polymer without explicitly set mainchain atoms, determine a list of main chain atoms by shortest path from LOWER to UPPER.
Should only be called from copy_other_data() function.
Needs connections, bonded neighbors set
References bonded_neighbor(), core::chemical::get_residue_path_distances(), core::chemical::ResidueTypeBase::is_polymer(), lower_connect(), lower_connect_atom(), lower_connect_id(), mainchain_atoms_indices_, core::chemical::ResidueTypeBase::name(), protocols::sic_dock::scores::nbr, nbrs(), core::chemical::TR(), upper_connect(), upper_connect_atom(), and upper_connect_id().
Referenced by copy_other_info().
|
inline |
detach RestypeDestructionEvent observer function
fn | pointer to observer's unary member function with signature void( RestypeDestructionEvent const & ) |
ptr | RAW pointer to observer object |
References destruction_obs_hub_.
|
inline |
Return the indices for the set of atoms that define a particular intraresidue dihedral.
References dihedral_atom_sets_.
Referenced by core::scoring::ResidueExclParams::create_excl_info(), core::scoring::methods::MMTorsionEnergy::eval_atom_derivative(), core::scoring::methods::MMTorsionEnergy::eval_intrares_derivatives(), core::scoring::methods::MMTorsionEnergy::eval_intrares_energy(), core::scoring::GenericBondedPotential::eval_residue_energy_and_derivative_torsion(), and protocols::features::ProteinBondGeometryFeatures::report_intrares_torsions().
|
inline |
Returns the list of all of the indices of all the intraresidue dihedrals a particular atom is involved in. Useful for calculating the derivatives for an atom.
References dihedrals_for_atom_.
Referenced by core::scoring::methods::MMTorsionEnergy::eval_atom_derivative(), and core::scoring::methods::MMTorsionEnergy::eval_intrares_derivatives().
core::chemical::element::Elements core::chemical::ResidueType::element | ( | core::Size | atomno | ) | const |
Convenience function to go directly to the element enum.
References element_type(), and core::chemical::element::UnknownElement.
|
inline |
References elements_.
Referenced by core::chemical::AutomorphismIterator::can_pair(), protocols::md::CartesianMD::do_initialize(), element(), core::energy_methods::IdealParametersDatabase::generate_impropers_map_res(), protocols::drug_design::ConformationSelectionToRDMol::Mol(), core::io::pose_from_sfr::remap_names_on_geometry(), core::io::pose_from_sfr::score_mapping(), and show().
|
inline |
index of the first sidechain atom (heavy or hydrogen)
References n_backbone_heavyatoms_, natoms(), and nheavyatoms_.
Referenced by protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::align_and_calculate_rmsd(), protocols::cyclic_peptide::SymmetricCycpepAlign::align_to_origin(), protocols::simple_moves::chiral::ChiralMover::apply(), protocols::stepwise::modeler::rna::base_atoms_square_deviation(), core::pack::guidance_scoreterms::voids_penalty_energy::VoidsPenaltyVoxelGrid::compute_burial(), core::scoring::compute_sc_centroid(), core::scoring::compute_sc_radius(), core::chemical::MutableResidueType::copy_atom_info(), core::conformation::copy_residue_coordinates_and_rebuild_missing_atoms(), core::pose::rna::detect_base_contacts(), core::select::util::determine_whether_point_is_buried(), protocols::stepwise::modeler::align::StepWisePoseAligner::do_checks(), core::pack::figure_out_repackable_residues(), core::conformation::Residue::first_sidechain_atom(), protocols::qsar::scoring_grid::ShapeGrid::get_point_score(), protocols::minimization_packing::MinimalRotamer::has_ideal_geometry(), core::scoring::is_protein_sidechain_heavyatom(), protocols::features::PdbDataFeatures::load_residue_pdb_confidence(), protocols::drug_design::ConformationSelectionToRDMol::Mol(), core::conformation::Residue::place(), protocols::minimization_packing::MinimalRotamer::record_internal_geometry(), select_orient_atoms(), protocols::stepwise::modeler::rna::suite_square_deviation(), core::util::switch_to_centroid_rot_set(), protocols::mpi_refinement::StructAvrgMover::weighted_average(), and core::chemical::write_topology_file().
|
inline |
index of the first sidehchain hydrogen
References first_sidechain_hydrogen_.
Referenced by protocols::stepwise::modeler::align::StepWisePoseAligner::do_checks(), core::conformation::Residue::first_sidechain_hydrogen(), and core::pose::copydofs::setup_atom_id_map_match_atom_names().
|
inline |
gasteiger::GasteigerAtomTypeDataCOP core::chemical::ResidueType::gasteiger_atom_type | ( | core::Size | atomno | ) | const |
Get the Gasteiger atom type for this atom Can be null if the atom type isn't set.
References gasteiger_atom_type_index_, and core::chemical::ResidueTypeBase::gasteiger_atom_typeset().
Referenced by core::chemical::MutableResidueType::copy_atom_info().
|
overridevirtual |
Get a pointer to this ResidueTypeBase's base ResidueTypeBase.
Get a pointer to this ResidueTypeBase's base ResidueType.
Returns the base_type_cop_ pointer if not null, self pointer if null.
Implements core::chemical::ResidueTypeBase.
References base_type_cop_, and get_self_ptr().
Referenced by core::chemical::MutableResidueType::copy_other_info(), core::pack::palette::PackerPalette::decide_what_to_do_with_existing_type(), protocols::loops::loop_closure::jacobi::JacobiLoopClosureMover::default_target_icoors(), core::pack::palette::PackerPalette::get_base_type_raw_ptr(), core::chemical::ResidueTypeSet::get_residue_type_with_variant_removed(), and protocols::loops::loop_closure::jacobi::JacobiLoopClosureMover::prepare_foldtree().
|
inline |
Referenced by get_metal_binding_atoms(), and perform_checks().
|
inline |
Gets indices of all atoms that can form bonds to metals.
References atom_index(), get_metal_binding_atoms(), has(), and core::chemical::ResidueTypeBase::name().
Referenced by core::conformation::Residue::get_metal_binding_atoms(), and core::chemical::write_topology_file().
|
inline |
|
inline |
self pointers
Referenced by core::scoring::GenBondedExclInfo::add_residue_exclude_torsions(), protocols::match::Matcher::create_ds_builder(), get_base_type_cop(), core::scoring::GenBondedExclInfo::get_residue_data(), core::chemical::ResidueTypeSet::get_residue_type_with_custom_variant_added(), core::chemical::ResidueTypeSet::get_residue_type_with_variant_added(), core::chemical::ResidueTypeSet::get_residue_type_with_variant_removed(), core::scoring::lkball::LKB_ResidueInfo::initialize(), core::pose::make_pose_from_saccharide_sequence(), protocols::drug_design::place_new_restype_rotamer_align(), protocols::stepwise::modeler::protein::StepWiseProteinBackboneSampler::rama_energy(), core::pose::residue_types_from_saccharide_sequence_recursive(), protocols::simple_moves::ExplicitWaterMover::setup_pack(), and protocols::toolbox::match_enzdes_util::MatchConstraintFileInfo::template_atom_inds().
|
inline |
|
inline |
Referenced by self_pointer_updates().
|
inline |
return indices of aromatic Hydrogens
References Haro_index_.
Referenced by core::conformation::Residue::Haro_index().
|
inlineoverridevirtual |
is this atom present in this residue?
Implements core::chemical::ResidueTypeBase.
References atom_name(), and atom_name_to_index_.
Referenced by protocols::rna::movers::RNAThreadAndMinimizeMover::accomodate_length_change(), protocols::cyclic_peptide::CycpepRigidBodyPermutationMover::align_cycpep_pose_to_original_pose(), core::select::util::any_atoms_within_cutoff(), protocols::relax::loop::LoopRelaxMover::apply(), protocols::antibody_legacy::GraftMover::apply(), protocols::antibody_legacy::GraftOneMover::apply(), protocols::comparative_modeling::PartialThreadingMover::apply(), protocols::comparative_modeling::ThreadingMover::apply(), protocols::fldsgn::SheetConstraintGenerator::apply(), core::pack::rotamer_set::WaterAnchorInfo::attaches_to_residue_type(), core::scoring::elec::GroupElec::build_groupinfo(), core::io::pose_from_sfr::PoseFromSFRBuilder::build_pdb_info_2_temps(), core::chemical::SetPolymerConnectAtom::changes_connections_on(), core::chemical::AddConnect::changes_connections_on(), core::chemical::ConnectSulfurAndMakeVirtualProton::changes_connections_on(), core::chemical::AddConnectAndTrackingVirt::changes_connections_on(), core::chemical::AddConnectDeleteChildProton::changes_connections_on(), protocols::hybridization::InsertChunkMover::check_overlap(), protocols::simple_filters::AtomicDistanceFilter::compute(), core::simple_metrics::per_residue_metrics::PerResidueRMSDMetric::create_atom_id_map(), core::energy_methods::IdealParametersDatabase::create_parameters_for_restype(), protocols::ligand_docking::ga_ligand_dock::GridScorer::derivatives(), core::scoring::disulfides::DisulfideAtomIndices::DisulfideAtomIndices(), core::scoring::disulfides::CentroidDisulfideEnergyContainer::disulfides_changed(), core::scoring::disulfides::DisulfideMatchingEnergyContainer::disulfides_changed(), protocols::frag_picker::scores::AtomBasedConstraintsScore::do_caching(), protocols::stepwise::modeler::align::StepWisePoseAligner::do_checks(), protocols::stepwise::sampler::protein::do_set_xyz(), protocols::rna::denovo::ensure_phosphate_nomenclature_matches_mini(), protocols::stepwise::modeler::movemap::figure_out_stepwise_movemap(), protocols::frag_picker::scores::FragmentCrmsd::fill_CA_coords(), core::scoring::dssp::fill_hbond_bb_pair_score_dssp(), core::io::pose_from_sfr::PoseFromSFRBuilder::fill_name_map(), protocols::constraint_movers::AddConstraintsToCurrentConformationMover::find_best_anchor(), core::chemical::find_best_match(), core::scoring::disulfides::CentroidDisulfideEnergyContainer::find_disulfides(), core::scoring::disulfides::FullatomDisulfideEnergyContainer::find_disulfides(), protocols::rna::movers::find_nearby_res(), protocols::constraint_movers::AddConstraintsToCurrentConformationMover::generate_atom_pair_constraints(), protocols::constraint_movers::AddConstraintsToCurrentConformationMover::generate_coordinate_constraints(), core::pose::motif::get_AIDs(), core::scoring::elec::CountPairRepMap::get_map(), get_metal_binding_atoms(), protocols::qsar::scoring_grid::ShapeGrid::get_point_score(), core::conformation::Residue::has(), core::chemical::ICoorAtomID::ICoorAtomID(), protocols::match::upstream::UpstreamResTypeGeometry::initialize_from_residue_type(), core::scoring::facts::FACTSRsdTypeInfo::initialize_intrascale(), protocols::relax::RelaxProtocolBase::initialize_movemap(), core::scoring::lDDT_Calculator::lDDT_Cache::make_mapping_states(), core::pose::named_atom_id_to_atom_id(), core::conformation::Residue::orient_onto_residue(), protocols::hybridization::MRMover::pack_missing_sidechains(), protocols::cyclic_peptide::CycpepRigidBodyPermutationMover::perturb_cycpep_pose_orientation(), core::conformation::Residue::place(), core::chemical::pretty_print_atomicoor(), core::scoring::constraints::ConstraintIO::read_cst_atom_pairs(), core::scoring::constraints::ConstraintIO::read_cst_coordinates(), protocols::loop_grower::LoopGrower::refine_cycle(), core::io::pose_from_sfr::PoseFromSFRBuilder::refine_pose(), core::energy_methods::CustomAtomPairEnergy::residue_pair_energy(), core::energy_methods::PeptideBondEnergy::residue_pair_energy(), protocols::ligand_docking::ga_ligand_dock::GridScorer::score(), core::select::util::select_coord_for_residue(), protocols::cyclic_peptide::crosslinker::set_up_thioether_variants(), core::pose::copydofs::setup_atom_id_map_match_atom_names(), protocols::rna::denovo::setup_coarse_chainbreak_constraints(), core::scoring::setup_matching_atoms_with_given_names(), protocols::stepwise::modeler::protein::setup_protein_backbone_atom_id_map(), core::scoring::superimpose_polymer_heavyatoms(), core::scoring::lDDT_Calculator::lDDT_Cache::swap_indexes(), core::chemical::rna::RNA_Info::update_derived_rna_data(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::use_in_rmsd(), and protocols::energy_based_clustering::EnergyBasedClusteringProtocol::use_this_atom().
|
inline |
Does this type have groups (not just single atoms) that are polymer-bond dependent?
Always returns false for non-polymeric residue types.
References has_polymer_dependent_groups_, and core::chemical::ResidueTypeBase::is_polymer().
bool core::chemical::ResidueType::has_sc_orbitals | ( | ) | const |
does this residue have sidechain orbitals?
References core::chemical::ResidueProperties::has_property(), core::chemical::ResidueTypeBase::properties(), and core::chemical::SC_ORBITALS.
Referenced by core::conformation::Residue::has_sc_orbitals().
|
inline |
Returns true if this residue has shadow atoms, false otherwise.
References atom_shadowed_indices_.
Referenced by core::conformation::Residue::has_shadow_atoms(), and core::chemical::write_topology_file().
bool core::chemical::ResidueType::heavyatom_has_polar_hydrogens | ( | Size | atomno | ) | const |
References heavyatom_has_polar_hydrogens_.
Referenced by core::pose::rna::detect_sugar_contacts(), protocols::stepwise::modeler::polar_hydrogens::PolarHydrogenPacker::get_possible_hbond_acceptors(), core::conformation::Residue::heavyatom_has_polar_hydrogens(), core::scoring::sasa::SasaMethod::is_polar_atom(), and show().
|
inline |
References vec_atom_types_.
Referenced by core::scoring::elec::GroupElec::build_groupinfo(), protocols::cyclic_peptide::PeptideInternalHbondsMetric::count_hbonds(), core::pose::rna::detect_sugar_contacts(), protocols::stepwise::modeler::polar_hydrogens::PolarHydrogenPacker::get_possible_hbond_acceptors(), core::conformation::Residue::heavyatom_is_an_acceptor(), core::scoring::sasa::SasaMethod::is_polar_atom(), protocols::cyclic_peptide::OversaturatedHbondAcceptorFilter::max_allowed_hbonds(), and show().
|
inline |
return indices of polar Hydrogens
References Hpol_index_.
Referenced by core::conformation::Residue::Hpol_index(), and perform_checks().
|
inline |
indices of non-polar hydrogens as potential carbon Hbond donors
References Hpos_apolar_.
Referenced by core::conformation::Residue::Hpos_apolar().
|
inline |
indices of polar hydrogens as Hbond donors
References Hpos_polar_.
Referenced by protocols::stepwise::modeler::rna::phosphate::MultiPhosphateSampler::check_other_partition_for_contact(), core::pose::rna::get_phosphate_atom_and_neighbor_list(), and core::conformation::Residue::Hpos_polar().
|
inline |
References Hpos_polar_sc_.
Referenced by core::conformation::Residue::Hpos_polar_sc().
AtomICoord of an atom.
References icoor_.
Referenced by protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::add_amide_bond_cyclic_constraints(), protocols::cyclic_peptide::crosslinker::OctahedralMetal_Helper::add_angle_constraints(), protocols::cyclic_peptide::crosslinker::SquarePlanarMetal_Helper::add_angle_constraints(), protocols::cyclic_peptide::crosslinker::TetrahedralMetal_Helper::add_angle_constraints(), protocols::cyclic_peptide::crosslinker::TrigonalPlanarMetal_Helper::add_angle_constraints(), protocols::cyclic_peptide::crosslinker::TrigonalPyramidalMetal_Helper::add_angle_constraints(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::add_closebond_logic_isopeptide(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::add_closebond_logic_thioether_lariat(), protocols::cyclic_peptide::crosslinker::SquarePlanarMetal_Helper::add_dihedral_constraint_to_stream(), protocols::cyclic_peptide::crosslinker::TrigonalPlanarMetal_Helper::add_dihedral_constraints(), protocols::carbohydrates::IdealizeAnomericHydrogens::apply(), protocols::minimization_packing::MinimalRotamer::atom_is_ideal(), core::conformation::Conformation::backbone_torsion_angle_atoms(), core::pack::guidance_scoreterms::voids_penalty_energy::VoidsPenaltyVoxelGrid::compute_burial(), core::chemical::MutableResidueType::copy_atom_info(), protocols::cyclic_peptide::crosslinker::correct_thioether_virtuals(), protocols::simple_moves::PeptideStapleMover::derive_staple_constraints_(), core::select::util::determine_whether_point_is_buried(), core::chemical::formatted_icoord_tree(), protocols::qsar::scoring_grid::ShapeGrid::get_point_score(), core::conformation::Residue::icoor(), protocols::match::upstream::UpstreamResTypeGeometry::initialize_from_residue_type(), core::conformation::Residue::place(), protocols::cyclic_peptide::PeptideStubMover::preserve_old_mainchain_torsions(), core::chemical::pretty_print_atomicoor(), protocols::minimization_packing::MinimalRotamer::record_internal_geometry(), core::io::pose_from_sfr::PoseFromSFRBuilder::refine_pose(), core::chemical::ResidueDatabaseIO::report_residue_type_icoor(), core::pack::palette::PackerPalette::saccharide_backbones_are_compatible(), protocols::cyclic_peptide::crosslinker::Metal_HelperBase::set_metal_bond_length(), protocols::cyclic_peptide::crosslinker::set_up_thioether_constraints(), protocols::cyclic_peptide::crosslinker::set_up_thioether_variants(), update_nonpolymer_dependent_groups(), update_polymer_dependent_groups(), and core::chemical::write_topology_file().
|
inline |
References ideal_xyz_.
Referenced by core::io::pose_from_sfr::check_and_correct_sister_atom_based_on_chirality(), core::io::pose_from_sfr::check_and_correct_sister_atom_based_on_outgroup(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::chisamples_for_rotamer_and_chi(), core::chemical::MutableResidueType::copy_atom_info(), debug_dump_icoor(), protocols::match::upstream::FullChiSampleSet::FullChiSampleSet(), ideal_xyz(), core::conformation::improper_build(), core::scoring::mm::MMBondAngleResidueTypeParam::init(), protocols::match::upstream::UpstreamResTypeGeometry::initialize_from_residue_type(), core::conformation::Residue::Residue(), core::io::pose_from_sfr::score_mapping(), core::select::util::select_coord_for_residue(), core::chemical::ResidueTypeKinWriter::write_restype(), and core::chemical::ICoorAtomID::xyz().
|
inline |
References atom_index(), and ideal_xyz().
|
private |
Precalculate other derived data from data already present.
References atoms_last_controlled_by_chi_, atoms_within_one_bond_of_a_residue_connection_, atoms_within_two_bonds_of_a_residue_connection_, bondangle_atom_sets_, bondangles_for_atom_, bonded_neighbor(), dihedral_atom_sets_, dihedrals_for_atom_, core::chemical::get_residue_path_distances(), core::chemical::ResidueTypeBase::has_property(), last_controlling_chi_, core::chemical::ResidueTypeBase::name(), natoms(), nchi(), path_distance_, path_distances(), core::chemical::ResidueTypeBase::properties(), residue_connections_, core::chemical::RNA, rna_info_, core::chemical::TNA, core::chemical::TR(), update_last_controlling_chi(), update_nonpolymer_dependent_groups(), update_polymer_dependent_groups(), update_ring_conformer_sets(), within1bonds_sets_for_atom_, and within2bonds_sets_for_atom_.
Referenced by ResidueType().
bool core::chemical::ResidueType::is_acetylated_nterminus | ( | ) | const |
is acetylated n terminus
References core::chemical::ACETYLATED_NTERMINUS, core::chemical::ResidueProperties::has_property(), and core::chemical::ResidueTypeBase::properties().
bool core::chemical::ResidueType::is_adduct | ( | ) | const |
is an adduct-modified residue?
References core::chemical::ADDUCT, core::chemical::ResidueProperties::has_property(), and core::chemical::ResidueTypeBase::properties().
|
inline |
Is this an alpha-amino acid?
References core::chemical::ALPHA_AA, core::chemical::ResidueProperties::has_property(), and core::chemical::ResidueTypeBase::properties().
Referenced by protocols::ncbb::SecStructMinimizeMover::add_dihedral_constraints_to_pose(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::alignment_atoms_in_res(), protocols::denovo_design::movers::FastDesign::apply(), protocols::ncbb::SecStructMinimizeMover::apply(), protocols::simple_moves::SetTorsion::apply(), core::select::residue_selector::BinSelector::apply(), core::select::residue_selector::PhiSelector::apply(), protocols::simple_moves::DeclareBond::apply(), protocols::generalized_kinematic_closure::filter::GeneralizedKICfilter::apply_loop_bump_check(), protocols::generalized_kinematic_closure::perturber::GeneralizedKICperturber::apply_perturb_dihedral_bbg(), protocols::generalized_kinematic_closure::perturber::GeneralizedKICperturber::apply_randomize_alpha_backbone_by_rama(), protocols::generalized_kinematic_closure::perturber::GeneralizedKICperturber::apply_sample_cis_peptide_bond(), core::scoring::atomic_depth::AtomicDepth::AtomicDepth(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::check_backbones_match(), core::conformation::check_good_cutpoint_neighbour(), protocols::denovo_design::construct_poly_ala_pose(), protocols::toolbox::pose_manipulation::construct_poly_uniq_restype_pose(), core::pack::palette::PackerPalette::decide_what_to_do_with_base_type(), core::kinematics::jacobian::SeriesJacobians::determine_residue_series_type(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::do_ABOXYZ_bin_analysis(), core::conformation::form_disulfide_helper(), protocols::generalized_kinematic_closure::general_set_phi(), protocols::generalized_kinematic_closure::general_set_psi(), protocols::stepwise::modeler::protein::StepWiseProteinBackboneSampler::get_main_chain_torsion_set_list_c_terminus(), protocols::stepwise::modeler::protein::StepWiseProteinBackboneSampler::get_main_chain_torsion_set_list_coarse(), protocols::stepwise::modeler::protein::StepWiseProteinBackboneSampler::get_main_chain_torsion_set_list_full(), protocols::stepwise::modeler::protein::StepWiseProteinBackboneSampler::get_main_chain_torsion_set_list_n_terminus(), protocols::stepwise::modeler::protein::StepWiseProteinBackboneSampler::get_main_chain_torsion_set_list_sample_phi_only(), protocols::stepwise::modeler::protein::StepWiseProteinBackboneSampler::get_main_chain_torsion_set_list_sample_psi_only(), core::scoring::P_AA::get_Paa_pp_deriv(), protocols::cyclic_peptide::PeptideStubMover::handle_lower_terminus(), protocols::cyclic_peptide::PeptideStubMover::handle_upper_terminus(), core::scoring::bin_transitions::BinTransitionData::has_property(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::is_all_alpha_aa_or_peptoid(), protocols::cyclic_peptide::CycpepSymmetryFilter::is_cyclic_peptide(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::is_supported_restype(), protocols::denovo_design::DisulfidizeMover::mutate_disulfides_to_ala(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::mutate_to_alanine(), protocols::cyclic_peptide::PeptideStubMover::preserve_old_mainchain_torsions(), protocols::stepwise::modeler::protein::StepWiseProteinBackboneSampler::sample_residues_recursively(), protocols::stepwise::modeler::protein::StepWiseProteinBackboneSampler::setup_torsion_sets(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::use_in_rmsd(), and protocols::energy_based_clustering::EnergyBasedClusteringProtocol::use_this_atom().
|
inline |
Is this an aramid?
References core::chemical::ARAMID, core::chemical::ResidueProperties::has_property(), and core::chemical::ResidueTypeBase::properties().
Referenced by protocols::ncbb::ResidueReplacementRebuildMover::apply(), core::pack::palette::PackerPalette::aramid_backbones_are_compatible(), core::conformation::Conformation::backbone_torsion_angle_atoms(), core::conformation::Conformation::backbone_torsion_angle_atoms_meta_aramid(), core::conformation::Conformation::backbone_torsion_angle_atoms_ortho_aramid(), core::conformation::Conformation::backbone_torsion_angle_atoms_para_aramid(), core::conformation::check_good_cutpoint_neighbour(), core::pack::palette::PackerPalette::decide_what_to_do_with_base_type(), core::chemical::rna::default_jump_atom(), core::scoring::OmegaTether::eval_omega_score_residue(), core::energy_methods::OmegaTetherEnergy::eval_residue_dof_derivative(), core::energy_methods::RamaPreProEnergy::is_allowed_type(), core::conformation::Residue::is_aramid(), core::energy_methods::OmegaTetherEnergy::residue_energy(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::RotamericSingleResidueDunbrackLibrary(), and protocols::simple_moves::RandomTorsionMover::setup_torsion_list().
bool core::chemical::ResidueType::is_aromatic | ( | ) | const |
is aromatic?
References core::chemical::AROMATIC, core::chemical::ResidueProperties::has_property(), and core::chemical::ResidueTypeBase::properties().
Referenced by protocols::antibody::AntibodyFeatures::calculate_cdr_aromatic_nres(), core::pack::task::ResidueLevelTask_::extrachi_sample_level(), core::scoring::bin_transitions::BinTransitionData::has_property(), core::conformation::Residue::is_apolar(), and core::conformation::Residue::is_aromatic().
|
overridevirtual |
Is this ResidueTypeBase a base type?
Checks the base_type_cop_ pointer. If it's null, this is assumed to be a base type.
Implements core::chemical::ResidueTypeBase.
References base_type_cop_.
Referenced by core::scoring::elec::FA_ElecEnergy::atomistic_pair_energy(), core::scoring::elec::FA_ElecEnergy::backbone_backbone_energy(), core::scoring::elec::FA_ElecEnergy::backbone_sidechain_energy(), core::chemical::MutableResidueType::copy_other_info(), core::pack::palette::PackerPalette::decide_what_to_do_with_existing_type(), core::scoring::etable::BaseEtableEnergy< Derived >::determine_crossover_behavior(), core::scoring::elec::FA_ElecEnergy::eval_intrares_derivatives(), core::scoring::elec::FA_ElecEnergy::eval_intrares_energy(), core::scoring::elec::FA_ElecEnergy::get_intrares_countpair(), core::scoring::elec::FA_ElecEnergy::residue_pair_energy(), core::scoring::elec::FA_ElecEnergy::sidechain_sidechain_energy(), and update_derived_data().
|
inline |
Is this a beta-amino acid?
References core::chemical::BETA_AA, core::chemical::ResidueProperties::has_property(), and core::chemical::ResidueTypeBase::properties().
Referenced by protocols::energy_based_clustering::EnergyBasedClusteringProtocol::add_cyclic_constraints(), protocols::ncbb::SecStructMinimizeMover::add_dihedral_constraints_to_pose(), protocols::cyclic_peptide::CycpepRigidBodyPermutationMover::align_cycpep_pose_to_original_pose(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::alignment_atoms_in_res(), protocols::ncbb::SecStructFinder::apply(), protocols::ncbb::SecStructMinimizeMover::apply(), protocols::simple_moves::SetTorsion::apply(), core::select::residue_selector::PhiSelector::apply(), protocols::simple_moves::DeclareBond::apply(), protocols::generalized_kinematic_closure::filter::GeneralizedKICfilter::apply_loop_bump_check(), protocols::generalized_kinematic_closure::perturber::GeneralizedKICperturber::apply_sample_cis_peptide_bond(), core::pack::rotamer_set::ContinuousRotamerSet::build_rotamers(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::check_backbones_match(), core::conformation::check_good_cutpoint_neighbour(), protocols::denovo_design::construct_poly_ala_pose(), protocols::toolbox::pose_manipulation::construct_poly_uniq_restype_pose(), core::pack::rotamers::SingleNCAARotamerLibraryCreator::create(), core::pack::palette::PackerPalette::decide_what_to_do_with_base_type(), core::conformation::form_disulfide_helper(), protocols::stepwise::modeler::protein::StepWiseProteinBackboneSampler::get_main_chain_torsion_set_list_c_terminus(), protocols::stepwise::modeler::protein::StepWiseProteinBackboneSampler::get_main_chain_torsion_set_list_coarse(), protocols::stepwise::modeler::protein::StepWiseProteinBackboneSampler::get_main_chain_torsion_set_list_full(), protocols::stepwise::modeler::protein::StepWiseProteinBackboneSampler::get_main_chain_torsion_set_list_n_terminus(), protocols::stepwise::modeler::protein::StepWiseProteinBackboneSampler::get_main_chain_torsion_set_list_sample_phi_only(), protocols::stepwise::modeler::protein::StepWiseProteinBackboneSampler::get_main_chain_torsion_set_list_sample_psi_only(), protocols::cyclic_peptide::PeptideStubMover::handle_lower_terminus(), protocols::cyclic_peptide::PeptideStubMover::handle_upper_terminus(), core::scoring::bin_transitions::BinTransitionData::has_property(), protocols::cyclic_peptide::CycpepSymmetryFilter::is_cyclic_peptide(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::is_supported_restype(), protocols::stepwise::modeler::protein::StepWiseProteinBackboneSampler::main_chain_torsion_set_lists_real(), protocols::denovo_design::DisulfidizeMover::mutate_disulfides_to_ala(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::mutate_to_alanine(), core::scoring::OmegaTether::omega_index(), protocols::cyclic_peptide::CycpepRigidBodyPermutationMover::perturb_cycpep_pose_orientation(), core::scoring::OmegaTether::phi_index(), protocols::cyclic_peptide::PeptideStubMover::preserve_old_mainchain_torsions(), core::scoring::OmegaTether::psi_index(), core::pack::dunbrack::RotamerLibrary::read_from_binary(), protocols::stepwise::modeler::protein::StepWiseProteinBackboneSampler::sample_residues_recursively(), protocols::stepwise::modeler::protein::StepWiseProteinBackboneSampler::setup_torsion_sets(), and protocols::energy_based_clustering::EnergyBasedClusteringProtocol::use_this_atom().
bool core::chemical::ResidueType::is_branch_point | ( | ) | const |
is a branch-point residue?
References core::chemical::BRANCH_POINT, core::chemical::ResidueProperties::has_property(), and core::chemical::ResidueTypeBase::properties().
Referenced by core::conformation::Residue::is_branch_point(), and show().
bool core::chemical::ResidueType::is_canonical | ( | ) | const |
Is this a canonical residue type (nucleic acid or amino acid)?
Calls is_canonical_aa() and is_canonical_nucleic().
References is_canonical_aa(), and is_canonical_nucleic().
Referenced by core::conformation::Conformation::bonded_neighbor_all_res(), and core::io::pose_to_sfr::PoseToStructFileRepConverter::grab_conect_records_for_atom().
bool core::chemical::ResidueType::is_canonical_aa | ( | ) | const |
Is this a canonical amino acid (CANONICAL_AA property)?
Only the standard amino acid types (ACDEFGHIKLMNPQRSTVWY) are canonical.
References core::chemical::CANONICAL_AA, core::chemical::ResidueProperties::has_property(), and core::chemical::ResidueTypeBase::properties().
Referenced by is_canonical(), core::pack::dunbrack::SingleResidueDunbrackLibrary::n_rotamer_bins_for_aa(), core::energy_methods::FaMPAsymEzCBEnergy::residue_energy(), core::energy_methods::FaMPAsymEzCGEnergy::residue_energy(), and core::pack::dunbrack::SingleResidueDunbrackLibrary::SingleResidueDunbrackLibrary().
bool core::chemical::ResidueType::is_canonical_nucleic | ( | ) | const |
Is this a canonical nucleic acid (CANONICAL_NUCLEIC property)?
Only the standard nucliec acid types (dA, dC, dG, dT, A, C, G, U) are canonical.
References core::chemical::CANONICAL_NUCLEIC, core::chemical::ResidueProperties::has_property(), and core::chemical::ResidueTypeBase::properties().
Referenced by protocols::rna::movers::determine_residues_to_rebuild(), protocols::stepwise::modeler::align::StepWisePoseAligner::do_checks(), is_canonical(), and core::chemical::rna::RNA_Info::rna_update_last_controlling_chi().
bool core::chemical::ResidueType::is_carbohydrate | ( | ) | const |
is carbohydrate?
References core::chemical::CARBOHYDRATE, core::chemical::ResidueProperties::has_property(), and core::chemical::ResidueTypeBase::properties().
Referenced by core::conformation::Conformation::append_residue(), protocols::carbohydrates::GlycanTreeModeler::apply(), protocols::carbohydrates::IdealizeAnomericHydrogens::apply(), protocols::carbohydrates::LinkageConformerMover::apply(), protocols::simple_moves::CoupledMover::apply(), core::select::residue_selector::GlycanLayerSelector::apply(), protocols::constraint_generator::DihedralConstraintGenerator::apply(), protocols::flexpep_docking::FlexPepDockingPoseMetrics::calc_phipsi_RMSD(), core::simple_metrics::metrics::DihedralDistanceMetric::calculate(), core::simple_metrics::per_residue_metrics::PerResidueGlycanLayerMetric::calculate(), core::conformation::Residue::carbohydrate_info(), core::conformation::check_good_cutpoint_neighbour(), core::pack::palette::PackerPalette::decide_what_to_do_with_base_type(), core::chemical::rna::default_jump_atom(), core::select::movemap::MoveMapFactory::edit_movemap_given_pose(), core::io::pose_to_sfr::PoseToStructFileRepConverter::get_connectivity_annotation_info(), core::io::pose_to_sfr::PoseToStructFileRepConverter::get_link_record(), core::energy_methods::get_restag(), core::io::pose_to_sfr::PoseToStructFileRepConverter::grab_torsion_records(), protocols::stepwise::modeler::StepWiseConnectionSampler::initialize_checkers(), protocols::stepwise::modeler::align::StepWiseClusterer::initialize_parameters(), protocols::stepwise::modeler::StepWiseConnectionSampler::initialize_sampler(), core::conformation::Conformation::insert_polymer_residue(), core::conformation::Residue::is_carbohydrate(), core::io::pose_from_sfr::PoseFromSFRBuilder::refine_pose(), core::pose::carbohydrates::set_glycan_iupac_bb_torsions(), core::conformation::update_cutpoint_virtual_atoms_if_connected(), and protocols::rna::movers::ErraserMinimizerMover::vary_bond_geometry().
bool core::chemical::ResidueType::is_charged | ( | ) | const |
is charged?
References core::chemical::CHARGED, core::chemical::ResidueProperties::has_property(), and core::chemical::ResidueTypeBase::properties().
Referenced by core::scoring::bin_transitions::BinTransitionData::has_property(), core::conformation::Residue::is_apolar(), and core::conformation::Residue::is_charged().
bool core::chemical::ResidueType::is_coarse | ( | ) | const |
is coarse?
References core::chemical::COARSE, core::chemical::ResidueProperties::has_property(), and core::chemical::ResidueTypeBase::properties().
Referenced by core::chemical::rna::default_jump_atom(), core::import_pose::libraries::RNA_ChunkLibrary::initialize_rna_chunk_library(), core::conformation::Residue::is_coarse(), core::pose::toolbox::AtomID_Mapper::renumber_after_variant_changes(), and core::pose::rna::setup_base_pair_constraints().
bool core::chemical::ResidueType::is_cyclic | ( | ) | const |
is cyclic?
References core::chemical::CYCLIC, core::chemical::ResidueProperties::has_property(), and core::chemical::ResidueTypeBase::properties().
Referenced by core::scoring::bin_transitions::BinTransitionData::has_property(), core::chemical::is_mainchain_torsion_also_ring_torsion(), core::conformation::Residue::ring_conformer(), core::pose::Pose::set_ring_conformation(), protocols::simple_moves::RingConformationMover::setup_residue_list(), core::conformation::Residue::show(), and show().
|
inline |
is disulfide?
References core::chemical::DISULFIDE_BONDED, core::chemical::ResidueProperties::has_property(), and core::chemical::ResidueTypeBase::properties().
Referenced by protocols::abinitio::DomainAssembly::apply(), protocols::cyclic_peptide::TryDisulfPermutations::apply(), protocols::minimization_packing::DisulfideOptimizationMover::apply(), protocols::pose_sewing::movers::BlockwiseAnalysisMover::apply(), protocols::pose_sewing::movers::OmnibusDisulfideAnalysisLabelerMover::apply(), protocols::protein_interface_design::movers::PlaceStubMover::apply(), protocols::protein_interface_design::movers::PrepackMover::apply(), protocols::pose_sewing::filters::HasDisulfideFilter::apply(), protocols::hybridization::HybridizeProtocol::apply(), protocols::simple_moves::MutateResidue::break_a_disulfide(), core::conformation::break_disulfide(), core::conformation::change_cys_state(), protocols::denovo_design::construct_poly_ala_pose(), core::pack::palette::PackerPalette::decide_what_to_do_with_base_type(), core::pack::palette::PackerPalette::decide_what_to_do_with_existing_type(), core::conformation::Conformation::detect_disulfides(), core::conformation::symmetry::SymmetricConformation::detect_disulfides(), core::scoring::etable::BaseEtableEnergy< Derived >::determine_crossover_behavior(), core::conformation::disulfide_bonds(), core::scoring::disulfides::CentroidDisulfideEnergyContainer::disulfides_changed(), core::scoring::disulfides::DisulfideMatchingEnergyContainer::disulfides_changed(), core::scoring::EnvPairPotential::evaluate_pair_and_cenpack_score(), protocols::denovo_design::DisulfidizeMover::find_current_disulfides(), core::scoring::disulfides::CentroidDisulfideEnergyContainer::find_disulfides(), core::scoring::disulfides::DisulfideMatchingEnergyContainer::find_disulfides(), protocols::denovo_design::DisulfidizeMover::find_possible_disulfides(), protocols::simple_ddg::SSElementBisectddGFilter::get_ddg_bisect_score(), core::conformation::get_disulf_partner(), protocols::enzdes::EnzdesFlexBBProtocol::get_tenA_neighbor_residues(), core::scoring::bin_transitions::BinTransitionData::has_property(), protocols::cyclic_peptide::crosslinker::OctahedralMetal_Helper::is_allowed_type(), protocols::cyclic_peptide::crosslinker::TetrahedralMetal_Helper::is_allowed_type(), protocols::toolbox::match_enzdes_util::EnzConstraintParameters::make_constraint_covalent_helper(), protocols::simple_moves::MutateResidue::make_mutation(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::mutate_to_alanine(), core::energy_methods::DisulfideMatchingEnergy::residue_pair_energy(), core::energy_methods::FullatomDisulfideEnergy::residue_pair_energy(), protocols::loops::select_loop_residues(), protocols::calc_taskop_movers::DesignRepackMover::setup_packer_and_movemap(), and core::pose::full_model_info::update_disulfides_from_full_model_info().
|
inline |
Is this a gamma-amino acid?
References core::chemical::GAMMA_AA, core::chemical::ResidueProperties::has_property(), and core::chemical::ResidueTypeBase::properties().
Referenced by protocols::energy_based_clustering::EnergyBasedClusteringProtocol::alignment_atoms_in_res(), protocols::generalized_kinematic_closure::perturber::GeneralizedKICperturber::apply_sample_cis_peptide_bond(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::check_backbones_match(), core::conformation::check_good_cutpoint_neighbour(), core::pack::palette::PackerPalette::decide_what_to_do_with_base_type(), protocols::cyclic_peptide::CycpepSymmetryFilter::is_cyclic_peptide(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::is_supported_restype(), and protocols::energy_based_clustering::EnergyBasedClusteringProtocol::use_this_atom().
bool core::chemical::ResidueType::is_inverted_virtual_residue | ( | ) | const |
Check if atom is an inverted virtual.
Check if residue is 'INVERTING_VIRTUAL_RESIDUE'.
Used by the symmetry machinery for mirror symmetry operations.
References core::chemical::ResidueProperties::has_property(), core::chemical::INVERTED_VIRTUAL_RESIDUE, and core::chemical::ResidueTypeBase::properties().
Referenced by core::conformation::symmetry::calculate_inverting_virtuals(), core::pose::symmetry::make_symmetric_pose(), and core::pack::guidance_scoreterms::voids_penalty_energy::VoidsPenaltyVoxelGrid::prune_voxels_for_fixed_residues().
bool core::chemical::ResidueType::is_ligand | ( | ) | const |
is ligand?
References core::chemical::ResidueProperties::has_property(), core::chemical::LIGAND, and core::chemical::ResidueTypeBase::properties().
Referenced by protocols::energy_based_clustering::EnergyBasedClusteringProtocol::alignment_atoms_in_res(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::alignment_torsions_in_res(), protocols::enzdes::RepackLigandSiteWithoutLigandMover::apply(), protocols::enzdes::GenerateStoredRBConfs::apply(), protocols::simple_task_operations::RestrictToInterface::apply(), protocols::enzdes::DetectProteinLigandInterface::apply(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::calc_dist(), protocols::enzdes::enzutil::catalytic_res(), protocols::enzdes::EnzdesBaseProtocol::catalytic_res(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::check_backbones_match(), protocols::enzdes::LigDSasaFilter::compute(), protocols::enzdes::RepackWithoutLigandFilter::compute(), protocols::flxbb::constraints_sheet(), protocols::enzdes::PoseFoundResiduesCombination::construct_and_dump_outpose(), core::pack::rotamers::SingleLigandRotamerLibraryCreator::create(), core::pack::palette::PackerPalette::decide_what_to_do_with_base_type(), protocols::enzdes::EnzdesBaseProtocol::design_targets(), core::select::util::determine_whether_point_is_buried(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::do_ABOXYZ_bin_analysis(), protocols::enzdes::SecondaryMatchProtocol::find_all_allowed_positions(), protocols::ligand_docking::get_ligand_seqpos(), protocols::enzdes::ModifyStoredRBConfs::get_rigid_body_confs(), protocols::motifs::LigandMotifSearch::get_sphere_aa(), protocols::motifs::LigandMotifSearch::incorporate_motifs(), protocols::motifs::LigandMotifSearch::initialize(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::is_all_alpha_aa_or_peptoid(), core::conformation::Residue::is_ligand(), IdentifyLigandMotifs::ligand_to_residue_analysis(), protocols::forge::remodel::RemodelLoopMover::loophash_stage(), core::scoring::lDDT_Calculator::lDDT_Cache::make_mapping_states(), protocols::ligand_docking::ProtLigEnsemble::make_packer_task(), protocols::ligand_docking::HighResDocker::make_packer_task_from_vector(), protocols::toolbox::match_enzdes_util::EnzdesCstCache::ordered_constrained_positions(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::pose_from_posedata(), IdentifyLigandMotifs::process_for_motifs(), protocols::enzdes::EnzdesScorefileFilter::setup_pose_metric_calculators(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::storeposedata(), core::scoring::Energies::update_neighbor_links(), and core::chemical::write_topology_file().
bool core::chemical::ResidueType::is_lipid | ( | ) | const |
bool core::chemical::ResidueType::is_lower_terminus | ( | ) | const |
is lower terminus?
References core::chemical::ResidueProperties::has_property(), core::chemical::LOWER_TERMINUS, and core::chemical::ResidueTypeBase::properties().
Referenced by protocols::energy_based_clustering::EnergyBasedClusteringProtocol::add_cyclic_constraints(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::alignment_torsions_in_res(), protocols::simple_moves::oop::OopMover::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(), protocols::simple_moves::MissingDensityToJumpMover::apply(), core::io::pose_from_sfr::PoseFromSFRBuilder::build_initial_pose(), protocols::flexpep_docking::FlexPepDockingPoseMetrics::calc_phipsi_RMSD(), core::energy_methods::IdealParametersDatabase::create_parameters_for_restype(), core::pose::symmetry::get_asymmetric_pose_copy_from_symmetric_pose(), core::scoring::dna::DNATorsionPotential::get_atom_ids_by_torsion(), protocols::rbsegment_relax::guess_rbsegs_from_pose(), core::scoring::facts::FACTSRsdTypeInfo::initialize_parameters(), core::conformation::Residue::is_lower_terminus(), is_terminus(), core::pose::make_pose_from_sequence(), core::conformation::Residue::orient_onto_residue_peptoid(), core::conformation::Residue::place(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::pose_from_posedata(), core::io::pose_from_sfr::PoseFromSFRBuilder::refine_pose(), core::pose::remove_ligand_canonical_residues(), core::chemical::ResidueDatabaseIO::report_residue_type(), protocols::dna::set_base_segment_chainbreak_constraints(), protocols::cyclic_peptide::crosslinker::set_up_thioether_variants(), protocols::legacy_sewing::Assembly::to_pose(), and protocols::sewing::data_storage::SmartAssembly::to_pose().
bool core::chemical::ResidueType::is_membrane | ( | ) | const |
is membrane?
References core::chemical::ResidueProperties::has_property(), core::chemical::MEMBRANE, and core::chemical::ResidueTypeBase::properties().
Referenced by core::io::pose_to_sfr::PoseToStructFileRepConverter::append_residue_info_to_sfr(), and atom_index().
|
inline |
Is this a meta-aramid?
References core::chemical::ResidueProperties::has_property(), core::chemical::META_ARAMID, and core::chemical::ResidueTypeBase::properties().
Referenced by core::conformation::Conformation::backbone_torsion_angle_atoms(), core::conformation::Residue::is_meta_aramid(), core::scoring::OmegaTether::omega_index(), core::scoring::OmegaTether::phi_index(), core::scoring::OmegaTether::psi_index(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::RotamericSingleResidueDunbrackLibrary(), and protocols::simple_moves::RandomTorsionMover::setup_torsion_list().
bool core::chemical::ResidueType::is_metal | ( | ) | const |
Return true if this residue type is a metal ion, false otherwise.
The METAL property is specified in the params file under PROPERTIES.
References core::chemical::ResidueProperties::has_property(), core::chemical::METAL, and core::chemical::ResidueTypeBase::properties().
Referenced by core::util::add_covalent_linkage_helper(), core::scoring::sc::MolecularSurfaceCalculator::AddResidue(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::alignment_atoms_in_res(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::alignment_torsions_in_res(), protocols::metal_interface::RemoveMetalConnectionsMover::apply(), core::scoring::sc::MolecularSurfaceCalculator::Calc(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::calc_dist(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::check_backbones_match(), core::scoring::ResidueExclParams::create_excl_info(), core::energy_methods::GenericBondedEnergy::eval_intrares_energy(), core::conformation::Residue::is_metal(), protocols::toolbox::match_enzdes_util::EnzConstraintParameters::make_constraint_covalent_helper(), perform_checks(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::pose_from_posedata(), and protocols::energy_based_clustering::EnergyBasedClusteringProtocol::storeposedata().
bool core::chemical::ResidueType::is_metalbinding | ( | ) | const |
Return true if this residue type is a type that can bind to a metal ion (e.g. His, Asp, Cys, etc.), false otherwise.
The METALBINDING property is specified in the params file under PROPERTIES.
References core::chemical::ResidueProperties::has_property(), core::chemical::METALBINDING, and core::chemical::ResidueTypeBase::properties().
Referenced by protocols::metal_interface::RemoveMetalConnectionsMover::apply(), core::scoring::bin_transitions::BinTransitionData::has_property(), core::conformation::Residue::is_metalbinding(), and perform_checks().
bool core::chemical::ResidueType::is_methylated_cterminus | ( | ) | const |
is methylated c terminus
References core::chemical::ResidueProperties::has_property(), core::chemical::METHYLATED_CTERMINUS, and core::chemical::ResidueTypeBase::properties().
|
inline |
Is this a D_AA, R_PEPTOID, or L_RNA?
Convenience function to avoid quering is_d_aa(), is_r_peptoid(), and is_l_rna() repeatedly.
References core::chemical::ResidueTypeBase::is_d_aa(), core::chemical::ResidueTypeBase::is_l_rna(), and core::chemical::ResidueTypeBase::is_r_peptoid().
Referenced by core::pack::dunbrack::SemiRotamericSingleResidueDunbrackLibrary< T, N >::bbdep_nrchi_score(), core::pack::rotamer_set::RotamerSet_::build_rotamers_for_concrete(), core::scoring::OmegaTether::eval_omega_score_residue(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::fill_rotamer_vector(), core::pack::dunbrack::SemiRotamericSingleResidueDunbrackLibrary< T, N >::fill_rotamer_vector_bbdep(), core::pack::dunbrack::MainchainTorsionReporter::get_dof(), core::pack::dunbrack::PeptideTorsionReporter::get_dof(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::get_packed_rotno(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::get_phi_from_rsd(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::get_psi_from_rsd(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::get_rotamer_from_chi_static_voronoi(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::interpolate_rotamers(), core::pack::dunbrack::SemiRotamericSingleResidueDunbrackLibrary< T, N >::rotamer_deriv_bbdep(), and core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::rotamer_energy_deriv().
|
inline |
Is this residue N-methylated?
References core::chemical::ResidueProperties::has_property(), core::chemical::N_METHYLATED, and core::chemical::ResidueTypeBase::properties().
Referenced by protocols::energy_based_clustering::EnergyBasedClusteringProtocol::alignment_atoms_in_res(), is_N_substituted(), and protocols::energy_based_clustering::EnergyBasedClusteringProtocol::use_in_rmsd().
bool core::chemical::ResidueType::is_N_substituted | ( | ) | const |
is N-substituted? Returns true if this aa is aa_pro or aa_dpr, N-methyl amino acid, peptoid, or proline-like oligourea, false otherwise
Returns true if this aa N-substituted.
References core::chemical::ResidueTypeBase::aa(), core::chemical::aa_b3p, core::chemical::aa_dpr, core::chemical::aa_pro, is_n_methylated(), core::chemical::ResidueTypeBase::is_peptoid(), and core::chemical::ou3_pro.
Referenced by protocols::cyclic_peptide::CrankshaftFlipMover::try_peptoid_flip().
|
inline |
is Nucleic Acid?
References core::chemical::ResidueTypeBase::is_DNA(), core::chemical::ResidueTypeBase::is_RNA(), and is_TNA().
Referenced by protocols::stepwise::modeler::rna::add_harmonic_chain_break_constraint(), protocols::stepwise::monte_carlo::mover::AddMover::append_residue(), protocols::minimization_packing::RotamerizeMover::apply(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::check_backbones_match(), core::conformation::check_good_cutpoint_neighbour(), protocols::stepwise::modeler::rna::figure_out_moving_rna_chain_breaks(), core::pose::fix_up_residue_type_variants(), core::pose::fix_up_residue_type_variants_at_strand_beginning(), core::pose::fix_up_residue_type_variants_at_strand_end(), protocols::unfolded_state_energy_calculator::UnfoldedStateEnergyCalculatorMover::fragment_check(), core::energy_methods::get_restag(), core::scoring::HydroxylTorsionPotential::get_restag(), core::pose::rna::get_suite_torsion_info(), protocols::stepwise::modeler::StepWiseConnectionSampler::initialize_pose_level_screeners(), protocols::stepwise::modeler::StepWiseConnectionSampler::initialize_residue_level_screeners(), core::conformation::Residue::is_NA(), core::conformation::Residue::place(), protocols::stepwise::monte_carlo::mover::AddMover::prepend_residue(), protocols::rna::movers::RNA_LoopCloser::rna_ccd_close(), protocols::stepwise::modeler::split_pose(), protocols::stepwise::modeler::rna::suite_square_deviation(), and protocols::stepwise::modeler::rna::checker::RNA_BaseCentroidChecker::update_base_stub_list().
|
inline |
Is this an oligourea?
References core::chemical::ResidueProperties::has_property(), core::chemical::OLIGOUREA, and core::chemical::ResidueTypeBase::properties().
Referenced by protocols::energy_based_clustering::EnergyBasedClusteringProtocol::alignment_atoms_in_res(), protocols::generalized_kinematic_closure::filter::GeneralizedKICfilter::apply_loop_bump_check(), protocols::generalized_kinematic_closure::perturber::GeneralizedKICperturber::apply_sample_cis_peptide_bond(), core::conformation::Conformation::backbone_torsion_angle_atoms(), core::conformation::Conformation::backbone_torsion_angle_atoms_oligourea(), core::conformation::check_good_cutpoint_neighbour(), core::pack::palette::PackerPalette::decide_what_to_do_with_base_type(), core::energy_methods::OmegaTetherEnergy::eval_residue_dof_derivative(), protocols::simple_moves::BackboneMover::get_mainchain_TorsionIDs(), protocols::cyclic_peptide::CycpepSymmetryFilter::is_cyclic_peptide(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::is_supported_restype(), protocols::simple_moves::SmallMover::move_with_rama(), protocols::simple_moves::ShearMover::move_with_rama(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::mutate_to_alanine(), core::scoring::OmegaTether::omega_index(), core::scoring::OmegaTether::phi_index(), core::scoring::OmegaTether::psi_index(), core::energy_methods::OmegaTetherEnergy::residue_energy(), and protocols::energy_based_clustering::EnergyBasedClusteringProtocol::use_this_atom().
|
inline |
Is this an ortho-aramid?
References core::chemical::ResidueProperties::has_property(), core::chemical::ORTHO_ARAMID, and core::chemical::ResidueTypeBase::properties().
Referenced by core::conformation::Conformation::backbone_torsion_angle_atoms(), core::conformation::Residue::is_ortho_aramid(), core::scoring::OmegaTether::omega_index(), core::scoring::OmegaTether::phi_index(), core::scoring::OmegaTether::psi_index(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::RotamericSingleResidueDunbrackLibrary(), and protocols::simple_moves::RandomTorsionMover::setup_torsion_list().
|
inline |
Is this a para-aramid?
References core::chemical::ResidueProperties::has_property(), core::chemical::PARA_ARAMID, and core::chemical::ResidueTypeBase::properties().
Referenced by core::conformation::Conformation::backbone_torsion_angle_atoms(), core::conformation::Residue::is_para_aramid(), core::scoring::OmegaTether::omega_index(), core::scoring::OmegaTether::phi_index(), core::scoring::OmegaTether::psi_index(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::RotamericSingleResidueDunbrackLibrary(), and protocols::simple_moves::RandomTorsionMover::setup_torsion_list().
|
inline |
bool core::chemical::ResidueType::is_polar | ( | ) | const |
is polar?
References core::chemical::ResidueProperties::has_property(), core::chemical::POLAR, and core::chemical::ResidueTypeBase::properties().
Referenced by core::scoring::bin_transitions::BinTransitionData::has_property(), core::conformation::Residue::is_apolar(), protocols::simple_filters::LongestContinuousPolarSegmentFilter::is_counted(), protocols::simple_filters::LongestContinuousApolarSegmentFilter::is_counted(), core::conformation::Residue::is_polar(), protocols::fldsgn::NcontactsCalculator::recompute(), and protocols::moves::PyMOLMover::send_polars().
|
inline |
Is this a meta-aramid?
References core::chemical::ResidueProperties::has_property(), core::chemical::POST_METHYLENE_META_ARAMID, and core::chemical::ResidueTypeBase::properties().
Referenced by core::conformation::Conformation::backbone_torsion_angle_atoms(), core::conformation::Conformation::backbone_torsion_angle_atoms_meta_aramid(), core::conformation::Residue::is_post_methylene_meta_aramid(), core::scoring::OmegaTether::omega_index(), core::scoring::OmegaTether::phi_index(), core::scoring::OmegaTether::psi_index(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::RotamericSingleResidueDunbrackLibrary(), and protocols::simple_moves::RandomTorsionMover::setup_torsion_list().
|
inline |
Is this an ortho-aramid?
References core::chemical::ResidueProperties::has_property(), core::chemical::POST_METHYLENE_ORTHO_ARAMID, and core::chemical::ResidueTypeBase::properties().
Referenced by core::conformation::Conformation::backbone_torsion_angle_atoms(), core::conformation::Conformation::backbone_torsion_angle_atoms_ortho_aramid(), core::conformation::Residue::is_post_methylene_ortho_aramid(), core::scoring::OmegaTether::omega_index(), core::scoring::OmegaTether::phi_index(), core::scoring::OmegaTether::psi_index(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::RotamericSingleResidueDunbrackLibrary(), and protocols::simple_moves::RandomTorsionMover::setup_torsion_list().
|
inline |
Is this a para-aramid?
References core::chemical::ResidueProperties::has_property(), core::chemical::POST_METHYLENE_PARA_ARAMID, and core::chemical::ResidueTypeBase::properties().
Referenced by core::conformation::Conformation::backbone_torsion_angle_atoms(), core::conformation::Conformation::backbone_torsion_angle_atoms_para_aramid(), core::conformation::Residue::is_post_methylene_para_aramid(), core::scoring::OmegaTether::omega_index(), core::scoring::OmegaTether::phi_index(), core::scoring::OmegaTether::psi_index(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::RotamericSingleResidueDunbrackLibrary(), and protocols::simple_moves::RandomTorsionMover::setup_torsion_list().
|
inline |
Is this a meta-aramid?
References core::chemical::ResidueProperties::has_property(), core::chemical::PRE_METHYLENE_META_ARAMID, and core::chemical::ResidueTypeBase::properties().
Referenced by core::conformation::Conformation::backbone_torsion_angle_atoms(), core::conformation::Conformation::backbone_torsion_angle_atoms_meta_aramid(), core::conformation::Residue::is_pre_methylene_meta_aramid(), core::scoring::OmegaTether::omega_index(), core::scoring::OmegaTether::phi_index(), core::scoring::OmegaTether::psi_index(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::RotamericSingleResidueDunbrackLibrary(), and protocols::simple_moves::RandomTorsionMover::setup_torsion_list().
|
inline |
Is this an ortho-aramid?
References core::chemical::ResidueProperties::has_property(), core::chemical::PRE_METHYLENE_ORTHO_ARAMID, and core::chemical::ResidueTypeBase::properties().
Referenced by core::conformation::Conformation::backbone_torsion_angle_atoms(), core::conformation::Conformation::backbone_torsion_angle_atoms_ortho_aramid(), core::conformation::Residue::is_pre_methylene_ortho_aramid(), core::scoring::OmegaTether::omega_index(), core::scoring::OmegaTether::phi_index(), core::scoring::OmegaTether::psi_index(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::RotamericSingleResidueDunbrackLibrary(), and protocols::simple_moves::RandomTorsionMover::setup_torsion_list().
|
inline |
Is this a para-aramid?
References core::chemical::ResidueProperties::has_property(), core::chemical::PRE_METHYLENE_PARA_ARAMID, and core::chemical::ResidueTypeBase::properties().
Referenced by core::conformation::Conformation::backbone_torsion_angle_atoms(), core::conformation::Conformation::backbone_torsion_angle_atoms_para_aramid(), core::conformation::Residue::is_pre_methylene_para_aramid(), core::scoring::OmegaTether::omega_index(), core::scoring::OmegaTether::phi_index(), core::scoring::OmegaTether::psi_index(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::RotamericSingleResidueDunbrackLibrary(), and protocols::simple_moves::RandomTorsionMover::setup_torsion_list().
|
inline |
Is this a meta-aramid?
References core::chemical::ResidueProperties::has_property(), core::chemical::PRE_METHYLENE_POST_METHYLENE_META_ARAMID, and core::chemical::ResidueTypeBase::properties().
Referenced by core::conformation::Conformation::backbone_torsion_angle_atoms(), core::conformation::Conformation::backbone_torsion_angle_atoms_meta_aramid(), core::conformation::Residue::is_pre_methylene_post_methylene_meta_aramid(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::RotamericSingleResidueDunbrackLibrary(), and protocols::simple_moves::RandomTorsionMover::setup_torsion_list().
|
inline |
Is this an ortho-aramid?
References core::chemical::ResidueProperties::has_property(), core::chemical::PRE_METHYLENE_POST_METHYLENE_ORTHO_ARAMID, and core::chemical::ResidueTypeBase::properties().
Referenced by core::conformation::Conformation::backbone_torsion_angle_atoms(), core::conformation::Conformation::backbone_torsion_angle_atoms_ortho_aramid(), core::conformation::Residue::is_pre_methylene_post_methylene_ortho_aramid(), core::scoring::OmegaTether::omega_index(), core::scoring::OmegaTether::phi_index(), core::scoring::OmegaTether::psi_index(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::RotamericSingleResidueDunbrackLibrary(), and protocols::simple_moves::RandomTorsionMover::setup_torsion_list().
|
inline |
Is this a para-aramid?
References core::chemical::ResidueProperties::has_property(), core::chemical::PRE_METHYLENE_POST_METHYLENE_PARA_ARAMID, and core::chemical::ResidueTypeBase::properties().
Referenced by core::conformation::Conformation::backbone_torsion_angle_atoms(), core::conformation::Conformation::backbone_torsion_angle_atoms_para_aramid(), core::conformation::Residue::is_pre_methylene_post_methylene_para_aramid(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::RotamericSingleResidueDunbrackLibrary(), and protocols::simple_moves::RandomTorsionMover::setup_torsion_list().
|
inline |
number of proton chis
References proton_chis_.
Referenced by protocols::ligand_docking::ga_ligand_dock::EntropyEstimator::analyze_trajectory(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::chisamples_for_rotamer_and_chi(), core::chemical::MutableResidueType::copy_other_info(), protocols::ligand_docking::ga_ligand_dock::GALigandDock::eval_docked_pose_helper(), protocols::match::upstream::FullChiSampleSet::expand_non_dunbrack_chi(), protocols::ligand_docking::ga_ligand_dock::EntropyEstimator::get_contacting_reslist(), core::energy_methods::IdealParametersDatabase::lookup_torsion_legacy(), core::pack::optimize_H_and_notify(), core::chemical::print_chis(), protocols::ligand_docking::ga_ligand_dock::EntropyEstimator::SimpleEntropy(), and core::chemical::write_topology_file().
bool core::chemical::ResidueType::is_purine | ( | ) | const |
is purine?
References core::chemical::ResidueProperties::has_property(), core::chemical::ResidueTypeBase::properties(), and core::chemical::PURINE.
Referenced by protocols::stepwise::legacy::modeler::rna::apply_chi_cst(), protocols::stepwise::monte_carlo::rna::RNA_TorsionMover::apply_random_nucleoside_torsion(), core::scoring::rna::RNA_TorsionPotential::eval_atom_derivative(), core::scoring::rna::RNA_TorsionPotential::eval_intrares_energy(), core::conformation::Residue::is_purine(), protocols::stepwise::modeler::rna::sugar::SugarModeling::set_base_and_pucker_state(), protocols::stepwise::modeler::rna::rigid_body::setup_pose_with_moving_residue_alternative_list(), and protocols::stepwise::sampler::rna::setup_sampler().
bool core::chemical::ResidueType::is_pyrimidine | ( | ) | const |
bool core::chemical::ResidueType::is_repulsive | ( | Size const | atomno | ) | const |
Check if atom is repulsive.
References atom_type().
Return whether this atom is in a particular ring.
References core::sequence::end, and ring_atoms_.
Referenced by core::energy_methods::CartesianBondedEnergy::eval_singleres_angle_derivatives(), core::energy_methods::CartesianBondedEnergy::eval_singleres_angle_energies(), core::energy_methods::CartesianBondedEnergy::eval_singleres_torsion_derivatives(), and core::scoring::is_carbohydrate_ring_atom().
|
inline |
is sidechain amine?
References core::chemical::ResidueProperties::has_property(), core::chemical::ResidueTypeBase::properties(), and core::chemical::SIDECHAIN_AMINE.
|
inline |
is thiol?
References core::chemical::ResidueProperties::has_property(), core::chemical::ResidueTypeBase::properties(), and core::chemical::SIDECHAIN_THIOL.
Referenced by core::pack::task::operation::OptCysHG::apply(), core::conformation::change_cys_state(), core::conformation::Conformation::detect_disulfides(), core::conformation::symmetry::SymmetricConformation::detect_disulfides(), core::scoring::disulfides::DisulfideMatchingEnergyContainer::disulfides_changed(), protocols::cyclic_peptide::crosslinker::Thioether_Helper::get_thioether_residues_from_selection(), core::scoring::bin_transitions::BinTransitionData::has_property(), protocols::cyclic_peptide::crosslinker::Metal_HelperBase::liganding_atom_from_restype(), core::energy_methods::DisulfideMatchingEnergy::residue_pair_energy(), core::energy_methods::FullatomDisulfideEnergy::residue_pair_energy(), protocols::cyclic_peptide::crosslinker::set_up_thioether_variants(), and core::pose::full_model_info::update_disulfides_from_full_model_info().
bool core::chemical::ResidueType::is_solvent | ( | ) | const |
Is this a solvent molecule (SOLVENT property)?
References core::chemical::ResidueProperties::has_property(), core::chemical::ResidueTypeBase::properties(), and core::chemical::SOLVENT.
Referenced by core::conformation::Conformation::bonded_neighbor_all_res(), and core::io::pose_to_sfr::PoseToStructFileRepConverter::grab_conect_records_for_atom().
bool core::chemical::ResidueType::is_sri | ( | ) | const |
Is this one of SRI's special heteropolymer building blocks?
References core::chemical::ResidueProperties::has_property(), core::chemical::ResidueTypeBase::properties(), and core::chemical::SRI.
Referenced by core::conformation::check_good_cutpoint_neighbour(), and core::conformation::Residue::is_sri().
bool core::chemical::ResidueType::is_surface | ( | ) | const |
is surface? (e.g. enamel)
References core::chemical::ResidueProperties::has_property(), core::chemical::ResidueTypeBase::properties(), and core::chemical::SURFACE.
Referenced by core::conformation::Residue::is_surface().
|
inline |
is terminus?
References core::chemical::ResidueProperties::has_property(), is_lower_terminus(), is_upper_terminus(), core::chemical::ResidueTypeBase::properties(), and core::chemical::TERMINUS.
Referenced by protocols::fldsgn::potentials::sspot::get_foldtree_seqsep(), core::scoring::SecondaryStructurePotential::get_foldtree_seqsep(), core::conformation::Residue::is_terminus(), and core::energy_methods::GoapEnergy::setup_for_scoring().
|
inline |
is TNA?
References core::chemical::ResidueProperties::has_property(), core::chemical::ResidueTypeBase::properties(), and core::chemical::TNA.
Referenced by protocols::stepwise::sampler::rna::RNA_SugarStepWiseSampler::apply(), core::chemical::rna::default_jump_atom(), core::scoring::loop_graph::evaluator::SixDTransRotPotentialEvaluator::evaluate(), protocols::stepwise::modeler::figure_out_moving_chain_breaks(), core::pose::fix_up_residue_type_variants_at_strand_beginning(), core::pose::fix_up_residue_type_variants_at_strand_end(), core::scoring::constraints::BasePairConstraint::init_subsidiary_constraints(), protocols::stepwise::modeler::align::StepWiseClusterer::initialize_parameters(), protocols::stepwise::modeler::StepWiseConnectionSampler::initialize_sampler(), is_NA(), core::conformation::Residue::is_TNA(), core::pose::rna::is_torsion_valid(), protocols::stepwise::monte_carlo::mover::TransientCutpointHandler::put_in_cutpoints(), protocols::stepwise::sampler::rna::setup_sampler(), protocols::stepwise::monte_carlo::mover::TransientCutpointHandler::take_out_cutpoints(), core::chemical::rna::RNA_Info::update_derived_rna_data(), and protocols::stepwise::modeler::align::StepWisePoseAligner::update_superimpose_atom_id_map().
bool core::chemical::ResidueType::is_TP3 | ( | ) | const |
Check if residue is a TP3 water.
References core::chemical::ResidueProperties::has_property(), core::chemical::ResidueTypeBase::properties(), and core::chemical::TP3.
bool core::chemical::ResidueType::is_triazolemer | ( | ) | const |
Is this a triazolemer?
References core::chemical::ResidueProperties::has_property(), core::chemical::ResidueTypeBase::properties(), and core::chemical::TRIAZOLE_LINKER.
Referenced by core::conformation::Residue::is_triazolemer().
bool core::chemical::ResidueType::is_upper_terminus | ( | ) | const |
is upper terminus?
References core::chemical::ResidueProperties::has_property(), core::chemical::ResidueTypeBase::properties(), and core::chemical::UPPER_TERMINUS.
Referenced by protocols::energy_based_clustering::EnergyBasedClusteringProtocol::add_cyclic_constraints(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::alignment_atoms_in_res(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::alignment_torsions_in_res(), protocols::simple_moves::chiral::ChiralMover::apply(), core::io::pose_from_sfr::PoseFromSFRBuilder::build_initial_pose(), protocols::flexpep_docking::FlexPepDockingPoseMetrics::calc_phipsi_RMSD(), core::energy_methods::IdealParametersDatabase::create_parameters_for_restype(), protocols::loops::find_non_protein_chunks(), core::pose::symmetry::get_asymmetric_pose_copy_from_symmetric_pose(), core::scoring::dna::DNATorsionPotential::get_atom_ids_by_torsion(), protocols::rbsegment_relax::guess_rbsegs_from_pose(), protocols::cyclic_peptide::PeptideStubMover::handle_lower_terminus(), protocols::cyclic_peptide::PeptideStubMover::handle_upper_terminus(), core::scoring::facts::FACTSRsdTypeInfo::initialize_parameters(), is_terminus(), core::conformation::Residue::is_upper_terminus(), core::pose::make_pose_from_sequence(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::pose_from_posedata(), core::io::pose_from_sfr::PoseFromSFRBuilder::refine_pose(), core::pose::remove_ligand_canonical_residues(), core::chemical::ResidueDatabaseIO::report_residue_type(), core::pack::palette::PackerPalette::saccharide_backbones_are_compatible(), protocols::fldsgn::potentials::sspot::SSPairPotential::score(), protocols::fldsgn::potentials::sspot::HSPairPotential::score(), protocols::fldsgn::potentials::sspot::NatbiasStrandPairPotential::score(), protocols::dna::set_base_segment_chainbreak_constraints(), protocols::legacy_sewing::Assembly::to_pose(), and protocols::sewing::data_storage::SmartAssembly::to_pose().
bool core::chemical::ResidueType::is_virtual | ( | Size const | atomno | ) | const |
Check if atom is virtual.
References atom_has_property(), atom_type(), and core::chemical::VIRTUAL_ATOM.
Referenced by protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::align_and_calculate_rmsd(), core::conformation::Conformation::bonded_neighbor_all_res(), core::simple_metrics::per_residue_metrics::PerResidueRMSDMetric::create_atom_id_map(), core::scoring::ResidueExclParams::create_excl_info(), core::pose::rna::detect_base_contacts(), core::pose::rna::detect_sugar_contacts(), protocols::stepwise::modeler::align::StepWisePoseAligner::do_checks(), core::pack::figure_out_repackable_residues(), core::scoring::elec::GroupElec::get_group(), protocols::stepwise::modeler::polar_hydrogens::PolarHydrogenPacker::get_possible_hbond_acceptors(), protocols::stepwise::modeler::rna::get_surrounding_O2prime_hydrogen(), protocols::rna::movers::ErraserMinimizerMover::i_want_this_atom_to_move(), core::pose::rna::is_torsion_valid(), protocols::drug_design::ConformationSelectionToRDMol::Mol(), perform_checks(), protocols::toolbox::match_enzdes_util::InvrotTreeNode::remove_invrots_clashing_with_parent_res(), select_orient_atoms_standard_logic(), core::pose::copydofs::setup_atom_id_map_match_atom_names(), show(), protocols::rna::denovo::movers::RNA_Minimizer::update_atom_level_domain_map_with_extra_minimize_res(), and core::chemical::rna::RNA_Info::update_derived_rna_data().
bool core::chemical::ResidueType::is_virtual_residue | ( | ) | const |
Check if residue is 'VIRTUAL_RESIDUE' This ONLY checks the VIRTUAL_RESIDUE PROPERTY!
References core::chemical::ResidueProperties::has_property(), core::chemical::ResidueTypeBase::properties(), and core::chemical::VIRTUAL_RESIDUE.
Referenced by protocols::simple_moves::ConvertRealToVirtualMover::apply(), protocols::simple_moves::ConvertVirtualToRealMover::apply(), core::simple_metrics::per_residue_metrics::PerResidueClashMetric::calculate(), core::pack::guidance_scoreterms::voids_penalty_energy::VoidsPenaltyVoxelGrid::compute_burial(), core::simple_metrics::per_residue_metrics::PerResidueDensityFitMetric::compute_scores(), core::scoring::ResidueExclParams::create_excl_info(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::do_ABOXYZ_bin_analysis(), core::pose::fix_up_residue_type_variants(), core::io::pose_to_sfr::PoseToStructFileRepConverter::grab_conect_records_for_atom(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::is_all_alpha_aa_or_peptoid(), core::conformation::Residue::is_virtual_residue(), core::scoring::lDDT_Calculator::make_identity_map(), core::pack::guidance_scoreterms::voids_penalty_energy::VoidsPenaltyVoxelGrid::prune_voxels_for_fixed_residues(), core::import_pose::setup_fold_trees(), protocols::stepwise::modeler::slice(), protocols::stepwise::modeler::rna::suite_square_deviation(), and core::scoring::superimpose_polymer_heavyatoms().
|
inline |
Is this a residue type that can be virtualized or devirtualized by the packer?
References core::chemical::ResidueProperties::has_property(), core::chemical::ResidueTypeBase::properties(), and core::chemical::VIRTUALIZABLE_BY_PACKER.
bool core::chemical::ResidueType::is_VRT1 | ( | ) | const |
Check if residue is 'VRT1'.
References core::chemical::ResidueProperties::has_property(), core::chemical::ResidueTypeBase::properties(), and core::chemical::VRT1.
|
inline |
is this a water residue type?
References core::chemical::ResidueProperties::has_property(), core::chemical::ResidueTypeBase::properties(), and core::chemical::WATER.
Referenced by protocols::simple_task_operations::RestrictToInterface::apply(), protocols::simple_moves::ExplicitWaterMover::build_lkboverlap_rotamer_clouds(), core::simple_metrics::per_residue_metrics::WaterMediatedHbondMetric::calculate(), core::scoring::ResidueExclParams::create_excl_info(), core::energy_methods::GenericBondedEnergy::eval_intrares_energy(), protocols::ligand_docking::ga_ligand_dock::GALigandDock::final_exact_cartmin(), protocols::ligand_docking::ga_ligand_dock::GALigandDock::final_exact_scmin(), and core::conformation::Residue::is_water().
|
inline |
index of the last backbone heavy atom
References n_backbone_heavyatoms_.
Referenced by protocols::hybridization::FragmentBiasAssigner::bfactors(), core::scoring::ResidueExclParams::create_excl_info(), protocols::constraint_movers::AddConstraintsToCurrentConformationMover::generate_coordinate_constraints(), core::conformation::Residue::last_backbone_atom(), protocols::features::PdbDataFeatures::load_residue_pdb_confidence(), protocols::hybridization::InsertChunkMover::set_bb_xyz_aligned(), and core::pose::copydofs::setup_atom_id_map_match_atom_names().
|
inline |
Read access to the last_controlling_chi_ array.
References last_controlling_chi_.
Referenced by protocols::stepwise::modeler::align::StepWisePoseAligner::do_checks(), protocols::match::upstream::UpstreamResTypeGeometry::initialize_from_residue_type(), and core::chemical::rna::RNA_Info::update_derived_rna_data().
The last_controlling_chi for an atom. 0 if an atom is controlled by no chi.
References last_controlling_chi_.
|
inline |
Low-energy ring conformers for each ring.
References low_ring_conformers_.
Referenced by core::chemical::MutableResidueType::copy_other_info(), and core::chemical::write_topology_file().
ResidueConnection const & core::chemical::ResidueType::lower_connect | ( | ) | const |
References core::chemical::ResidueTypeBase::has_property(), lower_connect_id_, core::chemical::POLYMER, core::chemical::ResidueTypeBase::properties(), and residue_connections_.
Referenced by define_mainchain_atoms(), core::energy_methods::CartesianBondedEnergy::eval_intraresidue_dof_derivative(), core::conformation::Conformation::insert_ideal_geometry_at_polymer_bond(), core::conformation::Residue::lower_connect(), protocols::simple_moves::CyclizationMover::setup_constraints(), core::chemical::write_topology_file(), and core::chemical::ICoorAtomID::xyz().
Size core::chemical::ResidueType::lower_connect_atom | ( | ) | const |
index number of the atom which connects to the lower connection
References core::chemical::ResidueTypeBase::has_property(), lower_connect_id_, core::chemical::POLYMER, core::chemical::ResidueTypeBase::properties(), and residue_connections_.
Referenced by protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::add_amide_bond_cyclic_constraints(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::add_closebond_logic_isopeptide(), core::import_pose::build_pose_as_is2(), protocols::denovo_design::connection::AreConnectablePredicate::check_distance(), core::scoring::ResidueExclParams::create_excl_info(), define_mainchain_atoms(), core::conformation::Residue::lower_connect_atom(), protocols::cyclic_peptide::PeptideStubMover::preserve_old_mainchain_torsions(), and core::chemical::ResidueDatabaseIO::report_residue_type().
|
inline |
References lower_connect_id_.
Referenced by core::conformation::Conformation::append_residue_by_bond(), core::conformation::Conformation::append_residues(), core::select::residue_selector::BinSelector::apply(), core::select::residue_selector::PhiSelector::apply(), protocols::simple_moves::DeclareBond::apply(), protocols::ligand_docking::ga_ligand_dock::GALigandDock::apply(), protocols::generalized_kinematic_closure::perturber::GeneralizedKICperturber::apply_copy_backbone_dihedrals(), core::scoring::bin_transitions::BinTransitionCalculator::are_normally_bonded(), core::chemical::ICoorAtomID::atom_id(), core::conformation::Conformation::backbone_torsion_angle_atoms(), 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(), core::conformation::Conformation::backbone_torsion_angle_atoms_para_aramid(), core::import_pose::build_pose_as_is2(), protocols::cyclic_peptide::CycpepRigidBodyPermutationMover::confirm_is_cyclic_peptide(), core::conformation::Residue::connected_residue_at_lower(), core::chemical::MutableResidueType::copy_other_info(), core::scoring::ResidueExclParams::create_excl_info(), core::energy_methods::IdealParametersDatabase::create_parameters_for_restype(), define_mainchain_atoms(), core::scoring::Ramachandran::defines_score_for_residue(), core::io::silent::BinarySilentStruct::fill_struct(), protocols::cyclic_peptide::CycpepRigidBodyPermutationMover::generate_cycpep_pose_copy(), protocols::cyclic_peptide::PeptideStubMover::get_connecting_id_for_append_by_bond(), core::io::pose_to_sfr::PoseToStructFileRepConverter::get_connectivity_annotation_info(), core::pack::dunbrack::PeptoidOmegaReporter::get_dof(), protocols::ligand_docking::ga_ligand_dock::get_ligand_resids(), protocols::ligand_docking::ga_ligand_dock::GALigandDock::get_ligand_resids(), protocols::cyclic_peptide::PeptideStubMover::handle_termini_and_store_terminal_dihedrals(), core::conformation::Residue::has_lower_connect(), protocols::chemically_conjugated_docking::UBQ_GTPaseMover::initialize(), core::pack::dunbrack::PeptoidOmegaReporter::insert_atoms_defining_dof(), protocols::cyclic_peptide::CycpepSymmetryFilter::is_cyclic_peptide(), core::conformation::Residue::is_polymer_bonded(), protocols::stepwise::monte_carlo::mover::StepWiseMasterMover::moves_for_pose(), core::scoring::bin_transitions::BinTransitionCalculator::random_bin_based_on_prev_and_next(), protocols::simple_moves::CyclizationMover::setup_constraints(), and core::chemical::write_topology_file().
|
inline |
For each ring, what's the lowest conformer?
References lowest_ring_conformer_.
Referenced by core::chemical::MutableResidueType::copy_other_info(), and core::chemical::write_topology_file().
index of mainchain atom
References mainchain_atoms_indices_.
Referenced by protocols::helical_bundle::align_mainchain_atoms(), protocols::helical_bundle::align_mainchain_atoms_of_residue_range(), protocols::helical_bundle::FitSimpleHelix::apply(), protocols::helical_bundle::copy_helix_bondangles(), protocols::helical_bundle::copy_helix_bondlengths(), core::conformation::Conformation::insert_ideal_geometry_at_polymer_bond(), core::conformation::Residue::mainchain_atom(), and protocols::helical_bundle::place_atom_positions().
|
inline |
indices of all mainchain atoms
References mainchain_atoms_indices_.
Referenced by protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::add_amide_bond_cyclic_constraints(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::add_bondangle_perturbation(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::add_bondlength_perturbation(), protocols::helical_bundle::align_mainchain_atoms(), core::scoring::MultipoleElecPotential::align_residue_multipole_axes(), protocols::helical_bundle_predict::HelicalBundlePredictApplication::align_to_native_pose(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::alignment_atoms_in_res(), core::chemical::rotamers::NCAARotamerLibrarySpecification::cache_tag(), protocols::backrub::connected_mainchain_atomids(), protocols::helical_bundle::copy_helix_bondangles(), protocols::helical_bundle::copy_helix_bondlengths(), core::chemical::MutableResidueType::copy_other_info(), core::energy_methods::RamaPreProEnergy::eval_intraresidue_dof_derivative(), core::pose::carbohydrates::find_neighbor(), protocols::stepwise::modeler::StepWiseConnectionSampler::initialize_generic_polymer_bond_sampler(), core::conformation::Conformation::insert_ideal_geometry_at_polymer_bond(), protocols::features::PdbDataFeatures::insert_residue_pdb_confidence_rows(), core::chemical::is_mainchain_torsion_also_ring_torsion(), core::conformation::Residue::mainchain_atoms(), core::conformation::Residue::n_mainchain_atoms(), core::io::pose_from_sfr::PoseFromSFRBuilder::pass_3_verify_sufficient_backbone_atoms(), core::conformation::Residue::Residue(), core::energy_methods::RamaPreProEnergy::residue_pair_energy(), core::pack::palette::PackerPalette::saccharide_backbones_are_compatible(), core::pose::carbohydrates::set_glycan_iupac_bb_torsions(), core::pose::carbohydrates::setup_existing_glycans(), protocols::energy_based_clustering::EnergyBasedClusteringProtocol::use_this_atom(), core::chemical::ResidueTypeKinWriter::write_restype(), and core::chemical::write_topology_file().
|
static |
Make a ResidueType from a Modifiable residue type.
In practice, this is the only way to create (or change) a ResidueType object.
By using a static function and not a constructor, this ensures that all ResidueTypes are on the heap (and can shared_from_this()), and allows us to do OP-requiring subobject updates in self_pointer_updates().
References ResidueType().
Referenced by core::chemical::ResidueTypeSet::add_base_residue_type(), core::chemical::ResidueTypeSet::add_unpatchable_residue_type(), protocols::drug_design::bcl::BCLFragmentMutateMover::apply(), core::chemical::GlobalResidueTypeSet::deal_with_patch_special_cases(), core::chemical::ResidueTypeSet::force_add_base_residue_type_already_write_locked(), core::chemical::PoseResidueTypeSet::generate_residue_type_write_locked(), core::chemical::ResidueTypeSet::generate_residue_type_write_locked(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibraryParser::hacky_parser_init_workaround(), core::pack::dunbrack::SingleResidueDunbrackLibrary::hokey_template_workaround(), and core::pose::Pose::real_to_virtual().
|
inline |
get the molecular weight of this residue
References mass_.
Referenced by protocols::ligand_docking::ga_ligand_dock::GALigandDock::eval_docked_pose_helper(), core::pose::mass(), and protocols::qsar::scoring_grid::MolecularWeightNormalization::operator()().
MMAtomType const & core::chemical::ResidueType::mm_atom_type | ( | Size const | atomno | ) | const |
Get the MM atom_type for this atom by its index number in this residue.
References mm_atom_type_index(), and core::chemical::ResidueTypeBase::mm_atom_types_ptr().
Referenced by print_bondangles(), and core::chemical::write_topology_file().
|
inline |
References mm_atom_type_index_, and natoms_.
Referenced by core::scoring::methods::MMBondAngleEnergy::eval_atom_derivative(), core::scoring::methods::MMBondLengthEnergy::eval_atom_derivative(), core::scoring::methods::MMTorsionEnergy::eval_atom_derivative(), core::scoring::methods::MMTorsionEnergy::eval_intrares_derivatives(), core::scoring::methods::MMTorsionEnergy::eval_intrares_energy(), core::scoring::methods::MMBondAngleEnergy::eval_intrares_energy(), core::scoring::methods::MMBondLengthEnergy::eval_intrares_energy(), core::scoring::mm::MMBondAngleResidueTypeParamSet::lookup(), mm_atom_type(), mm_name(), protocols::branch_angle::BranchAngleOptimizer::param1(), protocols::branch_angle::BranchAngleOptimizer::param2(), core::conformation::Residue::Residue(), core::scoring::methods::MMBondAngleEnergy::residue_pair_energy(), core::scoring::methods::MMBondLengthEnergy::residue_pair_energy(), core::scoring::methods::MMTorsionEnergy::residue_pair_energy(), protocols::simple_moves::CyclizationMover::setup_constraints(), and show().
std::string const & core::chemical::ResidueType::mm_name | ( | core::Size | atomno | ) | const |
References mm_atom_type_index(), and core::chemical::ResidueTypeBase::mm_atom_types_ptr().
Referenced by core::scoring::SplitUnfoldedTwoBodyPotential::calculate_residue_emap(), core::chemical::MutableResidueType::copy_atom_info(), core::scoring::methods::MMTorsionEnergy::eval_intrares_energy(), core::scoring::methods::MMBondAngleEnergy::eval_intrares_energy(), core::scoring::methods::MMBondLengthEnergy::eval_intrares_energy(), core::scoring::mm::MMBondAngleResidueTypeParam::init(), core::conformation::Residue::mm_atom_name(), print_bondangles(), core::chemical::ResidueDatabaseIO::report_residue_type_atom(), core::scoring::methods::MMBondAngleEnergy::residue_pair_energy(), core::scoring::methods::MMBondLengthEnergy::residue_pair_energy(), core::scoring::methods::MMTorsionEnergy::residue_pair_energy(), protocols::simple_moves::CyclizationMover::setup_constraints(), show(), update_derived_data(), and core::chemical::ResidueTypeKinWriter::write_restype().
|
inline |
number of hbond_acceptors
References n_hbond_acceptors_.
Referenced by core::conformation::Residue::n_hbond_acceptors().
|
inline |
number of hbond_donors
References n_hbond_donors_.
Referenced by core::conformation::Residue::n_hbond_donors().
|
inline |
|
inline |
Return number of nu (internal ring) angles.
References nu_atoms_.
Referenced by auto_assign_nu_atoms(), core::chemical::MutableResidueType::copy_other_info(), core::chemical::is_mainchain_torsion_also_ring_torsion(), core::conformation::Residue::n_nus(), core::conformation::Residue::Residue(), core::conformation::Residue::update_nus(), and core::chemical::write_topology_file().
|
inline |
References n_polymeric_residue_connections_.
Referenced by core::conformation::Residue::n_polymeric_residue_connections().
Size core::chemical::ResidueType::n_possible_residue_connections | ( | ) | const |
number of ResidueConnections, counting polymeric residue connections
References residue_connections_.
Referenced by protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::add_amide_bond_cyclic_constraints(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::add_closebond_logic_isopeptide(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::add_closebond_logic_thioether_lariat(), atom_depends_on_connection(), branch_connect_atoms(), core::chemical::MutableResidueType::copy_other_info(), core::conformation::Residue::copy_residue_connections(), protocols::ligand_docking::ga_ligand_dock::GridScorer::derivatives(), core::conformation::Conformation::detect_bonds(), core::conformation::Conformation::detect_pseudobonds(), core::conformation::disulfide_bonds(), protocols::cyclic_peptide::dump_debug_output(), protocols::viewer::dump_residue_kinemage(), core::io::silent::BinarySilentStruct::fill_struct(), protocols::abinitio::abscript::find_disulfide_partner(), core::scoring::disulfides::FullatomDisulfideEnergyContainer::find_disulfides(), core::conformation::form_disulfide(), protocols::cyclic_peptide::CycpepRigidBodyPermutationMover::generate_cycpep_pose_copy(), core::conformation::get_disulf_partner(), core::conformation::get_second_atom_from_connection(), core::chemical::ICoorAtomID::ICoorAtomID(), core::scoring::mm::MMBondAngleResidueTypeParam::init(), protocols::chemically_conjugated_docking::UBQ_GTPaseMover::initialize(), protocols::drug_design::ConformationSelectionToRDMol::Mol(), core::conformation::Residue::n_possible_residue_connections(), core::pose::Pose::real_to_virtual(), core::conformation::Residue::Residue(), protocols::ligand_docking::ga_ligand_dock::GridScorer::score(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::set_up_cterm_isopeptide_cyclization_mover(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::set_up_nterm_isopeptide_cyclization_mover(), protocols::cyclic_peptide_predict::SimpleCycpepPredictApplication::set_up_sidechain_isopeptide_cyclization_mover(), protocols::cyclic_peptide::crosslinker::set_up_thioether_bond_mover(), protocols::cyclic_peptide::crosslinker::set_up_thioether_constraints(), core::conformation::Residue::update_connections_to_other_residue(), update_nonpolymer_dependent_groups(), core::pose::Pose::virtual_to_real(), and core::chemical::write_topology_file().
|
inline |
number of proton chis
References proton_chis_.
Referenced by protocols::stepwise::modeler::polar_hydrogens::check_if_proton_chi_atom(), protocols::simple_moves::check_if_proton_chi_atom(), core::pack::rotamers::SingleResidueRotamerLibrary::compute_proton_chi_samplings(), core::pack::rotamers::SingleNCAARotamerLibraryCreator::create(), protocols::simple_moves::DumpSingleResidueRotamers::enumerate_aa_rotamer(), core::pack::rotamers::SingleResidueRotamerLibrary::expand_proton_chis(), protocols::stepwise::modeler::StepWiseConnectionSampler::initialize_generic_polymer_bond_sampler(), core::pack::optimize_H_and_notify(), and core::chemical::ResidueDatabaseIO::report_residue_type_proton_chi().
How many inter-residue chemical bonds does a particular atom form?
References atom_2_residue_connection_map_.
Referenced by core::energy_methods::LK_hack::calculate_orientation_vectors_and_pseudo_base_atoms(), core::conformation::Residue::copy_residue_connections(), core::conformation::Conformation::detect_bonds(), core::energy_methods::LK_hack::distribute_pseudo_base_atom_derivatives(), core::energy_methods::LK_PolarNonPolarEnergy::get_base_vector(), and core::energy_methods::LK_hack::residue_pair_energy().
core::Size core::chemical::ResidueType::n_ring_conformer_sets | ( | ) | const |
References ring_conformer_sets_.
|
inline |
Return the number of rings in this residue.
References ring_atoms_.
Referenced by protocols::simple_moves::RingConformationMover::apply(), auto_assign_nu_atoms(), core::io::pose_from_sfr::PoseFromSFRBuilder::build_initial_pose(), core::chemical::MutableResidueType::copy_other_info(), core::energy_methods::CartesianBondedEnergy::eval_interresidue_ring_derivatives(), core::energy_methods::CartesianBondedEnergy::eval_interresidue_ring_energy(), core::energy_methods::CartesianBondedEnergy::eval_singleres_angle_derivatives(), core::energy_methods::CartesianBondedEnergy::eval_singleres_angle_energies(), core::energy_methods::CartesianBondedEnergy::eval_singleres_ring_derivatives(), core::energy_methods::CartesianBondedEnergy::eval_singleres_ring_energies(), core::energy_methods::CartesianBondedEnergy::eval_singleres_torsion_derivatives(), core::conformation::is_atom_axial_or_equatorial(), core::conformation::Residue::ring_conformer(), core::pose::Pose::set_ring_conformation(), core::conformation::Residue::show(), show(), protocols::ligand_docking::ga_ligand_dock::LigandConformer::to_pose(), protocols::ligand_docking::ga_ligand_dock::LigandConformer::update_conf(), protocols::ligand_docking::ga_ligand_dock::LigandConformer::update_ligand_conf(), update_ring_conformer_sets(), and core::chemical::write_topology_file().
|
overridevirtual |
Counts the number of virtual atoms and returns the count.
The virtual count is not stored in the resiude type. This count is performed on the fly, and can hurt performance if reapeatedly carried out. Not intended for use in large loops – instead, call once and store the value.
The virtual count is not stored in the residue type. This count is performed on the fly, and can hurt performance if repeatedly carried out. Not intended for use in large loops – instead, call once and store the value.
Implements core::chemical::ResidueTypeBase.
References vec_atom_types_.
Referenced by core::conformation::Residue::n_virtual_atoms().
|
inlineoverridevirtual |
number of atoms
Implements core::chemical::ResidueTypeBase.
References natoms_.
Referenced by core::conformation::annotated_atom_graph_from_conformation(), protocols::enzdes::GenerateStoredRBConfs::apply(), protocols::rbsegment_relax::IdealizeHelicesMover::apply(), protocols::rna::movers::RNAIdealizeMover::apply(), core::pose::rna::RNA_IdealCoord::apply_coords(), core::conformation::symmetry::SymmetricConformation::apply_transform_Rx_plus_v(), core::conformation::Residue::apply_transform_Rx_plus_v(), atom_depends_on_connection(), atom_depends_on_lower_polymeric_connection(), atom_depends_on_polymeric_connection(), atom_depends_on_upper_polymeric_connection(), core::conformation::atom_graph_from_conformation(), atom_is_backbone(), atom_is_hydrogen(), atom_is_sidechain(), core::chemical::AtomRefMapping< FromRef, ToRef >::AtomRefMapping(), core::chemical::Metapatch::atoms(), core::chemical::AutomorphismIterator::AutomorphismIterator(), core::pack::rotamer_set::build_anchorless_water_rotamers(), core::pack::rotamers::SingleLigandRotamerLibrary::build_base_rotamers(), core::pack::rotamer_set::build_fixed_O_water_rotamers_independent(), core::pack::rotamer_set::build_moving_O_water_rotamers_dependent(), core::pack::rotamer_set::build_moving_O_water_rotamers_independent(), core::pack::rotamer_set::build_single_anchor_water_rotamers_independet(), protocols::analysis::InterfaceAnalyzerMover::calc_hbond_sasaE(), core::scoring::calc_per_res_hydrophobic_sasa(), core::scoring::SplitUnfoldedTwoBodyPotential::calculate_residue_emap(), protocols::features::ProteinResidueConformationFeatures::check_num_requested_atoms(), core::pack::guidance_scoreterms::voids_penalty_energy::VoidsPenaltyVoxelGrid::compute_bounding_box(), protocols::analysis::InterfaceAnalyzerMover::compute_interface_delta_hbond_unsat(), core::chemical::MutableResidueType::copy_atom_info(), protocols::cyclic_peptide::CycpepRigidBodyPermutationMover::copy_cycpep_pose_coordinates_to_original_pose(), core::conformation::copy_residue_coordinates_and_rebuild_missing_atoms(), protocols::cyclic_peptide::PeptideInternalHbondsMetric::count_hbonds(), core::simple_metrics::per_residue_metrics::PerResidueRMSDMetric::create_atom_id_map(), core::scoring::ResidueExclParams::create_excl_info(), core::energy_methods::IdealParametersDatabase::create_parameters_for_restype(), debug_dump_icoor(), core::io::pose_to_sfr::PoseToStructFileRepConverter::determine_atom_indices(), protocols::stepwise::modeler::align::StepWisePoseAligner::do_checks(), core::scoring::methods::MMTorsionEnergy::eval_intrares_derivatives(), core::scoring::methods::MMBondLengthEnergy::eval_intrares_energy(), core::chemical::find_best_match(), first_sidechain_atom(), core::chemical::formatted_icoord_tree(), core::scoring::elec::GroupElec::get_group(), core::chemical::get_residue_path_distances(), core::scoring::mm::MMBondAngleResidueTypeParam::init(), core::pose::initialize_atomid_map(), initialize_derived_data(), protocols::match::upstream::UpstreamResTypeGeometry::initialize_from_residue_type(), core::scoring::facts::FACTSRsdTypeInfo::initialize_intrascale(), core::scoring::facts::FACTSRsdTypeInfo::initialize_parameters(), protocols::features::PdbDataFeatures::load_residue_pdb_confidence(), core::conformation::Residue::natoms(), protocols::ligand_docking::LigandDockProtocol::optimize_orientation3(), core::conformation::Residue::orient_onto_location(), core::conformation::Residue::orient_onto_residue_peptoid(), protocols::cyclic_peptide::CycpepRigidBodyPermutationMover::perturb_cycpep_pose_orientation(), protocols::cyclic_peptide::CycpepRigidBodyPermutationMover::perturb_cycpep_pose_position(), protocols::ligand_docking::ga_ligand_dock::LigandAligner::perturb_lig(), protocols::ligand_docking::ga_ligand_dock::perturb_ligand_rb(), protocols::stepwise::modeler::rna::phosphate_base_phosphate_square_deviation(), core::conformation::Residue::place(), core::import_pose::atom_tree_diffs::pose_from_atom_tree_diff(), core::chemical::pretty_print_atomicoor(), protocols::rna::denovo::print_internal_coords(), print_pretty_path_distances(), core::energy_methods::PoissonBoltzmannEnergy::protein_position_equal_within(), protocols::ligand_docking::ga_ligand_dock::LigandAligner::randomize_lig(), core::io::pose_from_sfr::PoseFromSFRBuilder::refine_pose(), core::io::pose_from_sfr::remap_names_on_geometry(), protocols::features::ProteinBondGeometryFeatures::report_intrares_lengths(), core::chemical::ResidueDatabaseIO::report_residue_type_atom(), core::chemical::ResidueDatabaseIO::report_residue_type_bond(), core::chemical::ResidueDatabaseIO::report_residue_type_cut_bond(), core::chemical::ResidueDatabaseIO::report_residue_type_icoor(), core::conformation::Residue::Residue(), core::pose::PDBInfo::resize_atom_records(), core::chemical::rna::RNA_Info::rna_update_last_controlling_chi(), core::io::pose_from_sfr::score_mapping(), select_orient_atoms(), select_orient_atoms_standard_logic(), protocols::hybridization::InsertChunkMover::set_bb_xyz_aligned(), core::pose::copydofs::setup_atom_id_map(), core::pose::copydofs::setup_atom_id_map_match_atom_names(), core::scoring::lkball::LKBallDatabase::setup_atom_weights(), core::energy_methods::GoapRsdType::setup_connectivity(), core::scoring::lkball::setup_water_builders_for_residue_type(), show(), core::scoring::superimpose_polymer_heavyatoms(), core::pose::Pose::total_atoms(), protocols::hybridization::FoldTreeHybridize::translate_virt_to_CoM(), update_derived_data(), core::chemical::rna::RNA_Info::update_derived_rna_data(), update_last_controlling_chi(), update_nonpolymer_dependent_groups(), update_polymer_dependent_groups(), protocols::rna::movers::ErraserMinimizerMover::vary_bond_geometry(), core::chemical::AtomRefMapping< FromRef, ToRef >::vectorize(), core::chemical::ResidueTypeKinWriter::write_restype(), and core::chemical::write_topology_file().
|
inlineoverridevirtual |
number of bonds for given atom
References bonded_neighbor_.
|
inline |
get nbr_atom used to define residue-level neighbors
References nbr_atom_.
Referenced by core::chemical::MutableResidueType::copy_other_info(), core::energy_methods::FaMPEnvSmoothEnergy::eval_atom_derivative(), core::energy_methods::EnvSmoothEnergy::eval_atom_derivative(), core::energy_methods::MembraneEnvSmoothEnergy::eval_atom_derivative(), core::energy_methods::PairEnergy::evaluate_rotamer_pair_energies(), protocols::constraint_movers::AddConstraintsToCurrentConformationMover::generate_atom_pair_constraints(), core::conformation::Residue::nbr_atom(), core::conformation::Residue::nbr_atom_xyz(), core::chemical::ResidueDatabaseIO::report_residue_type(), select_orient_atoms(), core::energy_methods::FaMPEnvSmoothEnergy::setup_for_derivatives(), core::energy_methods::EnvSmoothEnergy::setup_for_derivatives(), core::energy_methods::MembraneEnvSmoothEnergy::setup_for_derivatives(), core::chemical::ResidueTypeKinWriter::write_restype(), and core::chemical::write_topology_file().
|
inline |
get nbr_radius_ used to define residue-level neighbors
References nbr_radius_.
Referenced by core::chemical::MutableResidueType::copy_other_info(), core::pack::rotamer_set::different_resgroup(), core::pack::rotamer_set::RotamerSubset::different_resgroup(), core::energy_methods::PairEnergy::evaluate_rotamer_pair_energies(), protocols::cyclic_peptide::crosslinker::Thioether_Helper::filter_by_sidechain_distance_asymmetric(), core::conformation::Residue::nbr_radius(), core::pose::pose_max_nbr_radius(), core::chemical::ResidueDatabaseIO::report_residue_type(), core::scoring::Energies::require_context_graph_(), protocols::nmr::pcs::PCSLigandTransformMover::reset_grid_and_bounding_box(), core::scoring::Energies::update_neighbor_links(), core::scoring::symmetry::SymmetricEnergies::update_neighbor_links(), core::chemical::ResidueTypeKinWriter::write_restype(), and core::chemical::write_topology_file().
|
inline |
indices of the bonded neighbors for an atom, shortcut for bonded_neighbor(atomno)
References bonded_neighbor().
Referenced by atoms_are_bonded(), protocols::simple_moves::ExplicitWaterMover::build_backbone_rotamer_clouds(), core::chemical::AutomorphismIterator::can_pair(), copy_other_info(), core::energy_methods::IdealParametersDatabase::create_parameters_for_restype(), define_mainchain_atoms(), core::chemical::AutomorphismIterator::edges_match(), core::scoring::methods::MMBondLengthEnergy::eval_atom_derivative(), core::scoring::methods::MMBondLengthEnergy::eval_intrares_energy(), core::scoring::GenericBondedPotential::eval_residue_energy_and_derivative_bond(), core::scoring::GenericBondedPotential::eval_residue_energy_and_derivative_improper(), core::chemical::get_residue_path_distances(), note_chi_controls_atom(), protocols::features::ProteinBondGeometryFeatures::report_intrares_lengths(), select_orient_atoms(), select_orient_atoms_standard_logic(), core::scoring::lkball::setup_water_builders_for_residue_type(), core::scoring::orbitals::surrogate_atom_for_orbital(), and core::chemical::write_topology_file().
|
inline |
number of chi angles
References chi_atoms_.
Referenced by protocols::simple_moves::RepeatPropagationMover::add_cap_seq(), core::pose::add_variant_type_to_residue(), protocols::simple_moves::CopyRotamerMover::apply(), protocols::enzdes::SetCatalyticResPackBehavior::apply(), protocols::simple_moves::CopyRotamerMover::apply_from_template_pose(), core::pack::rotamer_set::build_rotamers_from_rotamer_bins(), protocols::comparative_modeling::chis_from_pose(), core::chemical::MutableResidueType::copy_other_info(), protocols::simple_moves::RepeatPropagationMover::copy_phi_psi_omega(), core::pack::rotamers::SingleNCAARotamerLibraryCreator::create(), core::energy_methods::YHHPlanarityEnergy::defines_score_for_rsd(), protocols::simple_moves::DumpSingleResidueRotamers::enumerate_aa_rotamer(), core::pack::dunbrack::RotamericSingleResidueDunbrackLibrary< T, N >::enumerate_chi_sets(), core::pack::rotamers::SingleResidueRotamerLibrary::expand_proton_chis(), core::chemical::rna::RNA_Info::figure_out_chi_order(), core::io::silent::ProteinSilentStruct_Template< T >::fill_pose(), protocols::match::upstream::FullChiSampleSet::FullChiSampleSet(), protocols::ligand_docking::get_ligand_torsion_constraints(), protocols::simple_moves::sidechain_moves::SidechainMover::idealize_sidechains(), protocols::simple_moves::sidechain_moves::SidechainMoverBase::idealize_sidechains(), initialize_derived_data(), protocols::match::upstream::UpstreamResTypeGeometry::initialize_from_residue_type(), protocols::stepwise::modeler::StepWiseConnectionSampler::initialize_generic_polymer_bond_sampler(), protocols::features::ProteinResidueConformationFeatures::load_conformation(), core::energy_methods::IdealParametersDatabase::lookup_torsion_legacy(), protocols::stepwise::modeler::StepWiseMinimizer::move_side_chain(), core::pack::dunbrack::SingleResidueDunbrackLibrary::n_rotamer_bins_for_aa(), core::conformation::Residue::nchi(), protocols::ligand_docking::LigandDockProtocol::optimize_orientation3(), perform_checks(), protocols::ligand_docking::ga_ligand_dock::LigandAligner::perturb_lig(), protocols::ligand_docking::ga_ligand_dock::perturb_ligand_torsions(), protocols::drug_design::place_new_restype_rotamer_align(), core::chemical::print_chis(), protocols::ligand_docking::ga_ligand_dock::LigandAligner::randomize_lig(), protocols::minimization_packing::MinimalRotamer::record_chi(), core::pose::remove_variant_type_from_residue(), core::chemical::ResidueDatabaseIO::report_residue_type_chi(), core::chemical::ResidueDatabaseIO::report_residue_type_chi_rotamer(), core::conformation::Residue::Residue(), core::chemical::rna::RNA_Info::rna_note_chi_controls_atom(), core::chemical::rna::RNA_Info::rna_update_last_controlling_chi(), protocols::ligand_docking::rotamers_for_trials(), core::pose::carbohydrates::set_glycan_iupac_bb_torsions(), core::pose::carbohydrates::set_glycan_iupac_chi_torsions(), protocols::match::upstream::BuildSet::set_residue_type(), protocols::ligand_docking::ResidueTorsionRestraints::setup_constraints(), core::chemical::rna::RNA_Info::update_derived_rna_data(), update_last_controlling_chi(), core::chemical::ResidueTypeKinWriter::write_restype(), and core::chemical::write_topology_file().
|
inline |
Return the number of intraresidue dihedrals. This covers all pairs of atoms that are separated by four bonds, and all pairs of intervening atoms.
References dihedral_atom_sets_.
Referenced by core::scoring::ResidueExclParams::create_excl_info(), core::scoring::methods::MMTorsionEnergy::eval_intrares_energy(), and protocols::features::ProteinBondGeometryFeatures::report_intrares_torsions().
orbitals::ICoorOrbitalData const & core::chemical::ResidueType::new_orbital_icoor_data | ( | Size const | orbital_index | ) | const |
|
inlineoverridevirtual |
number of heavy atoms
Implements core::chemical::ResidueTypeBase.
References nheavyatoms_.
Referenced by protocols::energy_based_clustering::EnergyBasedClusteringProtocol::align_with_offset(), protocols::simple_task_operations::RestrictToInterface::apply(), core::chemical::AutomorphismIterator::AutomorphismIterator(), protocols::stepwise::modeler::rna::base_atoms_square_deviation(), core::scoring::elec::GroupElec::build_groupinfo(), protocols::analysis::InterfaceAnalyzerMover::calc_hbond_sasaE(), core::pack::interaction_graph::SurfacePotential::compute_pose_hpatch_score(), core::scoring::compute_sc_centroid(), core::scoring::compute_sc_radius(), core::simple_metrics::per_residue_metrics::PerResidueRMSDMetric::create_atom_id_map(), core::pose::rna::detect_base_contacts(), protocols::stepwise::modeler::align::StepWisePoseAligner::do_checks(), core::pack::figure_out_repackable_residues(), protocols::ligand_docking::ga_ligand_dock::GALigandDock::final_exact_cartmin(), protocols::minimization_packing::MinimalRotamer::has_ideal_geometry(), core::chemical::heavy_atom_names_match(), core::pose::initialize_atomid_map_heavy_only(), protocols::features::PdbDataFeatures::insert_residue_pdb_confidence_rows(), core::scoring::lDDT_Calculator::lDDT_Cache::make_mapping_states(), core::pose::named_atom_id_to_atom_id(), core::conformation::Residue::nheavyatoms(), protocols::ligand_docking::LigandDockProtocol::optimize_orientation3(), protocols::stepwise::modeler::rna::phosphate_base_phosphate_square_deviation(), core::conformation::Residue::place(), protocols::minimization_packing::MinimalRotamer::record_internal_geometry(), select_orient_atoms(), select_orient_atoms_standard_logic(), core::pack::interaction_graph::HPatchBackgroundNode< V, E, G >::set_rotamer(), core::pack::interaction_graph::HPatchNode< V, E, G >::set_rotamers(), core::pose::copydofs::setup_atom_id_map_match_atom_names(), core::scoring::lkball::LKBallDatabase::setup_atom_weights(), protocols::stepwise::modeler::rna::suite_square_deviation(), and core::util::switch_to_centroid_rot_set().
Recursive subroutine invoked by update_last_controlling_chi().
O(N) recursive algorithm for determining the last chi for each atom. Each atom is visited at most twice.
References atom_base(), bonded_neighbor(), last_controlling_chi_, and nbrs().
Referenced by update_last_controlling_chi().
|
inline |
Return list of indices of the atoms used to define all the nu (internal ring) angles.
References nu_atoms_.
Referenced by auto_assign_nu_atoms().
|
inline |
Return indices of the atoms used to define a given nu (internal ring) angle.
References nu_atoms_.
Referenced by core::chemical::MutableResidueType::copy_other_info(), core::chemical::is_mainchain_torsion_also_ring_torsion(), core::conformation::Residue::nu_atoms(), core::conformation::Residue::set_all_ring_nu(), core::pose::Pose::set_ring_conformation(), core::conformation::Residue::set_tau(), protocols::ligand_docking::ga_ligand_dock::LigandConformer::to_pose(), protocols::ligand_docking::ga_ligand_dock::LigandConformer::update_conf(), protocols::ligand_docking::ga_ligand_dock::LigandConformer::update_ligand_conf(), core::conformation::Residue::update_nus(), and core::chemical::write_topology_file().
|
inline |
get number of intraresidue bond angles
References bondangle_atom_sets_.
Referenced by core::energy_methods::IdealParametersDatabase::create_parameters_for_restype(), core::scoring::methods::MMBondAngleEnergy::eval_intrares_energy(), core::scoring::mm::MMBondAngleResidueTypeParam::init(), and protocols::features::ProteinBondGeometryFeatures::report_intrares_angles().
indicates how many heavyatom bonded neighbors an atom has
References bonded_neighbor(), and number_bonded_hydrogens().
Referenced by core::scoring::orbitals::surrogate_atom_for_orbital().
indicates how many proton bonded neighbors an atom has
References attached_H_begin_, and attached_H_end_.
Referenced by number_bonded_heavyatoms(), protocols::pose_metric_calculators::SemiExplicitWaterUnsatisfiedPolarsCalculator::recompute(), protocols::simple_pose_metric_calculators::BuriedUnsatisfiedPolarsCalculator::recompute(), protocols::buns::BuriedUnsatisfiedPolarsCalculator2::single_bunsat_thorough_check(), and core::scoring::orbitals::surrogate_atom_for_orbital().
|
privatedelete |
Copies <src> into the ResidueType.
orbitals::ICoorOrbitalData const & core::chemical::ResidueType::orbital_icoor_data | ( | Size const | orbital_index | ) | const |