Rosetta
Classes | Typedefs | Functions
core::scoring::constraints Namespace Reference

Classes

class  AmbiguousConstraint
 Nested constraint where only the one with lowest energy is considered. More...
 
class  AmbiguousNMRConstraint
 
class  AmbiguousNMRDistanceConstraint
 
class  AngleConstraint
 An Angular Constraint. More...
 
class  AtomPairConstraint
 
struct  XYZs
 
class  AtomToAxisConstraint
 
class  BackboneStubConstraint
 This constraint favors the backbone landing on a "stub" backbone, which puts the sidechain in a pre-determined desirable location. More...
 
class  BackboneStubLinearConstraint
 This constraint favors the backbone landing on a "stub" backbone, which puts the sidechain in a pre-determined desirable location. More...
 
class  BasePairConstraint
 
class  AtomPairConstraintCreator
 Constraint creator for the AtomPairConstraint constraint. More...
 
class  NamedAtomPairConstraintCreator
 Constraint creator for the NamedAtomPairConstraint constraint. More...
 
class  BasePairConstraintCreator
 Constraint creator for the BasePairConstraint constraint. More...
 
class  AngleConstraintCreator
 Constraint creator for the AngleConstraint constraint. More...
 
class  DihedralConstraintCreator
 Constraint creator for the DihedralConstraint constraint. More...
 
class  DihedralPairConstraintCreator
 Constraint creator for DihedralPairConstraint. More...
 
class  BigBinConstraintCreator
 Constraint creator for the BigBinConstraint constraint. More...
 
class  MultiConstraintCreator
 Constraint creator for the MultiConstraint constraint. More...
 
class  AmbiguousConstraintCreator
 Constraint creator for the AmbiguousConstraint constraint. More...
 
class  KofNConstraintCreator
 Constraint creator for the KofNConstraint constraint. More...
 
class  CoordinateConstraintCreator
 Constraint creator for the CoordinateConstraint constraint. More...
 
class  LocalCoordinateConstraintCreator
 Constraint creator for the LocalCoordinateConstraint constraint. More...
 
class  AmbiguousNMRDistanceConstraintCreator
 Constraint creator for the AmbiguousNMRDistanceConstraint constraint. More...
 
class  AmbiguousNMRConstraintCreator
 Constraint creator for the AmbiguousNMRConstraint constraint. More...
 
class  SiteConstraintCreator
 Constraint creator for the SiteConstraint constraint. More...
 
class  SiteConstraintResiduesCreator
 Constraint creator for the SiteConstraintResidues constraint. More...
 
class  FabConstraintCreator
 Constraint creator for the FabConstraint constraint. More...
 
class  NamedAngleConstraintCreator
 Constraint creator for the NamedAngleConstraint. More...
 
class  BigBinConstraint
 constraint on dihedral angle formed by 4 points More...
 
class  BoundFunc
 
class  PeriodicBoundFunc
 a variant of the bound func that is periodic More...
 
class  OffsetPeriodicBoundFunc
 a variant of the bound func that is periodic More...
 
class  ConstantConstraint
 A Constant Constraint. More...
 
class  Constraint
 Actually a restraint, like a virtual rubber band between a pair of atoms. More...
 
class  ConstraintCreator
 Abstract base class for a Mover factory; the Creator class is responsible for creating a particular mover class. More...
 
class  CstResNeighbIterator
 
class  CstResNeighbConstIterator
 
class  CstEnergyContainer
 
class  ConstraintFactory
 
class  ConstraintRegistrator
 This templated class will register an instance of an ConstraintCreator (class T) with the ConstraintFactory. It will ensure that no ConstraintCreator is registered twice, and, centralizes this registration logic so that thread safety issues can be handled in one place. More...
 
class  ConstraintNode
 
class  ConstraintEdge
 
class  ConstraintGraph
 
class  ConstraintIO
 
class  Constraints
 
class  ConstraintsEnergy
 
class  ConstraintsEnergyCreator
 
class  ResidueConstraints
 
class  ConstraintSet
 
class  CoordinateConstraint
 
class  CstMinimizationData
 
class  DihedralConstraint
 constraint on dihedral angle formed by 4 points More...
 
class  DihedralPairConstraint
 constraint on dihedral angle formed by 4 points More...
 
class  DistancePairConstraint
 constraint on CA distance More...
 
class  DOF_Constraint
 This isn't quite a standard constraint since it acts on DOF's directly rather than on XYZ coordinates. More...
 
class  FabConstraint
 
class  KofNConstraint
 
class  LocalCoordinateConstraint
 
class  MembraneSpanConstraint
 This class favors a particular residue identity at a particular position by reducing its res_type energy. More...
 
class  MembraneSpanTermZConstraint
 This class favors a particular residue identity at a particular position by reducing its res_type energy. More...
 
class  MultiConstraint
 
class  NamedAngleConstraint
 
class  Obsolet_NamedAtomPairConstraint
 
class  NamedAtomPairConstraint
 
class  NamedDihedralConstraint
 
class  NonResidueTypeConstraint
 This class favors a particular residue identity at a particular position by reducing its res_type energy. More...
 
class  ResidueCouplingConstraint
 This class favors a particular residue identity at two particular positions by adding the scaled tensor value to the energy map. More...
 
class  ResidueTypeConstraint
 This class favors a particular residue identity at a particular position by reducing its res_type energy. More...
 
class  ResidueTypeLinkingConstraint
 This class favors a particular residue identity at a particular position by reducing its res_type energy. More...
 
class  RTConstraint
 
class  SequenceProfileConstraint
 
class  SequenceProfileConstraintCreator
 Constraint creator for the SequenceProfileConstraint constraint. More...
 
class  SiteConstraint
 
class  SiteConstraintResidues
 

Typedefs

typedef utility::pointer::shared_ptr< AmbiguousConstraintAmbiguousConstraintOP
 
typedef utility::pointer::shared_ptr< AmbiguousConstraint const > AmbiguousConstraintCOP
 
typedef utility::pointer::shared_ptr< AmbiguousNMRConstraintAmbiguousNMRConstraintOP
 
typedef utility::pointer::shared_ptr< AmbiguousNMRConstraint const > AmbiguousNMRConstraintCOP
 
typedef utility::pointer::shared_ptr< AmbiguousNMRDistanceConstraintAmbiguousNMRDistanceConstraintOP
 
typedef utility::pointer::shared_ptr< AmbiguousNMRDistanceConstraint const > AmbiguousNMRDistanceConstraintCOP
 
typedef utility::vector1< core::id::NamedAtomIDNamedAtoms
 
typedef utility::pointer::shared_ptr< AngleConstraintAngleConstraintOP
 
typedef utility::pointer::shared_ptr< AngleConstraint const > AngleConstraintCOP
 
typedef utility::pointer::shared_ptr< AtomPairConstraintAtomPairConstraintOP
 
typedef utility::pointer::shared_ptr< AtomPairConstraint const > AtomPairConstraintCOP
 
typedef utility::pointer::shared_ptr< AtomToAxisConstraintAtomToAxisConstraintOP
 
typedef utility::pointer::shared_ptr< AtomToAxisConstraint const > AtomToAxisConstraintCOP
 
using XYZ = numeric::xyzVector< core::Real >
 
typedef utility::pointer::shared_ptr< BackboneStubConstraintBackboneStubConstraintOP
 
typedef utility::pointer::shared_ptr< BackboneStubConstraint const > BackboneStubConstraintCOP
 
typedef utility::vector1< BackboneStubConstraintOPBackboneStubConstraintOPs
 
typedef utility::vector1< BackboneStubConstraintCOPBackboneStubConstraintCOPs
 
typedef utility::pointer::shared_ptr< BackboneStubLinearConstraintBackboneStubLinearConstraintOP
 
typedef utility::pointer::shared_ptr< BackboneStubLinearConstraint const > BackboneStubLinearConstraintCOP
 
