![]() |
Structural Bioinformatics Library
Template C++ / Python API for developping structural bioinformatics applications.
|
Representation of a single polynucleotide chain within a Nucleic Acid representation. More...
#include <Polynucleotide_chain_representation.hpp>
Public Types | |
| typedef ParticleTraits | Particle_traits |
| Traits class defining types related to a particle, see ParticleTraits. | |
| typedef MolecularCovalentStructure | Molecular_covalent_structure |
| Representation of the covalent structure of a molecular conformation. | |
| typedef ConformationType | Conformation_type |
| Representation of a conformation, see package Molecular_conformation. | |
| typedef T_Polynucleotide_chain_representation< Particle_traits, Molecular_covalent_structure, Conformation_type > | Self |
| The class itself. | |
| typedef Base::FT | FT |
| Representation of the number type. | |
| typedef Base::Chain | Chain |
| Biophysical representation of chain of a model of the nucleic acid. | |
| typedef Base::Residue | Residue |
| Biophysical representation of a residue. | |
| typedef Base::Atom | Atom |
| Biophysical representation of an atom. | |
| typedef Base::Residues_iterator | Residues_iterator |
| Iterator through all residues within the polynucleotide chain. | |
| typedef Base::Residues_const_iterator | Residues_const_iterator |
| Iterator through all residues within the polynucleotide chain (const) | |
| typedef Base::Atoms_iterator | Atoms_iterator |
| Iterator through all atoms within the chain. | |
| typedef Base::Atoms_const_iterator | Atoms_const_iterator |
| Iterator through all atoms within the chain (const) | |
| typedef Base::Residue_atoms_iterator | Residue_atoms_iterator |
| Iterator through all atoms within a residue. | |
| typedef Base::Residue_atoms_const_iterator | Residue_atoms_const_iterator |
| Iterator through all atoms within a residue (const) | |
| typedef Base::Is_Heavy | Is_Heavy |
| Checks whether an atom is a heavy atom. | |
| typedef boost::filter_iterator< Is_P, Atoms_iterator > | P_iterator |
| Iterators through selected atoms within the polynucleotide chain (5' ==> 3') | |
| typedef Base::Dihedral_angle | Dihedral_angle |
| Dihedral angle. | |
| typedef Base::Dihedral_angle_iterator | Dihedral_angle_iterator |
| Iterator through all atoms within the chain (const) | |
| typedef Base::Dihedral_angle_const_iterator | Dihedral_angle_const_iterator |
| Iterator through all atoms within the chain (const) | |
| typedef Base::Chosen_angle_iterator | Chosen_angle_iterator |
| To iterate on dihedral angles of a certain type. | |
| typedef Base::Chosen_angle_const_iterator | Chosen_angle_const_iterator |
| To iterate on dihedral angles of a certain type (const) | |
| typedef boost::filter_iterator< Is_Alpha_angle, Dihedral_angle_iterator > | Alpha_iterator |
| Iterator(s) through named backbone dihedral angles within the polypeptide chain (here alpha) | |
| typedef boost::filter_iterator< Is_Alpha_angle, Dihedral_angle_const_iterator > | Alpha_const_iterator |
| Iterator(s) through named backbone dihedral angles within the polypeptide chain (here alpha) (const) | |
| typedef SBL::CSB::EPIC_kernel_with_atom::Point_3 | Point_3 |
| Geometric representation of an atom, i.E a 3D point. | |
| typedef ParticleTraits::Molecular_system | Molecular_system |
| Biophysical representation of a linear polymer. | |
| typedef Molecular_system::Model | Molecular_model |
| Biophysical representation of a model of the linear polymer. | |
| typedef boost::filter_iterator< Is_Heavy, Atoms_iterator > | Heavy_iterator |
| Iterator through all the c-alpha atoms within the chain. | |
| typedef boost::filter_iterator< Is_Heavy, Atoms_const_iterator > | Heavy_const_iterator |
| Iterator through all the c-alpha atoms within the chain (const) | |
Constructors | |
| T_Polynucleotide_chain_representation () | |
| Builds an empty chain. | |
| T_Polynucleotide_chain_representation (Chain &c, Molecular_covalent_structure &s, const Conformation_type &mc) | |
| Builds a chain based on the biophysical information from the input model, the topology from the input covalent structure, and the geometry from the input conformation. | |
Operators | |
| std::pair< bool, FT > | get_alpha_angle (const Residue &res) const |
| Return the alpha angle associated to a residue. | |
| std::pair< bool, FT > | get_alpha_angle (unsigned resn) const |
| Return the alpha angle associated to a residue. | |
| std::pair< bool, FT > | get_beta_angle (const Residue &res) const |
| Return the beta angle associated to a residue. | |
| std::pair< bool, FT > | get_beta_angle (unsigned resn) const |
| Return the beta angle associated to a residue. | |
| bool | is_residue_heavy_atoms_embedded (const Residue &res) const |
| Returns whether a residue's heavy atoms are all embedded. | |
Iterators | |
| C4p_iterator | c4ps_begin () |
| For iterating on the c4ps of the NA chain. | |
| C4p_iterator | c4ps_end () |
| For iterating on the c4ps of the NA chain. | |
| C4p_const_iterator | c4ps_begin () const |
| For iterating on the c4ps of the NA chain. | |
| C4p_const_iterator | c4ps_end () const |
| For iterating on the c4ps of the NA chain. | |
| Alpha_iterator | alpha_angles_begin () |
| For iterating on the alpha angles of the NA chain. | |
| Alpha_iterator | alpha_angles_end () |
| For iterating on the alpha angles of the NA chain. | |
| Alpha_const_iterator | alpha_angles_begin () const |
| For iterating on the alpha angles of the NA chain. | |
| Alpha_const_iterator | alpha_angles_end () const |
| For iterating on the alpha angles of the NA chain. | |
Operators | |
| const Atom * | operator[] (const Particle_rep &p) const |
| Operator for allowing access to a particle given it's index in the covalent structure. | |
| Bond_pair | get_particles (const Bond_rep &b) const |
| Function to get the particle representations from a bond. | |
| std::pair< bool, const Atom * > | get_atom (const std::string &atom_name, const Residue &res) const |
| Function to get the specified atom from the specified residue. | |
| std::pair< bool, FT > | get_backbone_torsion_angle (int offset_starting_atom, const Residue &res) const |
| Function to get the backbone torsion angle specificied with an offset from a residue. | |
Accessors | |
| char | get_chain_id () const |
| std::string | get_chain_type () |
| Set the linear chain type specifier m_chain_type. | |
| int | get_res_backbone_size () const |
| FT | get_x (const Atom &a) const |
| Operator for allowing access to the x coordinate of a particle in the current conformation. | |
| FT & | get_x (const Atom &a) |
| Operator for allowing access to the x coordinate of a particle in the current conformation. | |
| FT | get_y (const Atom &a) const |
| Operator for allowing access to the y coordinate of a particle in the current conformation. | |
| FT & | get_y (const Atom &a) |
| Operator for allowing access to the y coordinate of a particle in the current conformation. | |
| FT | get_z (const Atom &a) const |
| Operator for allowing access to the z coordinate of a particle in the current conformation. | |
| FT & | get_z (const Atom &a) |
| Operator for allowing access to the z coordinate of a particle in the current conformation. | |
| Point_3 | get_coordinates (const Atom &a) const |
| Operator for allowing access to the coordinates of a particle in the current conformation. | |
| unsigned | get_number_of_residues () const |
| Return the number of residues in the chain or in a component. | |
| 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. | |
| unsigned | get_number_of_embedded_particles (int cc=-1) const |
| Return the number of embedded particles in the chain or in one component. | |
| bool | is_fully_embedded (int cc=-1) const |
| Return true iff all particles in the chain or in a component are embedded. | |
| unsigned | get_number_of_bonds (int cc=-1) const |
| Return the number of bonds in the chain or in a component. | |
| unsigned | get_number_of_embedded_bonds (int cc=-1) const |
| Return the number of embedded bonds in the chain or in a component. | |
| unsigned | get_number_of_particles (int cc=-1) const |
| Return the total number of particles. | |
| unsigned | get_number_of_components () const |
| Return the number of connected components. | |
| const Residue & | get_first_residue (int cc=-1) const |
| Return the first residue of the chain or of the component. | |
| const Residue & | get_last_residue (int cc=-1) const |
| Return the last residue of the chain or of the component. | |
| Particle_rep | get_particle_rep (const Atom &a) const |
| (deprecated) Return the atom representation of the input within the covalent structure | |
| const Molecular_covalent_structure & | get_covalent_structure () const |
| Return the underlying covalent structure. | |
| const Conformation_type & | get_conformation () const |
| Return the underlying geometrical conformation. | |
Modifiers | |
| void | set_conformation (Conformation_type &C) |
| Modify the conformation. | |
Iterators | |
| Incident_atoms_iterator | incident_atoms_begin (const Atom &a) |
| Function to initialize incident atoms iterator. | |
| Incident_atoms_const_iterator | incident_atoms_begin (const Atom &a) const |
| Function to initialize incident atoms iterator. | |
| Incident_atoms_iterator | incident_atoms_end (const Atom &a) |
| Function to initialize incident atoms iterator. | |
| Incident_atoms_const_iterator | incident_atoms_end (const Atom &a) const |
| Function to initialize incident atoms iterator. | |
| Residues_iterator | residues_begin () |
| Function to initialize residues iterator. | |
| Residues_const_iterator | residues_begin () const |
| Function to initialize residues iterator. | |
| Residues_iterator | residues_end () |
| Function to initialize residues iterator. | |
| Residues_const_iterator | residues_end () const |
| Function to initialize residues iterator. | |
| Atoms_iterator | atoms_begin () |
| For iterating on atoms. | |
| Atoms_const_iterator | atoms_begin () const |
| For iterating on atoms. | |
| Residue_atoms_iterator | atoms_begin (Residue &res) |
| For iterating on atoms of a residue. | |
| Residue_atoms_const_iterator | atoms_begin (const Residue &res) const |
| For iterating on atoms of a residue. | |
| Atoms_iterator | atoms_end () |
| For iterating on atoms. | |
| Atoms_const_iterator | atoms_end () const |
| For iterating on atoms. | |
| Residue_atoms_iterator | atoms_end (Residue &res) |
| For iterating on atoms of a residue. | |
| Residue_atoms_const_iterator | atoms_end (const Residue &res) const |
| For iterating on atoms of a residue. | |
| Backbone_iterator | backbone_begin (int cc=-1) |
| For iterating on the back bone of the chain or its component. | |
| Backbone_const_iterator | backbone_begin (int cc=-1) const |
| For iterating on the back bonee of the chain or its component. | |
| Backbone_iterator | backbone_end (int cc=-1) |
| For iterating on the back bonee of the chain or its component. | |
| Backbone_const_iterator | backbone_end (int cc=-1) const |
| For iterating on the back bonee of the chain or its component. | |
| Heavy_iterator | heavy_begin () |
| For iterating on the heavy atoms of the polymer. | |
| Heavy_const_iterator | heavy_begin () const |
| For iterating on the heavy atoms of the polymer. | |
| Heavy_iterator | heavy_end () |
| For iterating on the heavy atoms of the polymer. | |
| Heavy_const_iterator | heavy_end () const |
| For iterating on the heavy atoms of the polymer. | |
| Bond_iterator | bonds_begin () |
| For iterating on the bonds of the polymer. | |
| Bond_const_iterator | bonds_begin () const |
| For iterating on the bonds of the polymer. | |
| Bond_iterator | bonds_end () |
| For iterating on the bonds of the polymer. | |
| Bond_const_iterator | bonds_end () const |
| For iterating on the bonds of the polymer. | |
| Bond_angle_iterator | bond_angles_begin () |
| For iterating on the bond angles of the polymer. | |
| Bond_angle_const_iterator | bond_angles_begin () const |
| For iterating on the bond angles of the polymer. | |
| Bond_angle_iterator | bond_angles_end () |
| For iterating on the bond angles of the polymer. | |
| Bond_angle_const_iterator | bond_angles_end () const |
| For iterating on the bond angles of the polymer. | |
| Dihedral_angle_iterator | dihedral_angles_begin () |
| For iterating on the dihedral angles of the polymer. | |
| Dihedral_angle_const_iterator | dihedral_angles_begin () const |
| For iterating on the dihedral angles of the polymer. | |
| Dihedral_angle_iterator | dihedral_angles_end () |
| For iterating on the dihedral angles of the polymer. | |
| Dihedral_angle_const_iterator | dihedral_angles_end () const |
| For iterating on the dihedral angles of the polymer. | |
Attributes | |
| const Residue * | m_first_residue |
| The N-terminal residue of the chain. | |
| const Residue * | m_last_residue |
| The C-terminal residue of the chain. | |
| Chain & | m_chain |
| Contains the hierarchical info for polymers (Residues, Atoms) but not the SSE. | |
| Molecular_covalent_structure & | m_covalent_structure |
| The covalent structure of the chain. | |
| Conformation_type | m_conformation |
| The conformation of the chain. | |
| AtomId_to_particleRep_map_type | m_atomId_to_particleRep |
| The mapping from an atom serial number to its vertex id in the graph of the covalent structure. | |
| char | m_chain_id |
| The chain ID. | |
| std::string | m_chain_type |
| The chain type. | |
| std::vector< Molecular_covalent_structure > | m_components |
| The components of this chain, when there are multiple connected components. | |
| std::vector< std::pair< std::pair< int, char >, std::pair< int, char > > > | m_components_resids |
| The bounding residue ids for each component. | |
Representation of a single polynucleotide chain within a Nucleic Acid 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 boost::filter_iterator<Is_Alpha_angle, Dihedral_angle_const_iterator> Alpha_const_iterator |
Iterator(s) through named backbone dihedral angles within the polypeptide chain (here alpha) (const)
| typedef boost::filter_iterator<Is_Alpha_angle, Dihedral_angle_iterator> Alpha_iterator |
Iterator(s) through named backbone dihedral angles within the polypeptide chain (here alpha)
| typedef Base::Atom Atom |
Biophysical representation of an atom.
| typedef Base::Atoms_const_iterator Atoms_const_iterator |
Iterator through all atoms within the chain (const)
| typedef Base::Atoms_iterator Atoms_iterator |
Iterator through all atoms within the chain.
| typedef Base::Chain Chain |
Biophysical representation of chain of a model of the nucleic acid.
| typedef Base::Chosen_angle_const_iterator Chosen_angle_const_iterator |
To iterate on dihedral angles of a certain type (const)
| typedef Base::Chosen_angle_iterator Chosen_angle_iterator |
To iterate on dihedral angles of a certain type.
| typedef ConformationType Conformation_type |
Representation of a conformation, see package Molecular_conformation.
| typedef Base::Dihedral_angle Dihedral_angle |
Dihedral angle.
| typedef Base::Dihedral_angle_const_iterator Dihedral_angle_const_iterator |
Iterator through all atoms within the chain (const)
| typedef Base::Dihedral_angle_iterator Dihedral_angle_iterator |
Iterator through all atoms within the chain (const)
| typedef Base::FT FT |
Representation of the number type.
|
inherited |
Iterator through all the c-alpha atoms within the chain (const)
|
inherited |
Iterator through all the c-alpha atoms within the chain.
| typedef Base::Is_Heavy Is_Heavy |
Checks whether an atom is a heavy atom.
| 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. |
|
inherited |
Biophysical representation of a model of the linear polymer.
|
inherited |
Biophysical representation of a linear polymer.
| typedef boost::filter_iterator<Is_P, Atoms_iterator> P_iterator |
Iterators through selected atoms within the polynucleotide chain (5' ==> 3')
| typedef ParticleTraits Particle_traits |
Traits class defining types related to a particle, see ParticleTraits.
|
inherited |
Geometric representation of an atom, i.E a 3D point.
| typedef Base::Residue Residue |
Biophysical representation of a residue.
| typedef Base::Residue_atoms_const_iterator Residue_atoms_const_iterator |
Iterator through all atoms within a residue (const)
| typedef Base::Residue_atoms_iterator Residue_atoms_iterator |
Iterator through all atoms within a residue.
| typedef Base::Residues_const_iterator Residues_const_iterator |
Iterator through all residues within the polynucleotide chain (const)
| typedef Base::Residues_iterator Residues_iterator |
Iterator through all residues within the polynucleotide chain.
| typedef T_Polynucleotide_chain_representation<Particle_traits, Molecular_covalent_structure, Conformation_type> Self |
The class itself.
|
inline |
Builds an empty chain.
|
inline |
Builds a 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 the alpha angles of the NA chain.
|
inline |
For iterating on the alpha angles of the NA chain.
|
inline |
For iterating on the alpha angles of the NA chain.
|
inline |
For iterating on the alpha angles of the NA chain.
|
inlineinherited |
For iterating on atoms.
|
inlineinherited |
For iterating on atoms.
|
inlineinherited |
For iterating on atoms of a residue.
|
inlineinherited |
For iterating on atoms of a residue.
|
inlineinherited |
For iterating on atoms.
|
inlineinherited |
For iterating on atoms.
|
inlineinherited |
For iterating on atoms of a residue.
|
inlineinherited |
For iterating on atoms of a residue.
|
inlineinherited |
For iterating on the back bone of the chain or its component.
|
inlineinherited |
For iterating on the back bonee of the chain or its component.
|
inlineinherited |
For iterating on the back bonee of the chain or its component.
|
inlineinherited |
For iterating on the back bonee of the chain or its component.
|
inlineinherited |
For iterating on the bond angles of the polymer.
|
inlineinherited |
For iterating on the bond angles of the polymer.
|
inlineinherited |
For iterating on the bond angles of the polymer.
|
inlineinherited |
For iterating on the bond angles of the polymer.
|
inlineinherited |
For iterating on the bonds of the polymer.
|
inlineinherited |
For iterating on the bonds of the polymer.
|
inlineinherited |
For iterating on the bonds of the polymer.
|
inlineinherited |
For iterating on the bonds of the polymer.
|
inline |
For iterating on the c4ps of the NA chain.
|
inline |
For iterating on the c4ps of the NA chain.
|
inline |
For iterating on the c4ps of the NA chain.
|
inline |
For iterating on the c4ps of the NA chain.
|
inlineinherited |
Compute the center of mass of heavy atoms of the whole chain or of a connected component.
|
inherited |
For iterating on the dihedral angles of the polymer.
|
inlineinherited |
For iterating on the dihedral angles of the polymer.
|
inlineinherited |
For iterating on the dihedral angles of the polymer.
|
inlineinherited |
For iterating on the dihedral angles of the polymer.
|
inline |
Return the alpha angle associated to a residue.
| res | A const ref to the residue in question. |
|
inline |
Return the alpha angle associated to a residue.
| resn | The residue sequence number of the residue in question |
|
inlineinherited |
Function to get the specified atom from the specified residue.
| atom_name | The name of the atom |
| res | The residue containing wanted atom |
|
inlineinherited |
Function to get the backbone torsion angle specificied with an offset from a residue.
| offset_starting_atom | offset describing the torsion angle |
| res | The residue from which the offset is applied to find the torsion angle |
|
inline |
Return the beta angle associated to a residue.
| res | A const ref to the residue in question. |
|
inline |
Return the beta angle associated to a residue.
| resn | The residue sequence number of the residue in question |
|
inherited |
|
inherited |
Set the linear chain type specifier m_chain_type.
| (none). |
|
inlineinherited |
Return the underlying geometrical conformation.
|
inlineinherited |
Operator for allowing access to the coordinates of a particle in the current conformation.
| a | Reference to the particle in question |
|
inlineinherited |
Return the underlying covalent structure.
|
inlineinherited |
Return the first residue of the chain or of the component.
|
inlineinherited |
Return the last residue of the chain or of the component.
|
inlineinherited |
Return the number of bonds in the chain or in a component.
|
inlineinherited |
Return the number of connected components.
|
inlineinherited |
Return the number of embedded bonds in the chain or in a component.
|
inlineinherited |
Return the number of embedded particles in the chain or in one component.
|
inlineinherited |
Return the total number of particles.
|
inlineinherited |
Return the number of residues in the chain or in a component.
|
inlineinherited |
(deprecated) Return the atom representation of the input within the covalent structure
| a | Input atom |
|
inlineinherited |
Function to get the particle representations from a bond.
| b | Reference to the representation of a bond in the covalent structure. |
|
inherited |
|
inlineinherited |
Operator for allowing access to the x coordinate of a particle in the current conformation.
| a | Reference to the particle in question |
|
inlineinherited |
Operator for allowing access to the x coordinate of a particle in the current conformation.
| a | Reference to the particle in question |
|
inlineinherited |
Operator for allowing access to the y coordinate of a particle in the current conformation.
| a | Reference to the particle in question |
|
inlineinherited |
Operator for allowing access to the y coordinate of a particle in the current conformation.
| a | Reference to the particle in question |
|
inlineinherited |
Operator for allowing access to the z coordinate of a particle in the current conformation.
| a | Reference to the particle in question |
|
inlineinherited |
Operator for allowing access to the z coordinate of a particle in the current conformation.
| a | Reference to the particle in question |
|
inlineinherited |
For iterating on the heavy atoms of the polymer.
|
inlineinherited |
For iterating on the heavy atoms of the polymer.
|
inlineinherited |
For iterating on the heavy atoms of the polymer.
|
inlineinherited |
For iterating on the heavy atoms of the polymer.
|
inlineinherited |
Function to initialize incident atoms iterator.
| a | Reference to the atom in question. |
|
inlineinherited |
Function to initialize incident atoms iterator.
| a | Reference to the atom in question. |
|
inlineinherited |
Function to initialize incident atoms iterator.
| a | Reference to the atom in question. |
|
inlineinherited |
Function to initialize incident atoms iterator.
| a | Reference to the atom in question. |
|
inlineinherited |
Return true iff all particles in the chain or in a component are embedded.
|
inline |
Returns whether a residue's heavy atoms are all embedded.
| res | A const ref to the residue in question. |
|
inlineinherited |
Operator for allowing access to a particle given it's index in the covalent structure.
| p | Reference to the representation of the particle (or index) in the covalent structure. |
|
inlineinherited |
Function to initialize residues iterator.
|
inlineinherited |
Function to initialize residues iterator.
|
inlineinherited |
Function to initialize residues iterator.
|
inlineinherited |
Function to initialize residues iterator.
|
inlineinherited |
Modify the conformation.
| C | Reference to the new conformation |
|
protectedinherited |
The mapping from an atom serial number to its vertex id in the graph of the covalent structure.
|
protectedinherited |
Contains the hierarchical info for polymers (Residues, Atoms) but not the SSE.
|
protectedinherited |
The chain ID.
|
protectedinherited |
The chain type.
|
protectedinherited |
The components of this chain, when there are multiple connected components.
|
protectedinherited |
The bounding residue ids for each component.
|
protectedinherited |
The conformation of the chain.
|
protectedinherited |
The covalent structure of the chain.
|
protectedinherited |
The N-terminal residue of the chain.
|
protectedinherited |
The C-terminal residue of the chain.