Structural Bioinformatics Library
Template C++ / Python API for developping structural bioinformatics applications.
|
Reprenstation of a single polypeptidic chain within a protein representation. More...
#include <Polypeptide_chain_representation.hpp>
Classes | |
class | Backbone_const_iterator |
Iterator through the atoms of the polypeptide chain backbone (const). More... | |
class | Backbone_iterator |
Iterator through the atoms of the polypeptide chain backbone. More... | |
class | Bond |
Representation of a bond between two atoms. More... | |
class | Bond_angle |
Representation of a valence angle between three atoms. More... | |
class | Bond_angle_const_iterator |
Iterator through all the valence angles in the polypeptide chain (const). More... | |
class | Bond_angle_iterator |
Iterator through all the valence angles in the polypeptide chain. More... | |
class | Bond_const_iterator |
Iterator through all the bonds in the polypeptide chain (const). More... | |
class | Bond_iterator |
Iterator through all the bonds in the polypeptide chain. More... | |
class | Dihedral_angle |
Representation of a proper dihedral angle between four atoms. More... | |
class | Dihedral_angle_const_iterator |
Iterator through all the proper dihedral angles in the polypeptide chain (const). More... | |
class | Dihedral_angle_iterator |
Iterator through all the proper dihedral angles in the polypeptide chain. More... | |
class | Incident_atoms_const_iterator |
Iterator through bonded atoms to an input atom (const). More... | |
class | Incident_atoms_iterator |
Iterator through bonded atoms to an input atom. More... | |
class | Residue_atoms_const_iterator |
Iterator through all the atoms of an input residue (const). More... | |
class | Residue_atoms_iterator |
Iterator through all the atoms of an input residue. More... | |
Public Types | |
typedef ParticleTraits | Particle_traits |
Traits class defining types related to a particle, see ParticleTraits. More... | |
typedef MolecularCovalentStructure | Molecular_covalent_structure |
Representation of the covalent structure of a molecular conformation. More... | |
typedef ConformationType | Conformation_type |
Representation of a conformation, see package Molecular_conformation. More... | |
typedef T_Polypeptide_chain_representation< Particle_traits, Molecular_covalent_structure, Conformation_type > | Self |
The class itself. More... | |
typedef SBL::CSB::EPIC_kernel_with_atom::FT | FT |
Representation of the number type. More... | |
typedef SBL::CSB::EPIC_kernel_with_atom::Point_3 | Point_3 |
Geometric representation of an atom, i.E a 3D point. More... | |
typedef ParticleTraits::Molecular_system | Molecular_system |
Biophysical representation of a protein. More... | |
typedef Molecular_system::Model | Molecular_model |
Biophysical representation of a model of the protein. More... | |
typedef Molecular_system::Chain | Chain |
Biophysical representation of chain of a model of the protein. More... | |
typedef Molecular_system::Residue | Residue |
Biophysical representation of a residue. More... | |
typedef Residue::Atom | Atom |
Biophysical representation of an atom. More... | |
typedef Chain::Residues_iterator | Residues_iterator |
Iterator through all residues within the polypetide chain. More... | |
typedef Chain::Residues_const_iterator | Residues_const_iterator |
Iterator through all residues within the polypetide chain (const) More... | |
typedef Molecular_model::Chain::Atoms_iterator | Atoms_iterator |
Iterator through all atoms within the polypeptide chain. More... | |
typedef Molecular_model::Chain::Atoms_const_iterator | Atoms_const_iterator |
Iterator through all atoms within the polypeptide chain (const) More... | |
typedef boost::filter_iterator< Is_Calpha, Atoms_iterator > | Calpha_iterator |
Iterator through all the c-alpha atoms within the polypeptide chain. More... | |
typedef boost::filter_iterator< Is_Calpha, Atoms_const_iterator > | Calpha_const_iterator |
Iterator through all the c-alpha atoms within the polypeptide chain (const) More... | |
typedef boost::filter_iterator< Is_Heavy, Atoms_iterator > | Heavy_iterator |
Iterator through all the c-alpha atoms within the polypeptide chain. More... | |
typedef boost::filter_iterator< Is_Heavy, Atoms_const_iterator > | Heavy_const_iterator |
Iterator through all the c-alpha atoms within the polypeptide chain (const) More... | |
typedef boost::filter_iterator< Is_Phi_angle, Dihedral_angle_iterator > | Phi_iterator |
Iterator through all the phi dihedral angles within the polypeptide chain. More... | |
typedef boost::filter_iterator< Is_Phi_angle, Dihedral_angle_const_iterator > | Phi_const_iterator |
Iterator through all the phi dihedral angles within the polypeptide chain (const) More... | |
typedef boost::filter_iterator< Is_Psi_angle, Dihedral_angle_iterator > | Psi_iterator |
Iterator through all the psi dihedral angles within the polypeptide chain. More... | |
typedef boost::filter_iterator< Is_Psi_angle, Dihedral_angle_const_iterator > | Psi_const_iterator |
Iterator through all the psi dihedral angles within the polypeptide chain (const) More... | |
typedef boost::filter_iterator< Is_Omega_angle, Dihedral_angle_iterator > | Omega_iterator |
Iterator through all the omega dihedral angles within the polypeptide chain. More... | |
typedef boost::filter_iterator< Is_Omega_angle, Dihedral_angle_const_iterator > | Omega_const_iterator |
Iterator through all the omega dihedral angles within the polypeptide chain (const) More... | |
Constructors | |
T_Polypeptide_chain_representation () | |
Builds an empty polypeptide chain. More... | |
T_Polypeptide_chain_representation (Chain &c, Molecular_covalent_structure &s, const Conformation_type &mc) | |
Builds a polypeptide chain based on the biophysical information from the input model, the topology from the input covalent structure, and the geometry from the input conformation. More... | |
Operators | |
T_Polypeptide_chain_representation & | operator= (const T_Polypeptide_chain_representation &other) |
Accessors | |
char | get_chain_id () const |
FT | get_x (const Atom &a) const |
Operator for allowing access to the x coordinate of a particle in the current conformation. More... | |
FT | get_y (const Atom &a) const |
Operator for allowing access to the y coordinate of a particle in the current conformation. More... | |
FT | get_z (const Atom &a) const |
Operator for allowing access to the z coordinate of a particle in the current conformation. More... | |
FT & | get_x (const Atom &a) |
Operator for allowing access to the x coordinate of a particle in the current conformation. More... | |
FT & | get_y (const Atom &a) |
Operator for allowing access to the y coordinate of a particle in the current conformation. More... | |
FT & | get_z (const Atom &a) |
Operator for allowing access to the z coordinate of a particle in the current conformation. More... | |
Point_3 | get_coordinates (const Atom &a) const |
Operator for allowing access to the coordinates of a particle in the current conformation. More... | |
unsigned | get_number_of_residues () const |
Return the number of residues in the chain or in a component. More... | |
Point_3 | compute_heavy_atoms_center_of_mass (int cc=-1) const |
Compute the center of mass of heavy atoms of the whole chain or of a connected component. More... | |
unsigned | get_number_of_embedded_particles (int cc=-1) const |
Return the number of embedded particles in the chain or in one component. More... | |
bool | is_fully_embedded (int cc=-1) const |
Return true iff all particles in the chain or in a component are embedded. More... | |
FT | get_phi_angle (const Residue &res) const |
Return the phi angle associated to a residue. More... | |
FT | get_psi_angle (const Residue &res) const |
Return the psi angle associated to a residue. More... | |
FT | get_omega_angle (const Residue &res) const |
Return the omega angle associated to a residue. More... | |
FT | get_phi_angle (unsigned resn) const |
Return the phi angle associated to a residue. More... | |
FT | get_psi_angle (unsigned resn) const |
Return the psi angle associated to a residue. More... | |
FT | get_omega_angle (unsigned resn) const |
Return the omega angle associated to a residue. More... | |
unsigned | get_number_of_bonds (int cc=-1) const |
Return the number of bonds in the chain or in a component. More... | |
unsigned | get_number_of_embedded_bonds (int cc=-1) const |
Return the number of embedded bonds in the chain or in a component. More... | |
unsigned | get_number_of_particles (int cc=-1) const |
Return the total number of particles. More... | |
unsigned | get_number_of_components () const |
Return the number of connected components. More... | |
const Residue & | get_first_residue (int cc=-1) const |
Return the first residue of the chain or of the component. More... | |
const Residue & | get_last_residue (int cc=-1) const |
Return the last residue of the chain or of the component. More... | |
Particle_rep | get_particle_rep (const Atom &a) const |
(deprecated) Return the atom representation of the input within the covalent structure More... | |
const Molecular_covalent_structure & | get_covalent_structure () const |
Return the underlying covalent structure. More... | |
const Conformation_type & | get_conformation () const |
Return the underlying geometrical conformation. More... | |
Modifiers | |
void | set_conformation (Conformation_type &C) |
Modify the conformation. More... | |
Iterators | |
Incident_atoms_iterator | incident_atoms_begin (const Atom &a) |
Function to initialize incident atoms iterator. More... | |
Incident_atoms_iterator | incident_atoms_end (const Atom &a) |
Function to initialize incident atoms iterator. More... | |
Incident_atoms_const_iterator | incident_atoms_begin (const Atom &a) const |
Function to initialize incident atoms iterator. More... | |
Incident_atoms_const_iterator | incident_atoms_end (const Atom &a) const |
Function to initialize incident atoms iterator. More... | |
Residues_iterator | residues_begin () |
Function to initialize residues iterator. More... | |
Residues_iterator | residues_end () |
Function to initialize residues iterator. More... | |
Residues_const_iterator | residues_begin () const |
Function to initialize residues iterator. More... | |
Residues_const_iterator | residues_end () const |
Function to initialize residues iterator. More... | |
Atoms_iterator | atoms_begin () |
For iterating on atoms. More... | |
Atoms_iterator | atoms_end () |
For iterating on atoms. More... | |
Atoms_const_iterator | atoms_begin () const |
For iterating on atoms. More... | |
Atoms_const_iterator | atoms_end () const |
For iterating on atoms. More... | |
Residue_atoms_iterator | atoms_begin (Residue &res) |
For iterating on atoms of a residue. More... | |
Residue_atoms_iterator | atoms_end (Residue &res) |
For iterating on atoms of a residue. More... | |
Residue_atoms_const_iterator | atoms_begin (const Residue &res) const |
For iterating on atoms of a residue. More... | |
Residue_atoms_const_iterator | atoms_end (const Residue &res) const |
For iterating on atoms of a residue. More... | |
Backbone_iterator | backbone_begin (int cc=-1) |
For iterating on the back bone of the chain or its component. More... | |
Backbone_iterator | backbone_end (int cc=-1) |
For iterating on the back bonee of the chain or its component. More... | |
Backbone_const_iterator | backbone_begin (int cc=-1) const |
For iterating on the back bonee of the chain or its component. More... | |
Backbone_const_iterator | backbone_end (int cc=-1) const |
For iterating on the back bonee of the chain or its component. More... | |
Calpha_iterator | calphas_begin () |
For iterating on the calphas of the protein. More... | |
Calpha_iterator | calphas_end () |
For iterating on the calphas of the protein. More... | |
Calpha_const_iterator | calphas_begin () const |
For iterating on the calphas of the protein. More... | |
Calpha_const_iterator | calphas_end () const |
For iterating on the calphas of the protein. More... | |
Heavy_iterator | heavy_begin () |
For iterating on the calphas of the protein. More... | |
Heavy_iterator | heavy_end () |
For iterating on the calphas of the protein. More... | |
Heavy_const_iterator | heavy_begin () const |
For iterating on the calphas of the protein. More... | |
Heavy_const_iterator | heavy_end () const |
For iterating on the calphas of the protein. More... | |
Bond_iterator | bonds_begin () |
For iterating on the bonds of the protein. More... | |
Bond_iterator | bonds_end () |
For iterating on the bonds of the protein. More... | |
Bond_const_iterator | bonds_begin () const |
For iterating on the bonds of the protein. More... | |
Bond_const_iterator | bonds_end () const |
For iterating on the bonds of the protein. More... | |
Bond_angle_iterator | bond_angles_begin () |
For iterating on the bond angles of the protein. More... | |
Bond_angle_iterator | bond_angles_end () |
For iterating on the bond angles of the protein. More... | |
Bond_angle_const_iterator | bond_angles_begin () const |
For iterating on the bond angles of the protein. More... | |
Bond_angle_const_iterator | bond_angles_end () const |
For iterating on the bond angles of the protein. More... | |
Dihedral_angle_iterator | dihedral_angles_begin () |
For iterating on the dihedral angles of the protein. More... | |
Dihedral_angle_iterator | dihedral_angles_end () |
For iterating on the dihedral angles of the protein. More... | |
Dihedral_angle_const_iterator | dihedral_angles_begin () const |
For iterating on the dihedral angles of the protein. More... | |
Dihedral_angle_const_iterator | dihedral_angles_end () const |
For iterating on the dihedral angles of the protein. More... | |
Phi_iterator | phi_angles_begin () |
For iterating on the phi angles of the protein. More... | |
Phi_iterator | phi_angles_end () |
For iterating on the phi angles of the protein. More... | |
Phi_const_iterator | phi_angles_begin () const |
For iterating on the phi angles of the protein. More... | |
Phi_const_iterator | phi_angles_end () const |
For iterating on the phi angles of the protein. More... | |
Psi_iterator | psi_angles_begin () |
For iterating on the psi angles of the protein. More... | |
Psi_iterator | psi_angles_end () |
For iterating on the psi angles of the protein. More... | |
Psi_const_iterator | psi_angles_begin () const |
For iterating on the psi angles of the protein. More... | |
Psi_const_iterator | psi_angles_end () const |
For iterating on the psi angles of the protein. More... | |
Omega_iterator | omega_angles_begin () |
For iterating on the omega angles of the protein. More... | |
Omega_iterator | omega_angles_end () |
For iterating on the omega angles of the protein. More... | |
Omega_const_iterator | omega_angles_begin () const |
For iterating on the omega angles of the protein. More... | |
Omega_const_iterator | omega_angles_end () const |
For iterating on the omega angles of the protein. More... | |
Reprenstation of a single polypeptidic chain within a protein representation.
ParticleTraits | Traits class providing the particle type, see package ParticleTraits |
MolecularCovalentStructure | Graph representation of a covalent structure. |
ConformationType | Representation of a conformation as a point in dimension D, where D is three times the number of particles in the conformation. |
typedef Residue::Atom Atom |
Biophysical representation of an atom.
typedef Molecular_model::Chain::Atoms_const_iterator Atoms_const_iterator |
Iterator through all atoms within the polypeptide chain (const)
typedef Molecular_model::Chain::Atoms_iterator Atoms_iterator |
Iterator through all atoms within the polypeptide chain.
typedef boost::filter_iterator<Is_Calpha, Atoms_const_iterator> Calpha_const_iterator |
Iterator through all the c-alpha atoms within the polypeptide chain (const)
typedef boost::filter_iterator<Is_Calpha, Atoms_iterator> Calpha_iterator |
Iterator through all the c-alpha atoms within the polypeptide chain.
typedef Molecular_system::Chain Chain |
Biophysical representation of chain of a model of the protein.
typedef ConformationType Conformation_type |
Representation of a conformation, see package Molecular_conformation.
typedef SBL::CSB::EPIC_kernel_with_atom::FT FT |
Representation of the number type.
typedef boost::filter_iterator<Is_Heavy, Atoms_const_iterator> Heavy_const_iterator |
Iterator through all the c-alpha atoms within the polypeptide chain (const)
typedef boost::filter_iterator<Is_Heavy, Atoms_iterator> Heavy_iterator |
Iterator through all the c-alpha atoms within the polypeptide chain.
typedef MolecularCovalentStructure Molecular_covalent_structure |
Representation of the covalent structure of a molecular conformation.
It uses a boost graph for encoding that covalent structure and offers the possibility to access internal and cartesian coordinates of the structure.
ParticleInfo | Information to attached to the particle (default is a simple string). It should be comparable (less operator) and streamable. |
typedef Molecular_system::Model Molecular_model |
Biophysical representation of a model of the protein.
typedef ParticleTraits::Molecular_system Molecular_system |
Biophysical representation of a protein.
typedef boost::filter_iterator<Is_Omega_angle, Dihedral_angle_const_iterator> Omega_const_iterator |
Iterator through all the omega dihedral angles within the polypeptide chain (const)
typedef boost::filter_iterator<Is_Omega_angle, Dihedral_angle_iterator> Omega_iterator |
Iterator through all the omega dihedral angles within the polypeptide chain.
typedef ParticleTraits Particle_traits |
Traits class defining types related to a particle, see ParticleTraits.
typedef boost::filter_iterator<Is_Phi_angle, Dihedral_angle_const_iterator> Phi_const_iterator |
Iterator through all the phi dihedral angles within the polypeptide chain (const)
typedef boost::filter_iterator<Is_Phi_angle, Dihedral_angle_iterator> Phi_iterator |
Iterator through all the phi dihedral angles within the polypeptide chain.
typedef SBL::CSB::EPIC_kernel_with_atom::Point_3 Point_3 |
Geometric representation of an atom, i.E a 3D point.
typedef boost::filter_iterator<Is_Psi_angle, Dihedral_angle_const_iterator> Psi_const_iterator |
Iterator through all the psi dihedral angles within the polypeptide chain (const)
typedef boost::filter_iterator<Is_Psi_angle, Dihedral_angle_iterator> Psi_iterator |
Iterator through all the psi dihedral angles within the polypeptide chain.
typedef Molecular_system::Residue Residue |
Biophysical representation of a residue.
typedef Chain::Residues_const_iterator Residues_const_iterator |
Iterator through all residues within the polypetide chain (const)
typedef Chain::Residues_iterator Residues_iterator |
Iterator through all residues within the polypetide chain.
typedef T_Polypeptide_chain_representation<Particle_traits, Molecular_covalent_structure, Conformation_type> Self |
The class itself.
Builds an empty polypeptide chain.
T_Polypeptide_chain_representation | ( | Chain & | c, |
Molecular_covalent_structure & | s, | ||
const Conformation_type & | c | ||
) |
Builds a polypeptide chain based on the biophysical information from the input model, the topology from the input covalent structure, and the geometry from the input conformation.
m | input chain from a biophysical model |
s | input covalent structure |
c | input geometrical conformation |
|
inline |
For iterating on atoms.
|
inline |
For iterating on atoms.
|
inline |
For iterating on atoms of a residue.
|
inline |
For iterating on atoms of a residue.
|
inline |
For iterating on atoms.
|
inline |
For iterating on atoms.
|
inline |
For iterating on atoms of a residue.
|
inline |
For iterating on atoms of a residue.
|
inline |
For iterating on the back bone of the chain or its component.
|
inline |
For iterating on the back bonee of the chain or its component.
|
inline |
For iterating on the back bonee of the chain or its component.
|
inline |
For iterating on the back bonee of the chain or its component.
|
inline |
For iterating on the bond angles of the protein.
|
inline |
For iterating on the bond angles of the protein.
|
inline |
For iterating on the bond angles of the protein.
|
inline |
For iterating on the bond angles of the protein.
|
inline |
For iterating on the bonds of the protein.
|
inline |
For iterating on the bonds of the protein.
|
inline |
For iterating on the bonds of the protein.
|
inline |
For iterating on the bonds of the protein.
|
inline |
For iterating on the calphas of the protein.
|
inline |
For iterating on the calphas of the protein.
|
inline |
For iterating on the calphas of the protein.
|
inline |
For iterating on the calphas of the protein.
|
inline |
Compute the center of mass of heavy atoms of the whole chain or of a connected component.
|
inline |
For iterating on the dihedral angles of the protein.
|
inline |
For iterating on the dihedral angles of the protein.
|
inline |
For iterating on the dihedral angles of the protein.
|
inline |
For iterating on the dihedral angles of the protein.
char get_chain_id |
|
inline |
Return the underlying geometrical conformation.
|
inline |
Operator for allowing access to the coordinates of a particle in the current conformation.
a | Reference to the particle in question |
|
inline |
Return the underlying covalent structure.
|
inline |
Return the first residue of the chain or of the component.
|
inline |
Return the last residue of the chain or of the component.
|
inline |
Return the number of bonds in the chain or in a component.
|
inline |
Return the number of connected components.
|
inline |
Return the number of embedded bonds in the chain or in a component.
|
inline |
Return the number of embedded particles in the chain or in one component.
|
inline |
Return the total number of particles.
|
inline |
Return the number of residues in the chain or in a component.
|
inline |
Return the omega angle associated to a residue.
res | A const ref to the residue in question. |
|
inline |
Return the omega angle associated to a residue.
resn | The residue sequence number of the residue in question |
|
inline |
(deprecated) Return the atom representation of the input within the covalent structure
a | Input atom |
|
inline |
Return the phi angle associated to a residue.
res | A const ref to the residue in question. |
|
inline |
Return the phi angle associated to a residue.
resn | The residue sequence number of the residue in question |
|
inline |
Return the psi angle associated to a residue.
res | A const ref to the residue in question. |
|
inline |
Return the psi angle associated to a residue.
resn | The residue sequence number of the residue in question |
|
inline |
Operator for allowing access to the x coordinate of a particle in the current conformation.
a | Reference to the particle in question |
|
inline |
Operator for allowing access to the x coordinate of a particle in the current conformation.
a | Reference to the particle in question |
|
inline |
Operator for allowing access to the y coordinate of a particle in the current conformation.
a | Reference to the particle in question |
|
inline |
Operator for allowing access to the y coordinate of a particle in the current conformation.
a | Reference to the particle in question |
|
inline |
Operator for allowing access to the z coordinate of a particle in the current conformation.
a | Reference to the particle in question |
|
inline |
Operator for allowing access to the z coordinate of a particle in the current conformation.
a | Reference to the particle in question |
|
inline |
For iterating on the calphas of the protein.
|
inline |
For iterating on the calphas of the protein.
|
inline |
For iterating on the calphas of the protein.
|
inline |
For iterating on the calphas of the protein.
|
inline |
Function to initialize incident atoms iterator.
a | Reference to the atom in question. |
|
inline |
Function to initialize incident atoms iterator.
a | Reference to the atom in question. |
|
inline |
Function to initialize incident atoms iterator.
a | Reference to the atom in question. |
|
inline |
Function to initialize incident atoms iterator.
a | Reference to the atom in question. |
|
inline |
Return true iff all particles in the chain or in a component are embedded.
|
inline |
For iterating on the omega angles of the protein.
|
inline |
For iterating on the omega angles of the protein.
|
inline |
For iterating on the omega angles of the protein.
|
inline |
For iterating on the omega angles of the protein.
|
inline |
For iterating on the phi angles of the protein.
|
inline |
For iterating on the phi angles of the protein.
|
inline |
For iterating on the phi angles of the protein.
|
inline |
For iterating on the phi angles of the protein.
|
inline |
For iterating on the psi angles of the protein.
|
inline |
For iterating on the psi angles of the protein.
|
inline |
For iterating on the psi angles of the protein.
|
inline |
For iterating on the psi angles of the protein.
|
inline |
Function to initialize residues iterator.
|
inline |
Function to initialize residues iterator.
|
inline |
Function to initialize residues iterator.
|
inline |
Function to initialize residues iterator.
|
inline |
Modify the conformation.
C | Reference to the new conformation |