typedef utility::vector1< BackboneStubLinearConstraintOPBackboneStubLinearConstraintOPs
 
typedef utility::vector1< BackboneStubLinearConstraintCOPBackboneStubLinearConstraintCOPs
 
typedef utility::pointer::shared_ptr< BasePairConstraintBasePairConstraintOP
 
typedef utility::pointer::shared_ptr< BasePairConstraint const > BasePairConstraintCOP
 
typedef utility::pointer::shared_ptr< BigBinConstraintBigBinConstraintOP
 
typedef utility::pointer::shared_ptr< BigBinConstraint const > BigBinConstraintCOP
 
typedef utility::pointer::shared_ptr< BoundFuncBoundFuncOP
 
typedef utility::pointer::shared_ptr< BoundFunc const > BoundFuncCOP
 
typedef utility::pointer::shared_ptr< ConstantConstraintConstantConstraintOP
 
typedef utility::pointer::shared_ptr< ConstantConstraint const > ConstantConstraintCOP
 
typedef utility::pointer::shared_ptr< ConstraintConstraintOP
 
typedef utility::pointer::shared_ptr< Constraint const > ConstraintCOP
 
typedef utility::vector1< ConstraintOPConstraintOPs
 
typedef utility::vector1< ConstraintCOPConstraintCOPs
 
typedef utility::pointer::shared_ptr< ConstraintCreatorConstraintCreatorOP
 
typedef utility::pointer::shared_ptr< ConstraintCreator const > ConstraintCreatorCOP
 
typedef utility::pointer::shared_ptr< CstEnergyContainerCstEnergyContainerOP
 
typedef utility::pointer::shared_ptr< CstEnergyContainer const > CstEnergyContainerCOP
 
typedef utility::pointer::shared_ptr< ConstraintGraphConstraintGraphOP
 
typedef utility::pointer::shared_ptr< ConstraintGraph const > ConstraintGraphCOP
 
typedef utility::pointer::shared_ptr< ConstraintsConstraintsOP
 
typedef utility::pointer::shared_ptr< Constraints const > ConstraintsCOP
 
typedef utility::pointer::shared_ptr< ConstraintsEnergyConstraintsEnergyOP
 
typedef utility::pointer::shared_ptr< ConstraintsEnergy const > ConstraintsEnergyCOP
 
typedef utility::pointer::shared_ptr< ResidueConstraintsResidueConstraintsOP
 
typedef utility::pointer::shared_ptr< ResidueConstraints const > ResidueConstraintsCOP
 
typedef utility::pointer::shared_ptr< ConstraintSetConstraintSetOP
 
typedef utility::pointer::shared_ptr< ConstraintSet const > ConstraintSetCOP
 
typedef utility::pointer::shared_ptr< CoordinateConstraintCoordinateConstraintOP
 
typedef utility::pointer::shared_ptr< CoordinateConstraint const > CoordinateConstraintCOP
 
typedef utility::pointer::shared_ptr< CstMinimizationDataCstMinimizationDataOP
 
typedef utility::pointer::shared_ptr< CstMinimizationData const > CstMinimizationDataCOP
 
typedef utility::pointer::shared_ptr< DihedralConstraintDihedralConstraintOP
 
typedef utility::pointer::shared_ptr< DihedralConstraint const > DihedralConstraintCOP
 
typedef utility::pointer::shared_ptr< DOF_ConstraintDOF_ConstraintOP
 
typedef utility::pointer::shared_ptr< DOF_Constraint const > DOF_ConstraintCOP
 
typedef utility::vector1< DOF_ConstraintOPDOF_ConstraintOPs
 
typedef utility::vector1< DOF_ConstraintCOPDOF_ConstraintCOPs
 
typedef utility::pointer::shared_ptr< FabConstraintFabConstraintOP
 
typedef utility::pointer::shared_ptr< FabConstraint const > FabConstraintCOP
 
typedef utility::pointer::shared_ptr< KofNConstraintKofNConstraintOP
 
typedef utility::pointer::shared_ptr< KofNConstraint const > KofNConstraintCOP
 
typedef utility::pointer::shared_ptr< LocalCoordinateConstraintLocalCoordinateConstraintOP
 
typedef utility::pointer::shared_ptr< LocalCoordinateConstraint const > LocalCoordinateConstraintCOP
 
typedef utility::pointer::shared_ptr< MembraneSpanConstraintMembraneSpanConstraintOP
 
typedef utility::pointer::shared_ptr< MembraneSpanConstraint const > MembraneSpanConstraintCOP
 
typedef utility::pointer::shared_ptr< MembraneSpanTermZConstraintMembraneSpanTermZConstraintOP
 
typedef utility::pointer::shared_ptr< MembraneSpanTermZConstraint const > MembraneSpanTermZConstraintCOP
 
typedef utility::pointer::shared_ptr< MultiConstraintMultiConstraintOP
 
typedef utility::pointer::shared_ptr< MultiConstraint const > MultiConstraintCOP
 
typedef utility::pointer::shared_ptr< NamedAngleConstraintNamedAngleConstraintOP
 
typedef utility::pointer::shared_ptr< NamedAngleConstraint const > NamedAngleConstraintCOP
 
typedef utility::pointer::shared_ptr< NamedAtomPairConstraintNamedAtomPairConstraintOP
 
typedef utility::pointer::shared_ptr< NamedAtomPairConstraint const > NamedAtomPairConstraintCOP
 
typedef utility::pointer::shared_ptr< Obsolet_NamedAtomPairConstraintObsolet_NamedAtomPairConstraintOP
 
typedef utility::pointer::shared_ptr< Obsolet_NamedAtomPairConstraint const > Obsolet_NamedAtomPairConstraintCOP
 
typedef utility::pointer::shared_ptr< NamedDihedralConstraintNamedDihedralConstraintOP
 
typedef utility::pointer::shared_ptr< NamedDihedralConstraint const > NamedDihedralConstraintCOP
 
typedef utility::pointer::shared_ptr< NonResidueTypeConstraintNonResidueTypeConstraintOP
 
typedef utility::pointer::shared_ptr< NonResidueTypeConstraint const > NonResidueTypeConstraintCOP
 
typedef utility::pointer::shared_ptr< ResidueCouplingConstraintResidueCouplingConstraintOP
 
typedef utility::pointer::shared_ptr< ResidueCouplingConstraint const > ResidueCouplingConstraintCOP
 
typedef numeric::MathNTensor< double, 4 > CouplingTensor
 
typedef utility::pointer::shared_ptr< CouplingTensorCouplingTensorOP
 
typedef utility::pointer::shared_ptr< const CouplingTensorCouplingTensorCOP
 
typedef utility::pointer::shared_ptr< std::vector< int > > indexListOP
 
typedef utility::pointer::shared_ptr< const std::vector< int > > indexListCOP
 
typedef utility::pointer::shared_ptr< ResidueTypeConstraintResidueTypeConstraintOP
 
typedef utility::pointer::shared_ptr< ResidueTypeConstraint const > ResidueTypeConstraintCOP
 
typedef utility::pointer::shared_ptr< ResidueTypeLinkingConstraintResidueTypeLinkingConstraintOP
 
typedef utility::pointer::shared_ptr< ResidueTypeLinkingConstraint const > ResidueTypeLinkingConstraintCOP
 
typedef utility::pointer::shared_ptr< RTConstraintRTConstraintOP
 
typedef utility::pointer::shared_ptr< RTConstraint const > RTConstraintCOP
 
typedef utility::pointer::shared_ptr< SequenceProfileConstraintSequenceProfileConstraintOP
 
typedef utility::pointer::shared_ptr< SequenceProfileConstraint const > SequenceProfileConstraintCOP
 
typedef utility::pointer::shared_ptr< SiteConstraintSiteConstraintOP
 
typedef utility::pointer::shared_ptr< SiteConstraint const > SiteConstraintCOP
 
typedef utility::pointer::shared_ptr< SiteConstraintResiduesSiteConstraintResiduesOP
 
typedef utility::pointer::shared_ptr< SiteConstraintResidues const > SiteConstraintResiduesCOP
 

Functions

bool cst_eq (Constraint const &cst1, Constraint const &cst2)
 
bool is_aromatic (pose::Pose const &pose, core::Size res)
 
bool is_aromatic (core::chemical::AA aa)
 
void parse_NMR_name (std::string name, core::Size res, core::chemical::AA aa, NamedAtoms &atoms)
 
void parse_NMR_name (std::string name, core::Size res, AmbiguousNMRDistanceConstraint::Atoms &atoms, core::pose::Pose const &pose)
 
void parse_NMR_name_old (std::string name, core::Size res, AmbiguousNMRDistanceConstraint::Atoms &atoms, core::pose::Pose const &pose)
 
bool requires_CB_mapping (AmbiguousNMRDistanceConstraint::Atoms atoms, pose::Pose const &pose)
 
void combine_NMR_atom_string (AmbiguousNMRDistanceConstraint::Atoms atoms, std::string &atom_str, pose::Pose const &pose)
 
static basic::Tracer TR ("core.scoring.constraints.AngleConstraint")
 
core::Real distance_from_line (XYZ const &p, XYZ const &x1, XYZ const &x2)
 
XYZ closest_point_on_line (XYZ const &p, XYZ const &x1, XYZ const &x2)
 
XYZ closest_point_on_line (XYZs const &xyzs)
 
static basic::Tracer tr ("core.scoring.constraints.BackboneStubConstraint")
 
std::map< std::string, core::id::AtomIDauto_detect_atoms (pose::Pose const &pose, Size const seqpos)
 
static basic::Tracer TR ("core.scoring.constraints.BackboneStubLinearConstraint")
 
core::chemical::rna::BaseEdge get_edge_from_char (char const c)
 
std::ostream & operator<< (std::ostream &out, Constraint const &cst)
 
std::string get_section_name (std::string line)
 
static basic::Tracer tr ("core.scoring.ConstraintsEnergy")
 
static basic::Tracer tr ("core.scoring.ConstraintSet")
 
void add_constraint_to_residue_constraints (int const seqpos, ConstraintCOP cst, ResidueConstraints &residue_constraints)
 helper, static More...
 
bool remove_constraint_from_residue_constraints (int const seqpos, ConstraintCOP cst, ResidueConstraints &residue_constraints, bool object_comparison)
 helper, static More...
 
std::ostream & operator<< (std::ostream &os, ConstraintSet const &set)
 
static basic::Tracer TR ("core.scoring.constraints")
 
static basic::Tracer TR ("core.scoring.constraints")
 
static basic::Tracer TR ("core.scoring.constraints")
 
static basic::Tracer TR ("core.scoring.constraints.KofNConstraint")
 
static basic::Tracer TR ("core.scoring.constraints.MembraneSpanConstraint")
 
static basic::Tracer TR ("core.scoring.constraints.MembraneSpanTermZConstraint")
 
std::ostream & operator<< (std::ostream &out, Obsolet_NamedAtomPairConstraint const &cst)
 
static basic::Tracer TR ("core.scoring.constraints.NamedDihedralConstraint")
 
static basic::Tracer non_residue_type_constraint_tracer ("core.scoring.constraints.NonResidueTypeConstraint")
 
static basic::Tracer TR ("core.scoring.constraints.ResidueCouplingConstraint")
 
static basic::Tracer TR ("core.scoring.constraints.ResidueTypeConstraint")
 
static basic::Tracer TR ("core.scoring.constraints.ResidueTypeLinkingConstraint")
 
static basic::Tracer TR ("core.scoring.constraints.SequenceProfileConstraint")
 
static basic::Tracer tr ("core.scoring.constraints.util")
 
Real logdgaussian (Real x, Real mean, Real sd, Real weight)
 Returns the weighted value of a normal distribution evaluated with the given mean, sd, and x values. Returns zero if the weight is less than 1e-10. More...
 
Real logdgaussian_deriv (Real x, Real mean, Real sd, Real)
 Returns the weighted value of a normal distribution evaluated with the given mean, sd, and x values. Returns zero if the weight is less than 1e-10. More...
 
Real dgaussian (Real x, Real mean, Real sd, Real weight)
 Returns the weighted value of a normal distribution evaluated with the given mean, sd, and x values. Returns zero if the weight is less than 1e-10. More...
 
Real gaussian_deriv (Real x, Real mean, Real sd, Real weight)
 Returns the weighted derivative of a normal distribution evaluated with the given mean, sd, and x values. Returns zero if the weight is less than 1e-10. More...
 
Real dexponential (Real x, Real anchor, Real rate, Real weight)
 Returns the weighted value of an exponential distribution evaluated with the given anchor, rate, and x values. Returns zero if the weight is less than 1e-10. More...
 
Real exponential_deriv (Real x, Real anchor, Real rate, Real weight)
 Returns the weighted derivative of a log-exponential distribution evaluated with the given anchor, rate, and x values. Returns zero if the weight is less than 1e-10. More...
 
Real linear_interpolate (Real const x_val, Real const x1, Real const x2, Real const y1, Real const y2)
 Estimates the y-value of the given x-value by interpolating between the given points (x1,y1) and (x2,y2) by using linear interpolation between the two points. More...
 
void cull_violators (ConstraintCOPs const &target_list, ConstraintCOPs &culled_list, pose::Pose const &filter_pose, core::Real threshold)
 
std::string get_cst_file_option ()
 
std::string get_cst_file_option (utility::options::OptionCollection const &options)
 
void options_for_get_cst_file_option (utility::options::OptionKeyList &opts)
 companion function for get_cst_file_option More...
 
void add_constraints_from_cmdline_to_pose (core::pose::Pose &pose)
 
void add_constraints_from_cmdline_to_scorefxn (core::scoring::ScoreFunction &scorefxn_)
 
void add_constraints_from_cmdline (core::pose::Pose &pose, core::scoring::ScoreFunction &scorefxn_)
 
std::string get_cst_fa_file_option ()
 
std::string get_cst_fa_file_option (utility::options::OptionCollection const &options)
 
void options_for_get_cst_fa_file_option (utility::options::OptionKeyList &opts)
 companion function for get_cst_file_option More...
 
void add_fa_constraints_from_cmdline_to_pose (core::pose::Pose &pose)
 add constraints if specified by user. More...
 
void add_fa_constraints_from_cmdline_to_scorefxn (core::scoring::ScoreFunction &scorefxn_)
 add constraints if specified by user. More...
 
void add_fa_constraints_from_cmdline (core::pose::Pose &pose, core::scoring::ScoreFunction &scorefxn_)
 add constraints if specified by user. More...
 
void merge_constraints_from_cmdline_to_pose (core::pose::Pose &pose)
 merge cmdline constraints to pre-existing constraints More...
 
void merge_csts_to_scorefunction (core::Real const weight, core::scoring::ScoreFunction &scorefxn_)
 
void merge_constraints_from_cmdline_to_scorefxn (core::scoring::ScoreFunction &scorefxn_)
 merge cmdline constraints to pre-existing constraints - only adds to ZERO weights; previously nonzero constraint weights are unmodified and a warning is issued More...
 
void merge_constraints_from_cmdline (core::pose::Pose &pose, core::scoring::ScoreFunction &scorefxn_)
 merge cmdline constraints to pre-existing constraints More...
 
void merge_fa_constraints_from_cmdline_to_pose (core::pose::Pose &pose)
 merge cmdline constraints to pre-existing constraints More...
 
void merge_fa_constraints_from_cmdline_to_scorefxn (core::scoring::ScoreFunction &scorefxn_)
 merge cmdline constraints to pre-existing constraints - only adds to ZERO weights; previously nonzero constraint weights are unmodified and a warning is issued More...
 
void merge_fa_constraints_from_cmdline (core::pose::Pose &pose, core::scoring::ScoreFunction &scorefxn_)
 merge cmdline constraints to pre-existing constraints More...
 
void add_coordinate_constraints (core::pose::Pose &pose, core::Real const coord_sdev=10.0, bool include_sc=true)
 handy function for tethering pose to starting coordinates. More...
 
void add_coordinate_constraints (core::pose::Pose &pose, core::Size const start_res, core::Size const end_res, core::Real const coord_sdev=10.0, bool include_sc=true)
 Add coordinate constraints for starting coordinates, start:end residues, inclusive. More...
 
void remove_constraints_of_type (core::pose::Pose &pose, std::string const &type)
 Remove all constraints of a given type from a pose. More...
 
void remove_constraints_of_type (core::pose::Pose &pose, std::string const &type, core::Size const start_res, core::Size const end_res)
 Remove all constraints of a given type from a pose that involve start_res to end_res. Useful for coordinate/dihedral constraints. More...
 
void remove_nonbb_constraints (pose::Pose &pose)
 
bool combinable (Constraint const &cst, utility::vector1< Size > exclude_res)
 
void choose_effective_sequence_separation (core::kinematics::ShortestPathInFoldTree const &sp, ConstraintCOPs &in)
 combine constraints randomly into AmbiguousConstraints N -> 1 this greatly decreases the odds to have a wrong constraint More...
 
core::Size bin_by_seq_separation (core::Size sep)
 
void combine_constraints (ConstraintCOPs &in, core::Size combine_ratio, utility::vector1< bool > exclude_res, core::kinematics::ShortestPathInFoldTree const &sp_in)
 combine constraints randomly into AmbiguousConstraints N -> 1 this greatly decreases the odds to have a wrong constraint More...
 
void count_constraint (ConstraintCOP cst, bool redundant, ObjexxFCL::FArray2D_int &count_matrix, Size influence_width, Size total_residue)
 
bool keep_constraint (ConstraintCOP cst, bool redundant, ObjexxFCL::FArray2D_int &count_matrix, Size influence_width, Size total_residue)
 
void skip_redundant_constraints (ConstraintCOPs &in, core::Size total_residue, core::Size influence_width=1)
 have at most one constraint per residue pair... More...
 
void drop_constraints (ConstraintCOPs &in, core::Real drop_rate)
 
void print_atom_pair_constraints (pose::Pose const &pose, std::ostream &out=std::cout)
 example of how to go through a pose constraint set and print out stuff. More...
 
void map_constraints_from_original_pose (core::pose::Pose const &original_pose, core::pose::Pose &pose)
 map constraints to new atom numbers after, e.g. variants change. requires pose to have same number of residues. More...
 

Typedef Documentation

◆ AmbiguousConstraintCOP

typedef utility::pointer::shared_ptr< AmbiguousConstraint const > core::scoring::constraints::AmbiguousConstraintCOP

◆ AmbiguousConstraintOP

◆ AmbiguousNMRConstraintCOP

◆ AmbiguousNMRConstraintOP

◆ AmbiguousNMRDistanceConstraintCOP

◆ AmbiguousNMRDistanceConstraintOP

◆ AngleConstraintCOP

typedef utility::pointer::shared_ptr< AngleConstraint const > core::scoring::constraints::AngleConstraintCOP

◆ AngleConstraintOP

typedef utility::pointer::shared_ptr< AngleConstraint > core::scoring::constraints::AngleConstraintOP

◆ AtomPairConstraintCOP

typedef utility::pointer::shared_ptr< AtomPairConstraint const > core::scoring::constraints::AtomPairConstraintCOP

◆ AtomPairConstraintOP

◆ AtomToAxisConstraintCOP

typedef utility::pointer::shared_ptr< AtomToAxisConstraint const > core::scoring::constraints::AtomToAxisConstraintCOP

◆ AtomToAxisConstraintOP

◆ BackboneStubConstraintCOP

◆ BackboneStubConstraintCOPs

◆ BackboneStubConstraintOP

◆ BackboneStubConstraintOPs

◆ BackboneStubLinearConstraintCOP

◆ BackboneStubLinearConstraintCOPs

◆ BackboneStubLinearConstraintOP

◆ BackboneStubLinearConstraintOPs

◆ BasePairConstraintCOP

typedef utility::pointer::shared_ptr< BasePairConstraint const > core::scoring::constraints::BasePairConstraintCOP

◆ BasePairConstraintOP

◆ BigBinConstraintCOP

typedef utility::pointer::shared_ptr< BigBinConstraint const > core::scoring::constraints::BigBinConstraintCOP

◆ BigBinConstraintOP

typedef utility::pointer::shared_ptr< BigBinConstraint > core::scoring::constraints::BigBinConstraintOP

◆ BoundFuncCOP

typedef utility::pointer::shared_ptr< BoundFunc const > core::scoring::constraints::BoundFuncCOP

◆ BoundFuncOP

typedef utility::pointer::shared_ptr< BoundFunc > core::scoring::constraints::BoundFuncOP

◆ ConstantConstraintCOP

typedef utility::pointer::shared_ptr< ConstantConstraint const > core::scoring::constraints::ConstantConstraintCOP

◆ ConstantConstraintOP

◆ ConstraintCOP

typedef utility::pointer::shared_ptr< Constraint const > core::scoring::constraints::ConstraintCOP

◆ ConstraintCOPs

◆ ConstraintCreatorCOP

typedef utility::pointer::shared_ptr< ConstraintCreator const > core::scoring::constraints::ConstraintCreatorCOP

◆ ConstraintCreatorOP

typedef utility::pointer::shared_ptr< ConstraintCreator > core::scoring::constraints::ConstraintCreatorOP

◆ ConstraintGraphCOP

typedef utility::pointer::shared_ptr< ConstraintGraph const > core::scoring::constraints::ConstraintGraphCOP

◆ ConstraintGraphOP

typedef utility::pointer::shared_ptr< ConstraintGraph > core::scoring::constraints::ConstraintGraphOP

◆ ConstraintOP

typedef utility::pointer::shared_ptr< Constraint > core::scoring::constraints::ConstraintOP

◆ ConstraintOPs

◆ ConstraintsCOP

typedef utility::pointer::shared_ptr< Constraints const > core::scoring::constraints::ConstraintsCOP

◆ ConstraintsEnergyCOP

typedef utility::pointer::shared_ptr< ConstraintsEnergy const > core::scoring::constraints::ConstraintsEnergyCOP

◆ ConstraintsEnergyOP

typedef utility::pointer::shared_ptr< ConstraintsEnergy > core::scoring::constraints::ConstraintsEnergyOP

◆ ConstraintSetCOP

typedef utility::pointer::shared_ptr< ConstraintSet const > core::scoring::constraints::ConstraintSetCOP

◆ ConstraintSetOP

typedef utility::pointer::shared_ptr< ConstraintSet > core::scoring::constraints::ConstraintSetOP

◆ ConstraintsOP

typedef utility::pointer::shared_ptr< Constraints > core::scoring::constraints::ConstraintsOP

◆ CoordinateConstraintCOP

typedef utility::pointer::shared_ptr< CoordinateConstraint const > core::scoring::constraints::CoordinateConstraintCOP

◆ CoordinateConstraintOP

◆ CouplingTensor

typedef numeric::MathNTensor< double, 4 > core::scoring::constraints::CouplingTensor

◆ CouplingTensorCOP

typedef utility::pointer::shared_ptr< const CouplingTensor > core::scoring::constraints::CouplingTensorCOP

◆ CouplingTensorOP

typedef utility::pointer::shared_ptr< CouplingTensor > core::scoring::constraints::CouplingTensorOP

◆ CstEnergyContainerCOP

typedef utility::pointer::shared_ptr< CstEnergyContainer const > core::scoring::constraints::CstEnergyContainerCOP

◆ CstEnergyContainerOP

◆ CstMinimizationDataCOP

typedef utility::pointer::shared_ptr< CstMinimizationData const > core::scoring::constraints::CstMinimizationDataCOP

◆ CstMinimizationDataOP

◆ DihedralConstraintCOP

typedef utility::pointer::shared_ptr< DihedralConstraint const > core::scoring::constraints::DihedralConstraintCOP

◆ DihedralConstraintOP

◆ DOF_ConstraintCOP

typedef utility::pointer::shared_ptr< DOF_Constraint const > core::scoring::constraints::DOF_ConstraintCOP

◆ DOF_ConstraintCOPs

◆ DOF_ConstraintOP

typedef utility::pointer::shared_ptr< DOF_Constraint > core::scoring::constraints::DOF_ConstraintOP

◆ DOF_ConstraintOPs

◆ FabConstraintCOP

typedef utility::pointer::shared_ptr< FabConstraint const > core::scoring::constraints::FabConstraintCOP

◆ FabConstraintOP

typedef utility::pointer::shared_ptr< FabConstraint > core::scoring::constraints::FabConstraintOP

◆ indexListCOP

typedef utility::pointer::shared_ptr< const std::vector<int> > core::scoring::constraints::indexListCOP

◆ indexListOP

typedef utility::pointer::shared_ptr< std::vector<int> > core::scoring::constraints::indexListOP

◆ KofNConstraintCOP

typedef utility::pointer::shared_ptr< KofNConstraint const > core::scoring::constraints::KofNConstraintCOP

◆ KofNConstraintOP

typedef utility::pointer::shared_ptr< KofNConstraint > core::scoring::constraints::KofNConstraintOP

◆ LocalCoordinateConstraintCOP

◆ LocalCoordinateConstraintOP

◆ MembraneSpanConstraintCOP

◆ MembraneSpanConstraintOP

◆ MembraneSpanTermZConstraintCOP

◆ MembraneSpanTermZConstraintOP

◆ MultiConstraintCOP

typedef utility::pointer::shared_ptr< MultiConstraint const > core::scoring::constraints::MultiConstraintCOP

◆ MultiConstraintOP

typedef utility::pointer::shared_ptr< MultiConstraint > core::scoring::constraints::MultiConstraintOP

◆ NamedAngleConstraintCOP

typedef utility::pointer::shared_ptr< NamedAngleConstraint const > core::scoring::constraints::NamedAngleConstraintCOP

◆ NamedAngleConstraintOP

◆ NamedAtomPairConstraintCOP

◆ NamedAtomPairConstraintOP

◆ NamedAtoms

◆ NamedDihedralConstraintCOP

◆ NamedDihedralConstraintOP

◆ NonResidueTypeConstraintCOP

◆ NonResidueTypeConstraintOP

◆ Obsolet_NamedAtomPairConstraintCOP

◆ Obsolet_NamedAtomPairConstraintOP

◆ ResidueConstraintsCOP

typedef utility::pointer::shared_ptr< ResidueConstraints const > core::scoring::constraints::ResidueConstraintsCOP

◆ ResidueConstraintsOP

◆ ResidueCouplingConstraintCOP

◆ ResidueCouplingConstraintOP

◆ ResidueTypeConstraintCOP

typedef utility::pointer::shared_ptr< ResidueTypeConstraint const > core::scoring::constraints::ResidueTypeConstraintCOP

◆ ResidueTypeConstraintOP

◆ ResidueTypeLinkingConstraintCOP

◆ ResidueTypeLinkingConstraintOP

◆ RTConstraintCOP

typedef utility::pointer::shared_ptr< RTConstraint const > core::scoring::constraints::RTConstraintCOP

◆ RTConstraintOP

typedef utility::pointer::shared_ptr< RTConstraint > core::scoring::constraints::RTConstraintOP

◆ SequenceProfileConstraintCOP

◆ SequenceProfileConstraintOP

◆ SiteConstraintCOP

typedef utility::pointer::shared_ptr< SiteConstraint const > core::scoring::constraints::SiteConstraintCOP

◆ SiteConstraintOP

typedef utility::pointer::shared_ptr< SiteConstraint > core::scoring::constraints::SiteConstraintOP

◆ SiteConstraintResiduesCOP

◆ SiteConstraintResiduesOP

◆ XYZ

using core::scoring::constraints::XYZ = typedef numeric::xyzVector< core::Real >

Function Documentation

◆ add_constraint_to_residue_constraints()

void core::scoring::constraints::add_constraint_to_residue_constraints ( int const  seqpos,
ConstraintCOP  cst,
ResidueConstraints residue_constraints 
)

◆ add_constraints_from_cmdline()

void core::scoring::constraints::add_constraints_from_cmdline ( core::pose::Pose pose,
core::scoring::ScoreFunction scorefxn_ 
)

add constraints from command line to SCOREFUNCTION AND POSE BOTH, if cst file is supplied by user. Overwrites any constraints present in either. Assumed to be "centroid constraints" using cst_file & cst_weight (will work fine with fa constraints, but uses the not-fa command line options).

References add_constraints_from_cmdline_to_pose(), and add_constraints_from_cmdline_to_scorefxn().

Referenced by protocols::canonical_sampling::CanonicalSamplingMover::apply(), protocols::cluster::GatherPosesMover::apply(), protocols::flexpep_docking::FlexPepDockingProtocol::apply(), protocols::rbsegment_relax::AutoRBMover::apply(), protocols::relax::loop::LoopRelaxMover::apply(), and protocols::loop_modeling::LoopProtocol::start_protocol().

◆ add_constraints_from_cmdline_to_pose()

void core::scoring::constraints::add_constraints_from_cmdline_to_pose ( core::pose::Pose pose)

◆ add_constraints_from_cmdline_to_scorefxn()

void core::scoring::constraints::add_constraints_from_cmdline_to_scorefxn ( core::scoring::ScoreFunction scorefxn_)

◆ add_coordinate_constraints() [1/2]

void core::scoring::constraints::add_coordinate_constraints ( pose::Pose pose,
Real const  coord_sdev,
bool  include_sc 
)

◆ add_coordinate_constraints() [2/2]

void core::scoring::constraints::add_coordinate_constraints ( pose::Pose pose,
core::Size const  start_res,
core::Size const  end_res,
Real const  coord_sdev,
bool  include_sc 
)

◆ add_fa_constraints_from_cmdline()

void core::scoring::constraints::add_fa_constraints_from_cmdline ( core::pose::Pose pose,
core::scoring::ScoreFunction scorefxn_ 
)

add constraints if specified by user.

add constraints from command line to SCOREFUNCTION AND POSE BOTH, if cst file is supplied by user. Overwrites any constraints present in either. Assumed to be "fullatom constraints" because it uses the cst_fa_file & cst_fa_weight flags, but will work with centroids otherwise.

References add_fa_constraints_from_cmdline_to_pose(), and add_fa_constraints_from_cmdline_to_scorefxn().

Referenced by protocols::flexpep_docking::FlexPepDockingProtocol::apply(), protocols::relax::loop::LoopRelaxMover::apply(), protocols::abinitio::AbrelaxApplication::relax(), and protocols::loop_modeling::LoopProtocol::start_protocol().

◆ add_fa_constraints_from_cmdline_to_pose()

void core::scoring::constraints::add_fa_constraints_from_cmdline_to_pose ( core::pose::Pose pose)

◆ add_fa_constraints_from_cmdline_to_scorefxn()

void core::scoring::constraints::add_fa_constraints_from_cmdline_to_scorefxn ( core::scoring::ScoreFunction scorefxn_)

add constraints if specified by user.

add constraints from command line to SCOREFUNCTION ONLY, if cst file is supplied by user. Overwrites any constraint weights already in the scorefunction. Assumed to be "fullatom constraints" because it uses the cst_fa_weight flag, but will work with centroids otherwise.

References core::scoring::angle_constraint, core::scoring::atom_pair_constraint, core::scoring::coordinate_constraint, core::scoring::dihedral_constraint, and core::scoring::ScoreFunction::set_weight().

Referenced by protocols::simple_filters::ExtraScoreEvaluatorCreator::add_evaluators(), add_fa_constraints_from_cmdline(), protocols::indel::IndelOptimizationMover::apply(), protocols::loop_grower::LoopGrower::apply(), protocols::ncbb::NcbbDockDesignProtocol::apply(), protocols::ncbb::oop::OopCreatorMover::apply(), protocols::ncbb::oop::OopDockDesignProtocol::apply(), protocols::relax::loop::LoopRelaxMover::apply(), protocols::coupled_moves::CoupledMovesProtocol::configure_score_fxn(), protocols::backrub::BackrubProtocol::finalize_setup(), protocols::floppy_tail::FloppyTailMover::FloppyTailMover(), protocols::flxbb::FlxbbDesign_main(), protocols::relax::generate_relax_from_cmd(), protocols::hydrate::Hydrate::Hydrate(), protocols::hybridization::HybridizeProtocol::init(), protocols::loophash::MPI_LoopHashRefine::load_structures_from_cmdline_into_library(), protocols::mpi_refinement::MPI_Refinement::load_structures_from_cmdline_into_library(), protocols::relax::LocalRelax::LocalRelax(), protocols::ncbb::NcbbDockDesignProtocol::NcbbDockDesignProtocol(), protocols::ncbb::oop::OopDockDesignProtocol::OopDockDesignProtocol(), protocols::relax::WorkUnit_BatchRelax::run(), protocols::ncbb::SecStructFinder::SecStructFinder(), and protocols::glycan_docking::GlycanDockProtocol::setup_scorefxn().

◆ auto_detect_atoms()

std::map< std::string, core::id::AtomID > core::scoring::constraints::auto_detect_atoms ( pose::Pose const &  pose,
Size const  seqpos 
)

◆ bin_by_seq_separation()

core::Size core::scoring::constraints::bin_by_seq_separation ( core::Size  sep)
inline

Referenced by combine_constraints().

◆ choose_effective_sequence_separation()

void core::scoring::constraints::choose_effective_sequence_separation ( core::kinematics::ShortestPathInFoldTree const &  sp,
ConstraintCOPs in 
)

combine constraints randomly into AmbiguousConstraints N -> 1 this greatly decreases the odds to have a wrong constraint

call this on your constraints if you have MultiConstraints before running Abinitio – already done by broker-type application

References core::scoring::constraints::Constraint::choose_effective_sequence_separation(), core::conformation::membrane::in, and core::scoring::rg.

Referenced by protocols::topology_broker::ConstraintClaimer::add_constraints(), protocols::abinitio::abscript::ConstraintPreparer::prepare(), and protocols::constraints_additional::ConstraintEvaluator::prepare_pose().

◆ closest_point_on_line() [1/2]

XYZ core::scoring::constraints::closest_point_on_line ( XYZ const &  p,
XYZ const &  x1,
XYZ const &  x2 
)

◆ closest_point_on_line() [2/2]

XYZ core::scoring::constraints::closest_point_on_line ( XYZs const &  xyzs)

◆ combinable()

bool core::scoring::constraints::combinable ( Constraint const &  cst,
utility::vector1< Size exclude_res 
)

◆ combine_constraints()

void core::scoring::constraints::combine_constraints ( ConstraintCOPs in,
core::Size  combine_ratio,
utility::vector1< bool >  exclude_res,
core::kinematics::ShortestPathInFoldTree const &  sp_in 
)

combine constraints randomly into AmbiguousConstraints N -> 1 this greatly decreases the odds to have a wrong constraint

combine constraints randomly into Ambiguous constraints...

References bin_by_seq_separation(), combinable(), core::conformation::membrane::in, core::conformation::membrane::out, core::scoring::rg, and tr().

Referenced by protocols::topology_broker::ConstraintClaimer::add_constraints(), protocols::abinitio::abscript::ConstraintPreparer::prepare(), and protocols::constraints_additional::ConstraintEvaluator::prepare_pose().

◆ combine_NMR_atom_string()

void core::scoring::constraints::combine_NMR_atom_string ( AmbiguousNMRDistanceConstraint::Atoms  atoms,
std::string &  atom_str,
pose::Pose const &  pose 
)

◆ count_constraint()

void core::scoring::constraints::count_constraint ( ConstraintCOP  cst,
bool  redundant,
ObjexxFCL::FArray2D_int &  count_matrix,
Size  influence_width,
Size  total_residue 
)

◆ cst_eq()

bool core::scoring::constraints::cst_eq ( Constraint const &  cst1,
Constraint const &  cst2 
)

◆ cull_violators()

void core::scoring::constraints::cull_violators ( ConstraintCOPs const &  target_list,
ConstraintCOPs culled_list,
pose::Pose const &  filter_pose,
core::Real  threshold 
)

◆ dexponential()

Real core::scoring::constraints::dexponential ( Real  x,
Real  anchor,
Real  rate,
Real  weight 
)

Returns the weighted value of an exponential distribution evaluated with the given anchor, rate, and x values. Returns zero if the weight is less than 1e-10.

Returns the weighted value of an Exponential distribution evaluated with the given anchor, rate, and x values. Returns zero if the weight is less than 1e-10.

Referenced by core::scoring::func::MixtureFunc::dfunc_component(), and core::scoring::func::MixtureFunc::func_().

◆ dgaussian()

Real core::scoring::constraints::dgaussian ( Real  x,
Real  mean,
Real  sd,
Real  weight 
)

◆ distance_from_line()

core::Real core::scoring::constraints::distance_from_line ( XYZ const &  p,
XYZ const &  x1,
XYZ const &  x2 
)

This can be sped up by using distances-squared

◆ drop_constraints()

void core::scoring::constraints::drop_constraints ( ConstraintCOPs in,
core::Real  drop_rate 
)

◆ exponential_deriv()

Real core::scoring::constraints::exponential_deriv ( Real  x,
Real  anchor,
Real  rate,
Real  weight 
)

Returns the weighted derivative of a log-exponential distribution evaluated with the given anchor, rate, and x values. Returns zero if the weight is less than 1e-10.

Returns the weighted derivative of an Exponential distribution evaluated with the given anchor, rate, and x values. Returns zero if the weight is less than 1e-10.

Referenced by core::scoring::func::MixtureFunc::dfunc_component().

◆ gaussian_deriv()

Real core::scoring::constraints::gaussian_deriv ( Real  x,
Real  mean,
Real  sd,
Real  weight 
)

Returns the weighted derivative of a normal distribution evaluated with the given mean, sd, and x values. Returns zero if the weight is less than 1e-10.

Returns the weighted derivative of a Gaussian distribution evaluated with the given mean, sd, and x values. Returns zero if the weight is less than 1e-10.

References dgaussian(), and core::simple_metrics::metrics::mean.

Referenced by core::scoring::func::GaussianFunc::dfunc(), and core::scoring::func::MixtureFunc::dfunc_component().

◆ get_cst_fa_file_option() [1/2]

std::string core::scoring::constraints::get_cst_fa_file_option ( )

◆ get_cst_fa_file_option() [2/2]

std::string core::scoring::constraints::get_cst_fa_file_option ( utility::options::OptionCollection const &  options)

References core::scoring::rg, and tr().

◆ get_cst_file_option() [1/2]

std::string core::scoring::constraints::get_cst_file_option ( )

◆ get_cst_file_option() [2/2]

std::string core::scoring::constraints::get_cst_file_option ( utility::options::OptionCollection const &  options)

References core::scoring::rg, and tr().

◆ get_edge_from_char()

core::chemical::rna::BaseEdge core::scoring::constraints::get_edge_from_char ( char const  c)
inline

◆ get_section_name()

std::string core::scoring::constraints::get_section_name ( std::string  line)

◆ is_aromatic() [1/2]

bool core::scoring::constraints::is_aromatic ( core::chemical::AA  aa)

◆ is_aromatic() [2/2]

bool core::scoring::constraints::is_aromatic ( pose::Pose const &  pose,
core::Size  res 
)
inline

◆ keep_constraint()

bool core::scoring::constraints::keep_constraint ( ConstraintCOP  cst,
bool  redundant,
ObjexxFCL::FArray2D_int &  count_matrix,
Size  influence_width,
Size  total_residue 
)

References tr().

Referenced by skip_redundant_constraints().

◆ linear_interpolate()

Real core::scoring::constraints::linear_interpolate ( Real const  x_val,
Real const  x1,
Real const  x2,
Real const  y1,
Real const  y2 
)

Estimates the y-value of the given x-value by interpolating between the given points (x1,y1) and (x2,y2) by using linear interpolation between the two points.

Referenced by protocols::medal::MedalMover::apply(), and core::scoring::func::EtableFunc::func().

◆ logdgaussian()

Real core::scoring::constraints::logdgaussian ( Real  x,
Real  mean,
Real  sd,
Real  weight 
)

Returns the weighted value of a normal distribution evaluated with the given mean, sd, and x values. Returns zero if the weight is less than 1e-10.

Returns the log of the weighted value of a Gaussian distribution evaluated with the given mean, sd, and x values. Returns zero if the weight is less than 1e-10.

References core::simple_metrics::metrics::mean.

Referenced by core::scoring::func::GaussianFunc::func().

◆ logdgaussian_deriv()

Real core::scoring::constraints::logdgaussian_deriv ( Real  x,
Real  mean,
Real  sd,
Real   
)

Returns the weighted value of a normal distribution evaluated with the given mean, sd, and x values. Returns zero if the weight is less than 1e-10.

Returns the log of the weighted value of a Gaussian distribution evaluated with the given mean, sd, and x values. Returns zero if the weight is less than 1e-10.

References core::simple_metrics::metrics::mean.

Referenced by core::scoring::func::GaussianFunc::dfunc().

◆ map_constraints_from_original_pose()

void core::scoring::constraints::map_constraints_from_original_pose ( pose::Pose const &  original_pose,
pose::Pose pose 
)

◆ merge_constraints_from_cmdline()

void core::scoring::constraints::merge_constraints_from_cmdline ( core::pose::Pose pose,
core::scoring::ScoreFunction scorefxn_ 
)

merge cmdline constraints to pre-existing constraints

perform both pose and scorefunction updates in merge mode for centroid flags -cst_file and -cst_weight

References merge_constraints_from_cmdline_to_pose(), and merge_constraints_from_cmdline_to_scorefxn().

◆ merge_constraints_from_cmdline_to_pose()

void core::scoring::constraints::merge_constraints_from_cmdline_to_pose ( core::pose::Pose pose)

merge cmdline constraints to pre-existing constraints

merge centroid constraints from commandline (cst_file) to pose: read the user-specified constraints file, and merge those to the Pose's ConstraintSet. Creates a ConstraintSet normally, then merges it to the Pose's set.

References core::pose::Pose::add_constraints(), and get_cst_file_option().

Referenced by merge_constraints_from_cmdline().

◆ merge_constraints_from_cmdline_to_scorefxn()

void core::scoring::constraints::merge_constraints_from_cmdline_to_scorefxn ( core::scoring::ScoreFunction scorefxn_)

merge cmdline constraints to pre-existing constraints - only adds to ZERO weights; previously nonzero constraint weights are unmodified and a warning is issued

"merge" constraint weights for scorefunction. I don't know what "merge" means here, so it will only modify the zero weights; nonzero weights are untouched. Reads -cst_weight from command line, and sets nonzero constraint weights to the new value

References merge_csts_to_scorefunction().

Referenced by merge_constraints_from_cmdline().

◆ merge_csts_to_scorefunction()

void core::scoring::constraints::merge_csts_to_scorefunction ( core::Real const  weight,
core::scoring::ScoreFunction scorefxn_ 
)

◆ merge_fa_constraints_from_cmdline()

void core::scoring::constraints::merge_fa_constraints_from_cmdline ( core::pose::Pose pose,
core::scoring::ScoreFunction scorefxn_ 
)

merge cmdline constraints to pre-existing constraints

perform both pose and scorefunction updates in merge mode for centroid flags -cst_fa_file and -cst_fa_weight

References merge_fa_constraints_from_cmdline_to_pose(), and merge_fa_constraints_from_cmdline_to_scorefxn().

◆ merge_fa_constraints_from_cmdline_to_pose()

void core::scoring::constraints::merge_fa_constraints_from_cmdline_to_pose ( core::pose::Pose pose)

merge cmdline constraints to pre-existing constraints

merge fullatom constraints from commandline (cst_fa_file) to pose: read the user-specified constraints file, and merge those to the Pose's ConstraintSet. Creates a ConstraintSet normally, then merges it to the Pose's set.

FA constraints (merge mode)

References core::pose::Pose::add_constraints(), and get_cst_fa_file_option().

Referenced by merge_fa_constraints_from_cmdline().

◆ merge_fa_constraints_from_cmdline_to_scorefxn()

void core::scoring::constraints::merge_fa_constraints_from_cmdline_to_scorefxn ( core::scoring::ScoreFunction scorefxn_)

merge cmdline constraints to pre-existing constraints - only adds to ZERO weights; previously nonzero constraint weights are unmodified and a warning is issued

"merge" constraint weights for scorefunction. I don't know what "merge" means here, so it will only modify the zero weights; nonzero weights are untouched. Reads -cst_fa_weight from command line, and sets nonzero constraint weights to the new value

References merge_csts_to_scorefunction().

Referenced by merge_fa_constraints_from_cmdline().

◆ non_residue_type_constraint_tracer()

static basic::Tracer core::scoring::constraints::non_residue_type_constraint_tracer ( "core.scoring.constraints.NonResidueTypeConstraint"  )
static

◆ operator<<() [1/3]

std::ostream & core::scoring::constraints::operator<< ( std::ostream &  os,
ConstraintSet const &  set 
)

◆ operator<<() [2/3]

std::ostream & core::scoring::constraints::operator<< ( std::ostream &  out,
Constraint const &  cst 
)

◆ operator<<() [3/3]

std::ostream& core::scoring::constraints::operator<< ( std::ostream &  out,
Obsolet_NamedAtomPairConstraint const &  cst 
)

◆ options_for_get_cst_fa_file_option()

void core::scoring::constraints::options_for_get_cst_fa_file_option ( utility::options::OptionKeyList &  opts)

companion function for get_cst_file_option

◆ options_for_get_cst_file_option()

void core::scoring::constraints::options_for_get_cst_file_option ( utility::options::OptionKeyList &  opts)

companion function for get_cst_file_option

◆ parse_NMR_name() [1/2]

void core::scoring::constraints::parse_NMR_name ( std::string  name,
core::Size  res,
AmbiguousNMRDistanceConstraint::Atoms atoms,
core::pose::Pose const &  pose 
)

◆ parse_NMR_name() [2/2]

void core::scoring::constraints::parse_NMR_name ( std::string  name,
core::Size  res,
core::chemical::AA  aa,
NamedAtoms atoms 
)

◆ parse_NMR_name_old()

void core::scoring::constraints::parse_NMR_name_old ( std::string  name,
core::Size  res,
AmbiguousNMRDistanceConstraint::Atoms atoms,
core::pose::Pose const &  pose 
)

◆ print_atom_pair_constraints()

void core::scoring::constraints::print_atom_pair_constraints ( pose::Pose const &  pose,
std::ostream &  out 
)

example of how to go through a pose constraint set and print out stuff.

example of how to go through a pose constraint set and print out stuff.

References core::pose::Pose::constraint_set(), core::conformation::membrane::out, core::scoring::constraints::Constraint::show_def(), core::pose::Pose::size(), and core::scoring::constraints::Constraint::type().

◆ remove_constraint_from_residue_constraints()

bool core::scoring::constraints::remove_constraint_from_residue_constraints ( int const  seqpos,
ConstraintCOP  cst,
ResidueConstraints residue_constraints,
bool  object_comparison 
)

◆ remove_constraints_of_type() [1/2]

void core::scoring::constraints::remove_constraints_of_type ( core::pose::Pose pose,
std::string const &  type 
)

◆ remove_constraints_of_type() [2/2]

void core::scoring::constraints::remove_constraints_of_type ( core::pose::Pose pose,
std::string const &  type,
core::Size const  start_res,
core::Size const  end_res 
)

Remove all constraints of a given type from a pose that involve start_res to end_res. Useful for coordinate/dihedral constraints.

References core::pose::Pose::constraint_set(), and core::pose::Pose::remove_constraint().

◆ remove_nonbb_constraints()

void core::scoring::constraints::remove_nonbb_constraints ( pose::Pose pose)

◆ requires_CB_mapping()

bool core::scoring::constraints::requires_CB_mapping ( AmbiguousNMRDistanceConstraint::Atoms  atoms,
pose::Pose const &  pose 
)

◆ skip_redundant_constraints()

void core::scoring::constraints::skip_redundant_constraints ( ConstraintCOPs in,
Size  total_residue,
Size  influence_width 
)

◆ TR() [1/13]

static basic::Tracer core::scoring::constraints::TR ( "core.scoring.constraints"  )
static

◆ TR() [2/13]

static basic::Tracer core::scoring::constraints::TR ( "core.scoring.constraints"  )
static

◆ TR() [3/13]

static basic::Tracer core::scoring::constraints::TR ( "core.scoring.constraints"  )
static

◆ TR() [4/13]

static basic::Tracer core::scoring::constraints::TR ( "core.scoring.constraints.AngleConstraint"  )
static

Referenced by core::scoring::constraints::AngleConstraint::angle(), core::scoring::constraints::BackboneStubLinearConstraint::BackboneStubLinearConstraint(), core::scoring::constraints::DihedralPairConstraint::dihedral_diff(), core::scoring::constraints::SequenceProfileConstraint::dist(), core::scoring::constraints::AtomToAxisConstraint::dist(), core::scoring::constraints::DistancePairConstraint::distance_diff(), core::scoring::constraints::BackboneStubLinearConstraint::fill_f1_f2(), core::scoring::constraints::SequenceProfileConstraint::read_def(), core::scoring::constraints::AngleConstraint::read_def(), core::scoring::constraints::FabConstraint::read_def(), core::scoring::constraints::KofNConstraint::read_def(), core::scoring::constraints::SiteConstraint::read_def(), core::scoring::constraints::SiteConstraintResidues::read_def(), core::scoring::constraints::DihedralConstraint::read_def(), core::scoring::constraints::DihedralPairConstraint::read_def(), core::scoring::constraints::DistancePairConstraint::read_def(), core::scoring::constraints::NamedAngleConstraint::read_def(), core::scoring::constraints::NamedDihedralConstraint::read_def(), core::scoring::constraints::SequenceProfileConstraint::remap_resid(), core::scoring::constraints::SequenceProfileConstraint::remapped_clone(), core::scoring::constraints::AtomToAxisConstraint::remapped_clone(), core::scoring::constraints::BackboneStubLinearConstraint::score(), core::scoring::constraints::FabConstraint::setup_csts(), core::scoring::constraints::SiteConstraint::setup_csts(), and core::scoring::constraints::NamedAngleConstraint::setup_for_scoring().

◆ tr() [1/4]

static basic::Tracer core::scoring::constraints::tr ( "core.scoring.constraints.BackboneStubConstraint"  )
static

Referenced by core::scoring::constraints::AmbiguousNMRDistanceConstraint::AmbiguousNMRDistanceConstraint(), auto_detect_atoms(), core::scoring::constraints::BackboneStubConstraint::BackboneStubConstraint(), combine_constraints(), combine_NMR_atom_string(), count_constraint(), cull_violators(), core::scoring::constraints::BackboneStubConstraint::fill_f1_f2(), core::scoring::constraints::RTConstraint::fill_f1_f2(), get_cst_fa_file_option(), get_cst_file_option(), core::scoring::constraints::BasePairConstraint::init_subsidiary_constraints(), keep_constraint(), core::scoring::constraints::AmbiguousNMRDistanceConstraint::map_to_CEN(), merge_csts_to_scorefunction(), core::scoring::constraints::ConstraintSet::on_connection_change(), core::scoring::constraints::ConstraintIO::parse_atom_pair_constraint(), core::scoring::constraints::ConstraintIO::parse_coordinate_constraint(), parse_NMR_name_old(), core::scoring::constraints::ConstraintIO::parse_residue(), core::scoring::constraints::ConstraintIO::read_constraints(), core::scoring::constraints::ConstraintIO::read_constraints_new(), core::scoring::constraints::ConstraintIO::read_cst_angles(), core::scoring::constraints::ConstraintIO::read_cst_atom_pairs(), core::scoring::constraints::ConstraintIO::read_cst_bindingsites(), core::scoring::constraints::ConstraintIO::read_cst_coordinates(), core::scoring::constraints::CoordinateConstraint::read_def(), core::scoring::constraints::LocalCoordinateConstraint::read_def(), core::scoring::constraints::BasePairConstraint::read_def(), core::scoring::constraints::MultiConstraint::read_def(), core::scoring::constraints::AmbiguousNMRDistanceConstraint::read_def(), core::scoring::constraints::AtomPairConstraint::read_def(), core::scoring::constraints::NamedAtomPairConstraint::read_def(), core::scoring::constraints::ConstraintIO::read_individual_constraint_new(), core::scoring::constraints::ConstraintSet::remap_residue_positions(), core::scoring::constraints::ConstraintSet::remove_constraint(), core::scoring::constraints::BackboneStubConstraint::score(), core::scoring::constraints::NamedAtomPairConstraint::setup_for_scoring(), skip_redundant_constraints(), and core::scoring::constraints::LocalCoordinateConstraint::xyz_target().

◆ TR() [5/13]

static basic::Tracer core::scoring::constraints::TR ( "core.scoring.constraints.BackboneStubLinearConstraint"  )
static

◆ TR() [6/13]

static basic::Tracer core::scoring::constraints::TR ( "core.scoring.constraints.KofNConstraint"  )
static

◆ TR() [7/13]

static basic::Tracer core::scoring::constraints::TR ( "core.scoring.constraints.MembraneSpanConstraint"  )
static

◆ TR() [8/13]

static basic::Tracer core::scoring::constraints::TR ( "core.scoring.constraints.MembraneSpanTermZConstraint"  )
static

◆ TR() [9/13]

static basic::Tracer core::scoring::constraints::TR ( "core.scoring.constraints.NamedDihedralConstraint"  )
static

◆ TR() [10/13]

static basic::Tracer core::scoring::constraints::TR ( "core.scoring.constraints.ResidueCouplingConstraint"  )
static

◆ TR() [11/13]

static basic::Tracer core::scoring::constraints::TR ( "core.scoring.constraints.ResidueTypeConstraint"  )
static

◆ TR() [12/13]

static basic::Tracer core::scoring::constraints::TR ( "core.scoring.constraints.ResidueTypeLinkingConstraint"  )
static

◆ TR() [13/13]

static basic::Tracer core::scoring::constraints::TR ( "core.scoring.constraints.SequenceProfileConstraint"  )
static

◆ tr() [2/4]

static basic::Tracer core::scoring::constraints::tr ( "core.scoring.constraints.util"  )
static

◆ tr() [3/4]

static basic::Tracer core::scoring::constraints::tr ( "core.scoring.ConstraintsEnergy"  )
static

◆ tr() [4/4]

static basic::Tracer core::scoring::constraints::tr ( "core.scoring.ConstraintSet"  )
static