![]() |
Rosetta Core
2014.35
|
Namespaces | |
dfire | |
Enumerations | |
enum | EnergyMethodType { ci_2b = 1, cd_2b, ci_lr_2b, cd_lr_2b, ci_1b, cd_1b, ws, n_energy_method_types = ws } |
enum | EnergyMethods { etable_method = 1, dunbrack_method, hbond_method, elec_method, mm_lj_energy_inter_method, pair_e_method, reference_e_method, vdw_method, ramachandran_method, n_energy_methods = ramachandran_method } |
enum | LongRangeEnergyType { constraints_lr = 1, gen_born_lr, PB_elec_lr, cart_bonded_lr, rama2b_lr, rna_suite_lr, DFIRE, sym_bonus_lr, elec_dens_energy, elec_dens_fast_energy, elec_dens_cen_energy, elec_dens_allatom_cen_energy, elec_dens_atomwise_energy, patterson_corr_energy, fa_disulfide_energy, disulfide_matching_energy, centroid_disulfide_energy, n_long_range_types = centroid_disulfide_energy } |
Variables | |
static basic::Tracer | TR ("core.scoring.CartesianBondedEnergy") |
static basic::Tracer | GEOMETRIES ("core.scoring.CartesianBondedEnergy.GEOMETRIES") |
static const Real | K_LENGTH =300.0 |
static const Real | K_ANGLE =80.0 |
static const Real | K_TORSION =20.0 |
static const Real | K_TORSION_PROTON =10.0 |
static const Real | K_TORSION_IMPROPER =40.0 |
static basic::Tracer | tr ("core.scoring.methods.CustomAtomPairEnergy") |
static basic::Tracer | TR ("core.scoring.methods.D2H_SA_Energy.cc") |
Distance const | start_sig = 9.8 |
Distance const | end_sig = 10.2 |
DistanceSquared const | start_sig2 = start_sig*start_sig |
DistanceSquared const | end_sig2 = end_sig*end_sig |
core::Real const | envdata [20][40] |
static basic::Tracer | TR ("core.scoring.GoapEnergy") |
Real const | vdw_scale_factor (0.8) |
static basic::Tracer | tr ("core.scoring.LinearChainbreak", basic::t_info) |
static basic::Tracer | TR ("core.scoring.methods.LK_BallEnergy") |
static basic::Tracer | TR ("core.scoring.methods.LK_BallInfo") |
static Real const | optimal_water_distance (2.65) |
static basic::Tracer | TR ("core.mm.MMBondAngleEnergy") |
static basic::Tracer | TR ("core.mm.MMBondLengthEnergy") |
static basic::Tracer | TR ("core.scoring.methods.MMTorsionEnergy") |
static basic::Tracer | TR ("core.scoring.methods.ProQ_Energy.cc") |
static basic::Tracer | TR ("core.scoring.Rama2BOffsetEnergy") |
static basic::Tracer | tr ("core.scoring.methods") |
typedef utility::pointer::access_ptr< CartBondedParameters > core::scoring::methods::CartBondedParametersAP |
typedef utility::pointer::access_ptr< CartBondedParameters const > core::scoring::methods::CartBondedParametersCAP |
typedef utility::pointer::owning_ptr< CartBondedParameters const > core::scoring::methods::CartBondedParametersCOP |
typedef utility::pointer::owning_ptr< CartBondedParameters > core::scoring::methods::CartBondedParametersOP |
typedef utility::pointer::access_ptr< CartesianBondedEnergy > core::scoring::methods::CartesianBondedEnergyAP |
typedef utility::pointer::access_ptr< CartesianBondedEnergy const > core::scoring::methods::CartesianBondedEnergyCAP |
typedef utility::pointer::owning_ptr< CartesianBondedEnergy const > core::scoring::methods::CartesianBondedEnergyCOP |
typedef utility::pointer::owning_ptr< CartesianBondedEnergy > core::scoring::methods::CartesianBondedEnergyOP |
typedef utility::pointer::owning_ptr< ChemicalShiftAnisotropyEnergy > core::scoring::methods::ChemicalShiftAnisotropyEnergyOP |
typedef utility::pointer::owning_ptr< ContextDependentLRTwoBodyEnergy const > core::scoring::methods::ContextDependentLRTwoBodyEnergyCOP |
typedef utility::pointer::owning_ptr< ContextDependentLRTwoBodyEnergy > core::scoring::methods::ContextDependentLRTwoBodyEnergyOP |
typedef utility::pointer::owning_ptr< ContextDependentOneBodyEnergy > core::scoring::methods::ContextDependentOneBodyEnergyOP |
typedef utility::pointer::owning_ptr< ContextDependentTwoBodyEnergy const > core::scoring::methods::ContextDependentTwoBodyEnergyCOP |
typedef utility::pointer::owning_ptr< ContextDependentTwoBodyEnergy > core::scoring::methods::ContextDependentTwoBodyEnergyOP |
typedef utility::pointer::owning_ptr< ContextIndependentLRTwoBodyEnergy const > core::scoring::methods::ContextIndependentLRTwoBodyEnergyCOP |
typedef utility::pointer::owning_ptr< ContextIndependentLRTwoBodyEnergy > core::scoring::methods::ContextIndependentLRTwoBodyEnergyOP |
typedef utility::pointer::owning_ptr< ContextIndependentOneBodyEnergy const > core::scoring::methods::ContextIndependentOneBodyEnergyCOP |
typedef utility::pointer::owning_ptr< ContextIndependentOneBodyEnergy > core::scoring::methods::ContextIndependentOneBodyEnergyOP |
typedef utility::pointer::owning_ptr< ContextIndependentTwoBodyEnergy const > core::scoring::methods::ContextIndependentTwoBodyEnergyCOP |
typedef utility::pointer::owning_ptr< ContextIndependentTwoBodyEnergy > core::scoring::methods::ContextIndependentTwoBodyEnergyOP |
typedef utility::pointer::owning_ptr< CSD_TorsionEnergy const > core::scoring::methods::CSD_TorsionEnergyCOP |
typedef utility::pointer::owning_ptr< CSD_TorsionEnergy > core::scoring::methods::CSD_TorsionEnergyOP |
typedef utility::pointer::owning_ptr< DipolarCouplingEnergy > core::scoring::methods::DipolarCouplingEnergyOP |
typedef utility::pointer::owning_ptr< EnergyMethodCreator const > core::scoring::methods::EnergyMethodCreatorCOP |
typedef utility::pointer::owning_ptr< EnergyMethodCreator > core::scoring::methods::EnergyMethodCreatorOP |
typedef utility::pointer::owning_ptr< EnergyMethodOptions const > core::scoring::methods::EnergyMethodOptionsCOP |
typedef utility::pointer::owning_ptr< EnergyMethodOptions > core::scoring::methods::EnergyMethodOptionsOP |
typedef std::map< std::string, GoapRsdTypeOP > core::scoring::methods::GoapRsdTypeMap |
typedef utility::pointer::access_ptr< IdealParametersDatabase > core::scoring::methods::IdealParametersDatabaseAP |
typedef utility::pointer::access_ptr< IdealParametersDatabase const > core::scoring::methods::IdealParametersDatabaseCAP |
typedef utility::pointer::owning_ptr< IdealParametersDatabase const > core::scoring::methods::IdealParametersDatabaseCOP |
typedef utility::pointer::owning_ptr< IdealParametersDatabase > core::scoring::methods::IdealParametersDatabaseOP |
typedef utility::pointer::owning_ptr< const LKB_ResidueInfo > core::scoring::methods::LKB_ResidueInfoCOP |
typedef utility::pointer::owning_ptr< LKB_ResPairMinData const > core::scoring::methods::LKB_ResPairMinDataCOP |
typedef utility::pointer::owning_ptr< LKB_ResPairMinData > core::scoring::methods::LKB_ResPairMinDataOP |
typedef utility::pointer::owning_ptr< LKB_RotamerSetInfo > core::scoring::methods::LKB_RotamerSetInfoOP |
typedef utility::pointer::owning_ptr< LongRangeTwoBodyEnergy const > core::scoring::methods::LongRangeTwoBodyEnergyCOP |
typedef utility::pointer::owning_ptr< LongRangeTwoBodyEnergy > core::scoring::methods::LongRangeTwoBodyEnergyOP |
typedef std::pair< mm::mm_torsion_atom_quad, core::Real > core::scoring::methods::mm_torsion_atom_quad_angle_pair |
typedef utility::pointer::access_ptr< MMBondAngleEnergy > core::scoring::methods::MMBondAngleEnergyAP |
typedef utility::pointer::access_ptr< MMBondAngleEnergy const > core::scoring::methods::MMBondAngleEnergyCAP |
typedef utility::pointer::owning_ptr< MMBondAngleEnergy const > core::scoring::methods::MMBondAngleEnergyCOP |
typedef utility::pointer::owning_ptr< MMBondAngleEnergy > core::scoring::methods::MMBondAngleEnergyOP |
typedef utility::pointer::access_ptr< MMBondLengthEnergy > core::scoring::methods::MMBondLengthEnergyAP |
typedef utility::pointer::access_ptr< MMBondLengthEnergy const > core::scoring::methods::MMBondLengthEnergyCAP |
typedef utility::pointer::owning_ptr< MMBondLengthEnergy const > core::scoring::methods::MMBondLengthEnergyCOP |
typedef utility::pointer::owning_ptr< MMBondLengthEnergy > core::scoring::methods::MMBondLengthEnergyOP |
typedef utility::pointer::access_ptr< MMLJEnergyInter const > core::scoring::methods::MMLJEnergyInterCAP |
typedef utility::pointer::owning_ptr< MMLJEnergyInter const > core::scoring::methods::MMLJEnergyInterCOP |
typedef utility::pointer::access_ptr< MMLJEnergyIntra const > core::scoring::methods::MMLJEnergyIntraCAP |
typedef utility::pointer::owning_ptr< MMLJEnergyIntra const > core::scoring::methods::MMLJEnergyIntraCOP |
typedef utility::vector1< mm_torsion_atom_quad_angle_pair >::const_iterator core::scoring::methods::mmtaqap_iter |
typedef utility::pointer::access_ptr< MMTorsionEnergy const > core::scoring::methods::MMTorsionEnergyCAP |
typedef utility::pointer::owning_ptr< MMTorsionEnergy const > core::scoring::methods::MMTorsionEnergyCOP |
typedef utility::pointer::owning_ptr< NMerPSSMEnergy const > core::scoring::methods::NMerPSSMEnergyCOP |
typedef utility::pointer::owning_ptr< NMerRefEnergy const > core::scoring::methods::NMerRefEnergyCOP |
typedef utility::pointer::owning_ptr< NMerSVMEnergy const > core::scoring::methods::NMerSVMEnergyCOP |
typedef utility::pointer::owning_ptr< OmegaTetherEnergy const > core::scoring::methods::OmegaTetherEnergyCOP |
typedef utility::pointer::owning_ptr< OmegaTetherEnergy > core::scoring::methods::OmegaTetherEnergyOP |
typedef utility::pointer::owning_ptr< OneBodyEnergy const > core::scoring::methods::OneBodyEnergyCOP |
typedef utility::pointer::owning_ptr< OtherPoseEnergy const > core::scoring::methods::OtherPoseEnergyCOP |
typedef utility::pointer::access_ptr< PBLifetimeCache const > core::scoring::methods::PBLifetimeCacheCAP |
typedef utility::pointer::owning_ptr< PBLifetimeCache const > core::scoring::methods::PBLifetimeCacheCOP |
typedef utility::pointer::access_ptr< PoissonBoltzmannEnergy > core::scoring::methods::PoissonBoltzmannEnergyAP |
typedef utility::pointer::access_ptr< PoissonBoltzmannEnergy const > core::scoring::methods::PoissonBoltzmannEnergyCAP |
typedef utility::pointer::owning_ptr< PoissonBoltzmannEnergy const > core::scoring::methods::PoissonBoltzmannEnergyCOP |
typedef utility::pointer::owning_ptr< PoissonBoltzmannEnergy > core::scoring::methods::PoissonBoltzmannEnergyOP |
typedef utility::pointer::owning_ptr< ProClosureEnergy const > core::scoring::methods::ProClosureEnergyCOP |
typedef utility::pointer::access_ptr< Rama2BOffsetEnergy > core::scoring::methods::Rama2BOffsetEnergyAP |
typedef utility::pointer::access_ptr< Rama2BOffsetEnergy const > core::scoring::methods::Rama2BOffsetEnergyCAP |
typedef utility::pointer::owning_ptr< Rama2BOffsetEnergy const > core::scoring::methods::Rama2BOffsetEnergyCOP |
typedef utility::pointer::owning_ptr< Rama2BOffsetEnergy > core::scoring::methods::Rama2BOffsetEnergyOP |
typedef utility::pointer::owning_ptr< RamachandranEnergy2B const > core::scoring::methods::RamachandranEnergy2BCOP |
typedef utility::pointer::owning_ptr< RamachandranEnergy2B > core::scoring::methods::RamachandranEnergy2BOP |
typedef utility::pointer::owning_ptr< RamachandranEnergy const > core::scoring::methods::RamachandranEnergyCOP |
typedef utility::pointer::owning_ptr< RamachandranEnergy > core::scoring::methods::RamachandranEnergyOP |
typedef utility::pointer::owning_ptr< ReferenceEnergy const > core::scoring::methods::ReferenceEnergyCOP |
typedef utility::pointer::owning_ptr< ReferenceEnergyNoncanonical const > core::scoring::methods::ReferenceEnergyNoncanonicalCOP |
typedef utility::pointer::owning_ptr< ReferenceEnergyNoncanonical > core::scoring::methods::ReferenceEnergyNoncanonicalOP |
typedef utility::pointer::owning_ptr< ResidualDipolarCouplingEnergy > core::scoring::methods::ResidualDipolarCouplingEnergyOP |
typedef utility::pointer::owning_ptr< ResidualDipolarCouplingEnergyRigidSegments > core::scoring::methods::ResidualDipolarCouplingEnergyRigidSegmentsOP |
typedef utility::pointer::access_ptr< ResidueCartBondedParameters > core::scoring::methods::ResidueCartBondedParametersAP |
typedef utility::pointer::access_ptr< ResidueCartBondedParameters const > core::scoring::methods::ResidueCartBondedParametersCAP |
typedef utility::pointer::owning_ptr< ResidueCartBondedParameters const > core::scoring::methods::ResidueCartBondedParametersCOP |
typedef utility::pointer::owning_ptr< ResidueCartBondedParameters > core::scoring::methods::ResidueCartBondedParametersOP |
typedef utility::pointer::owning_ptr< SequenceDependentRefEnergy const > core::scoring::methods::SequenceDependentRefEnergyCOP |
typedef utility::pointer::owning_ptr< SequenceDependentRefEnergy > core::scoring::methods::SequenceDependentRefEnergyOP |
typedef utility::pointer::owning_ptr< ShortRangeTwoBodyEnergy const > core::scoring::methods::ShortRangeTwoBodyEnergyCOP |
typedef utility::pointer::owning_ptr< ShortRangeTwoBodyEnergy > core::scoring::methods::ShortRangeTwoBodyEnergyOP |
typedef utility::pointer::owning_ptr< TwoBodyEnergy const > core::scoring::methods::TwoBodyEnergyCOP |
typedef utility::pointer::owning_ptr< UnfoldedStateEnergy > core::scoring::methods::UnfoldedStateEnergyOP |
typedef utility::pointer::owning_ptr< WaterAdductIntraEnergy > core::scoring::methods::WaterAdductIntraEnergyOP |
typedef utility::pointer::owning_ptr< WholeStructureEnergy > core::scoring::methods::WholeStructureEnergyOP |
typedef utility::pointer::owning_ptr< YHHPlanarityEnergy > core::scoring::methods::YHHPlanarityEnergyOP |
utility::pointer::access_ptr<T> core::scoring::methods::_AP | ( | T & | o | ) |
Referenced by core::scoring::methods::PyContextIndependentTwoBodyEnergy::eval_intrares_energy(), core::scoring::methods::PyContextIndependentTwoBodyEnergy::indicate_required_context_graphs(), core::scoring::methods::PyContextIndependentOneBodyEnergy::residue_energy(), and core::scoring::methods::PyContextIndependentTwoBodyEnergy::residue_pair_energy().
utility::pointer::access_ptr<T const > core::scoring::methods::_CAP | ( | T const & | o | ) |
Referenced by core::scoring::methods::PyContextIndependentTwoBodyEnergy::defines_intrares_energy(), core::scoring::methods::PyContextIndependentTwoBodyEnergy::eval_dof_derivative(), core::scoring::methods::PyContextIndependentTwoBodyEnergy::eval_intrares_energy(), and core::scoring::methods::PyContextIndependentTwoBodyEnergy::residue_pair_energy().
void core::scoring::methods::apply_lk_ball_fraction_weight_for_hbonds | ( | Size const | hatm, |
conformation::Residue const & | don_rsd, | ||
Size const | aatm, | ||
conformation::Residue const & | acc_rsd, | ||
Vector const & | hatm_xyz, | ||
Vector const & | datm_xyz, | ||
Real & | unweighted_energy, | ||
bool const | evaluate_derivative, | ||
hbonds::HBondDerivs & | hbderivs, | ||
Real & | don_fraction, | ||
Real & | acc_fraction | ||
) |
this is a helper function for hbonds
hack to improve geometries of hbonds: apply an additional weighting factor which is used in LK_BallEnergy Do this for sidechain SP2 or Ring acceptors Do this for all sidechain donors
NOTE: also excluding multiple parallel Arg hbonds
References core::conformation::Residue::aa(), core::chemical::aa_arg, core::conformation::Residue::abase2(), core::scoring::hbonds::HBondDerivs::abase2_deriv, core::scoring::hbonds::HBondDerivs::abase_deriv, core::scoring::hbonds::HBondDerivs::acc_deriv, core::conformation::Residue::atom(), core::conformation::Residue::atom_base(), core::conformation::Residue::atom_is_backbone(), core::conformation::Residue::atom_type(), chemical, core::scoring::hbonds::HBondDerivs::don_deriv, numeric::xyzVector< class >::dot(), core::scoring::methods::LK_BallEnergy::eval_lk_ball_fraction_deriv(), core::scoring::DerivVectorPair::f1(), core::scoring::DerivVectorPair::f2(), get_parallel_h_for_arg(), core::scoring::hbonds::HBondDerivs::h_deriv, core::chemical::AtomType::hybridization(), core::conformation::Residue::is_protein(), numeric::conversions::radians(), core::chemical::RING_HYBRID, core::chemical::SP2_HYBRID, core::conformation::Atom::type(), core::conformation::Residue::type(), utility_exit_with_message, and core::conformation::Residue::xyz().
bool core::scoring::methods::atoms_interact | ( | conformation::Residue const & | rsd1, |
conformation::Residue const & | rsd2, | ||
core::id::AtomID const & | id1, | ||
core::id::AtomID const & | id2, | ||
core::Real const | interaction_cutoff | ||
) |
Vector core::scoring::methods::build_optimal_water_O_on_donor | ( | Vector const & | hxyz, |
Vector const & | dxyz | ||
) |
The next two functions were taken from protocols/water/rotamer_building_functions.cc with slight modifications
References optimal_water_distance.
Referenced by setup_water_builders_for_residue_type().
utility::vector1< Vector > core::scoring::methods::build_optimal_water_Os_on_acceptor | ( | Size const | acc_atm, |
conformation::Residue const & | acc_rsd, | ||
Vector const & | a_xyz, | ||
Vector | b1_xyz, | ||
Vector | b2_xyz, | ||
chemical::Hybridization const & | hybrid | ||
) |
References core::conformation::Residue::atom_is_backbone(), core::conformation::Residue::atom_name(), chemical, core::kinematics::distance(), core::conformation::Residue::is_DNA(), optimal_water_distance, numeric::conversions::radians(), radians(), core::chemical::RING_HYBRID, core::chemical::SP2_HYBRID, core::chemical::SP3_HYBRID, core::kinematics::Stub::spherical(), TR, utility_exit, and core::conformation::Residue::xyz().
Referenced by setup_water_builders_for_residue_type().
void core::scoring::methods::compute_and_store_pose_waters | ( | pose::Pose & | pose | ) |
References core::pose::Pose::data(), core::pose::datacache::CacheableDataType::LK_BALL_POSE_INFO, core::pose::Pose::residue(), basic::datacache::BasicDataCache::set(), and core::pose::Pose::total_residue().
Referenced by core::scoring::methods::LK_BallEnergy::setup_for_derivatives(), core::scoring::methods::LK_BallEnergy::setup_for_packing(), and core::scoring::methods::LK_BallEnergy::setup_for_scoring().
|
inline |
ordered!!!! requires pos1<pos2
Referenced by core::scoring::methods::DNA_BaseEnergy::eval_atom_derivative(), and core::scoring::methods::DNA_BaseEnergy::residue_pair_energy().
scoring::etable::count_pair::CPCrossoverBehavior core::scoring::methods::determine_crossover_behavior | ( | conformation::Residue const & | res1, |
conformation::Residue const & | res2, | ||
bool const | use_intra_dna_cp_crossover_4 | ||
) |
HACKY HELPER FXN TAKEN DIRECTLY FROM BaseEtableEnergy.tmpl.hh IF YOU CHANGE THE BEHAVIOR THERE YOU SHOULD CHANGE HERE AS WELL
References core::scoring::etable::count_pair::CP_CROSSOVER_3, core::scoring::etable::count_pair::CP_CROSSOVER_4, core::conformation::Residue::is_DNA(), core::conformation::Residue::is_protein(), core::conformation::Residue::is_RNA(), core::conformation::Residue::polymeric_sequence_distance(), and core::conformation::Residue::seqpos().
Referenced by core::scoring::etable::BaseEtableEnergy< Derived >::backbone_backbone_energy(), core::scoring::etable::BaseEtableEnergy< Derived >::backbone_sidechain_energy(), core::scoring::etable::BaseEtableEnergy< Derived >::bump_energy_backbone(), core::scoring::etable::BaseEtableEnergy< Derived >::bump_energy_full(), core::scoring::etable::BaseEtableEnergy< Derived >::get_count_pair_function(), core::scoring::etable::BaseEtableEnergy< Derived >::get_count_pair_function_trie(), core::scoring::etable::BaseEtableEnergy< Derived >::get_intrares_countpair(), core::scoring::etable::BaseEtableEnergy< Derived >::residue_pair_energy(), core::scoring::methods::LK_BallEnergy::residue_pair_energy(), and core::scoring::etable::BaseEtableEnergy< Derived >::sidechain_sidechain_energy().
std::string const core::scoring::methods::dna_deriv_atom | ( | " C5 " | ) |
the atom through which the knowledge based potential applies a force
Referenced by core::scoring::methods::DNA_BaseEnergy::eval_atom_derivative().
void core::scoring::methods::find_cutpoint_variants | ( | const core::pose::Pose & | pose, |
const core::kinematics::FoldTree & | , | ||
utility::vector1< int > * | cutpoints | ||
) |
References is_lower_cutpoint(), and core::pose::Pose::total_residue().
Referenced by core::scoring::methods::LinearChainbreakEnergy::finalize_total_energy().
core::Real core::scoring::methods::get_residue_weight_by_ss | ( | const char | ss | ) |
std::string core::scoring::methods::get_restag | ( | core::chemical::ResidueType const & | restype | ) |
helper function
References core::chemical::ResidueType::aa(), core::chemical::get_L_equivalent(), core::chemical::is_canonical_D_aa(), core::chemical::ResidueType::is_protein(), core::chemical::ResidueType::name(), core::chemical::ResidueType::name3(), core::chemical::name_from_aa(), and core::chemical::patch_linker.
Referenced by core::scoring::methods::IdealParametersDatabase::lookup_angle(), core::scoring::methods::IdealParametersDatabase::lookup_angle_legacy(), core::scoring::methods::IdealParametersDatabase::lookup_length(), core::scoring::methods::IdealParametersDatabase::lookup_length_legacy(), core::scoring::methods::IdealParametersDatabase::lookup_torsion(), and core::scoring::methods::IdealParametersDatabase::lookup_torsion_legacy().
bool core::scoring::methods::is_lower_cutpoint | ( | core::Size | residue, |
core::pose::Pose const & | pose | ||
) |
References core::chemical::CUTPOINT_LOWER, core::pose::Pose::fold_tree(), core::conformation::Residue::has_variant_type(), core::kinematics::FoldTree::is_cutpoint(), option, and core::pose::Pose::residue().
Referenced by core::scoring::methods::LinearChainbreakEnergy::eval_atom_derivative(), and find_cutpoint_variants().
bool core::scoring::methods::is_upper_cutpoint | ( | core::Size | residue, |
core::pose::Pose const & | pose | ||
) |
bool core::scoring::methods::operator!= | ( | EnergyMethodOptions const & | a, |
EnergyMethodOptions const & | b | ||
) |
used inside ScoreFunctionInfo::operator==
std::ostream & core::scoring::methods::operator<< | ( | std::ostream & | out, |
EnergyMethodOptions const & | options | ||
) |
bool core::scoring::methods::operator== | ( | EnergyMethodOptions const & | a, |
EnergyMethodOptions const & | b | ||
) |
used inside ScoreFunctionInfo::operator==
References core::scoring::methods::EnergyMethodOptions::analytic_etable_evaluation_, core::scoring::methods::EnergyMethodOptions::atom_vdw_atom_type_set_name_, core::scoring::methods::EnergyMethodOptions::bond_angle_central_atoms_to_score_, core::scoring::methods::EnergyMethodOptions::bond_angle_residue_type_param_set_, core::scoring::methods::EnergyMethodOptions::cartbonded_ang_, core::scoring::methods::EnergyMethodOptions::cartbonded_len_, core::scoring::methods::EnergyMethodOptions::cartbonded_linear_, core::scoring::methods::EnergyMethodOptions::cartbonded_proton_, core::scoring::methods::EnergyMethodOptions::cartbonded_tors_, core::scoring::methods::EnergyMethodOptions::cst_max_seq_sep_, core::scoring::methods::EnergyMethodOptions::elec_die_, core::scoring::methods::EnergyMethodOptions::elec_max_dis_, core::scoring::methods::EnergyMethodOptions::elec_min_dis_, core::scoring::methods::EnergyMethodOptions::elec_no_dis_dep_die_, core::scoring::methods::EnergyMethodOptions::etable_options_, core::scoring::methods::EnergyMethodOptions::etable_type_, core::scoring::methods::EnergyMethodOptions::exclude_DNA_DNA_, core::scoring::methods::EnergyMethodOptions::exclude_monomer_fa_elec_, core::scoring::methods::EnergyMethodOptions::exclude_protein_protein_fa_elec_, core::scoring::methods::EnergyMethodOptions::hbond_options_, core::scoring::methods::EnergyMethodOptions::intrares_elec_correction_scale_, core::scoring::methods::EnergyMethodOptions::method_weights_, core::scoring::methods::EnergyMethodOptions::pb_bound_tag_, core::scoring::methods::EnergyMethodOptions::pb_unbound_tag_, core::scoring::methods::EnergyMethodOptions::smooth_fa_elec_, core::scoring::methods::EnergyMethodOptions::ss_weights_, and core::scoring::methods::EnergyMethodOptions::unfolded_energies_type_.
bool core::scoring::methods::residues_interact | ( | conformation::Residue const & | rsd1, |
conformation::Residue const & | rsd2, | ||
core::Real const | interaction_cutoff | ||
) |
|
inline |
same as dna::retrieve_base_partner_from_pose
References core::pose::datacache::CacheableDataType::BASE_PARTNER, core::pose::Pose::data(), basic::datacache::BasicDataCache::get(), and basic::datacache::BasicDataCache::has().
Referenced by core::scoring::methods::DNA_BaseEnergy::eval_atom_derivative(), and core::scoring::methods::DNA_BaseEnergy::residue_pair_energy().
|
inline |
|
inline |
|
inline |
|
inline |
References core::pose::Pose::data(), basic::datacache::BasicDataCache::get(), and core::pose::datacache::CacheableDataType::LK_BALL_POSE_INFO.
Referenced by core::scoring::methods::LK_BallEnergy::evaluate_rotamer_background_energies(), and core::scoring::methods::LK_BallEnergy::residue_pair_energy().
|
inline |
inline retrieval functions here:
References core::conformation::RotamerSetBase::data(), basic::datacache::BasicDataCache::get(), and core::conformation::RotamerSetCacheableDataType::LK_BALL_ROTAMER_SET_INFO.
Referenced by core::scoring::methods::LK_BallEnergy::evaluate_rotamer_background_energies(), and core::scoring::methods::LK_BallEnergy::evaluate_rotamer_pair_energies().
|
inline |
|
inline |
References core::scoring::ResSingleMinimizationData::get_data(), core::scoring::lkb_res_data, and core::scoring::ResSingleMinimizationData::set_data().
Referenced by core::scoring::methods::LK_BallEnergy::setup_for_minimizing_for_residue(), and core::scoring::methods::LK_BallEnergy::setup_for_scoring_for_residue().
|
inline |
void core::scoring::methods::setup_water_builders_for_residue_type | ( | ResidueType const & | rsd_type, |
bool const | sidechain_only, | ||
utility::vector1< WaterBuilders > & | rsd_water_builders | ||
) |
References core::conformation::Residue::abase2(), core::conformation::Residue::accpt_pos(), core::conformation::Residue::atom_base(), core::chemical::ResidueType::atom_is_backbone(), core::chemical::ResidueType::atom_name(), core::conformation::Residue::atom_name(), core::conformation::Residue::atom_type(), core::chemical::ResidueType::atom_type(), build_optimal_water_O_on_donor(), build_optimal_water_Os_on_acceptor(), chain, core::conformation::Residue::chain(), chemical, core::conformation::ResidueFactory::create_residue(), core::io::pdb::dump_pdb_residue(), core::chemical::element::F, core::conformation::Residue::Hpos_polar(), core::chemical::AtomType::hybridization(), core::chemical::element::I, core::chemical::ResidueType::name(), core::conformation::Residue::name(), core::conformation::Residue::name3(), core::chemical::ResidueType::natoms(), out, core::conformation::Residue::seqpos(), core::chemical::SP3_HYBRID, TR, water, and core::conformation::Residue::xyz().
Referenced by core::scoring::methods::LKB_ResidueInfo::initialize_residue_type().
void core::scoring::methods::swap_seqpos | ( | core::Size & | seqpos1, |
core::Size & | seqpos2 | ||
) |
Distance const core::scoring::methods::end_sig = 10.2 |
Referenced by core::scoring::methods::EnvSmoothEnergy::increment_f1_f2_for_atom_pair(), core::scoring::methods::MembraneEnvSmoothEnergy::increment_f1_f2_for_atom_pair(), core::scoring::methods::EnvSmoothEnergy::sigmoidish_neighbor(), and core::scoring::methods::MembraneEnvSmoothEnergy::sigmoidish_neighbor().
DistanceSquared const core::scoring::methods::end_sig2 = end_sig*end_sig |
Referenced by core::scoring::methods::EnvSmoothEnergy::increment_f1_f2_for_atom_pair(), core::scoring::methods::MembraneEnvSmoothEnergy::increment_f1_f2_for_atom_pair(), core::scoring::methods::EnvSmoothEnergy::sigmoidish_neighbor(), and core::scoring::methods::MembraneEnvSmoothEnergy::sigmoidish_neighbor().
core::Real const core::scoring::methods::envdata[20][40] |
core::Real envdata[20][40] = { { 0.215, 0.211, 0.199, 0.184, 0.168, 0.155, 0.152, 0.152, 0.156, 0.154, 0.161, 0.187, 0.222, 0.264, 0.290, 0.306, 0.290, 0.254, 0.191, 0.117, 0.037, -0.032, -0.098, -0.162, -0.241, -0.318, -0.393, -0.467, -0.547, -0.634, -0.721, -0.807, -0.894, -0.989, -1.089, -1.179, -1.241, -1.273, -1.282, -1.284 }, {1.947, 1.943, 1.936, 1.933, 1.932, 1.937, 1.934, 1.916, 1.842, 1.699, 1.509, 1.313, 1.124, 0.940, 0.740, 0.561, 0.369, 0.196, 0.008, -0.147, -0.277, -0.371, -0.448, -0.510, -0.567, -0.606, -0.644, -0.669, -0.700, -0.721, -0.734, -0.744, -0.758, -0.810, -0.867, -0.933, -0.976, -1.027, -1.064, -1.088 }, {-0.935, -0.923, -0.892, -0.847, -0.798, -0.752, -0.713, -0.668, -0.620, -0.564, -0.514, -0.466, -0.416, -0.351, -0.272, -0.172, -0.068, 0.043, 0.147, 0.264, 0.391, 0.526, 0.643, 0.741, 0.816, 0.863, 0.884, 0.886, 0.888, 0.900, 0.925, 0.951, 0.972, 0.983, 0.991, 0.997, 1.006, 1.013, 1.016, 1.016 }, {-0.286, -0.309, -0.346, -0.398, -0.442, -0.506, -0.562, -0.624, -0.652, -0.651, -0.620, -0.582, -0.534, -0.469, -0.377, -0.262, -0.129, 0.021, 0.190, 0.372, 0.561, 0.736, 0.907, 1.060, 1.204, 1.310, 1.389, 1.440, 1.473, 1.492, 1.509, 1.540, 1.573, 1.602, 1.615, 1.621, 1.619, 1.618, 1.616, 1.617 }, { 0.760, 0.762, 0.772, 0.798, 0.863, 0.966, 1.085, 1.168, 1.192, 1.167, 1.104, 1.016, 0.896, 0.744, 0.566, 0.361, 0.166, -0.008, -0.149, -0.271, -0.371, -0.441, -0.476, -0.484, -0.470, -0.442, -0.400, -0.349, -0.277, -0.158, 0.009, 0.199, 0.353, 0.450, 0.497, 0.519, 0.533, 0.541, 0.548, 0.551 }, {-0.041, -0.050, -0.056, -0.055, -0.037, -0.028, -0.029, -0.051, -0.076, -0.096, -0.104, -0.106, -0.098, -0.078, -0.040, 0.007, 0.049, 0.080, 0.099, 0.120, 0.134, 0.150, 0.153, 0.150, 0.126, 0.072, -0.006, -0.104, -0.214, -0.341, -0.464, -0.579, -0.678, -0.788, -0.888, -1.000, -1.133, -1.311, -1.489, -1.579 }, { 0.020, 0.018, 0.016, 0.013, 0.018, 0.044, 0.088, 0.140, 0.172, 0.181, 0.166, 0.137, 0.092, 0.033, -0.036, -0.104, -0.151, -0.179, -0.177, -0.159, -0.116, -0.062, -0.007, 0.040, 0.087, 0.128, 0.172, 0.209, 0.242, 0.263, 0.272, 0.277, 0.279, 0.282, 0.280, 0.275, 0.270, 0.271, 0.278, 0.284 }, { 1.167, 1.170, 1.178, 1.193, 1.230, 1.270, 1.315, 1.326, 1.309, 1.247, 1.151, 1.038, 0.899, 0.746, 0.577, 0.407, 0.244, 0.091, -0.041, -0.159, -0.262, -0.362, -0.449, -0.517, -0.551, -0.557, -0.543, -0.514, -0.468, -0.401, -0.331, -0.268, -0.190, -0.082, 0.046, 0.144, 0.200, 0.224, 0.238, 0.244 }, {-0.026, -0.049, -0.092, -0.150, -0.214, -0.289, -0.359, -0.416, -0.456, -0.488, -0.510, -0.519, -0.508, -0.481, -0.438, -0.377, -0.282, -0.154, 0.018, 0.226, 0.454, 0.683, 0.908, 1.122, 1.328, 1.497, 1.638, 1.730, 1.800, 1.870, 1.969, 2.081, 2.168, 2.219, 2.244, 2.260, 2.266, 2.262, 2.254, 2.249 }, { 1.128, 1.132, 1.141, 1.156, 1.178, 1.212, 1.251, 1.270, 1.244, 1.167, 1.060, 0.936, 0.791, 0.624, 0.449, 0.281, 0.131, -0.007, -0.130, -0.242, -0.333, -0.406, -0.452, -0.476, -0.471, -0.444, -0.396, -0.323, -0.229, -0.120, -0.010, 0.108, 0.222, 0.374, 0.552, 0.783, 0.986, 1.139, 1.208, 1.232 }, { 0.756, 0.758, 0.766, 0.784, 0.807, 0.841, 0.874, 0.914, 0.910, 0.867, 0.766, 0.668, 0.557, 0.452, 0.333, 0.230, 0.133, 0.053, -0.028, -0.097, -0.169, -0.238, -0.317, -0.381, -0.423, -0.438, -0.443, -0.434, -0.423, -0.388, -0.387, -0.381, -0.412, -0.418, -0.438, -0.445, -0.454, -0.461, -0.466, -0.471 }, {-0.510, -0.515, -0.528, -0.545, -0.569, -0.579, -0.568, -0.513, -0.457, -0.397, -0.361, -0.322, -0.290, -0.250, -0.206, -0.152, -0.083, -0.006, 0.081, 0.162, 0.246, 0.327, 0.404, 0.462, 0.502, 0.529, 0.548, 0.561, 0.567, 0.576, 0.582, 0.594, 0.606, 0.621, 0.634, 0.645, 0.653, 0.662, 0.670, 0.675 }, {-1.240, -1.229, -1.194, -1.123, -1.022, -0.910, -0.810, -0.720, -0.620, -0.510, -0.394, -0.296, -0.204, -0.126, -0.054, -0.002, 0.042, 0.083, 0.137, 0.191, 0.247, 0.302, 0.359, 0.408, 0.430, 0.431, 0.409, 0.383, 0.354, 0.342, 0.336, 0.335, 0.338, 0.348, 0.360, 0.365, 0.370, 0.375, 0.380, 0.383 }, {-0.072, -0.067, -0.061, -0.055, -0.050, -0.066, -0.103, -0.174, -0.242, -0.309, -0.354, -0.386, -0.390, -0.372, -0.337, -0.284, -0.220, -0.130, -0.028, 0.099, 0.227, 0.361, 0.488, 0.602, 0.704, 0.786, 0.852, 0.898, 0.947, 1.006, 1.083, 1.158, 1.240, 1.335, 1.446, 1.548, 1.633, 1.702, 1.766, 1.796 }, { 0.190, 0.188, 0.183, 0.177, 0.177, 0.173, 0.154, 0.111, 0.047, -0.032, -0.119, -0.200, -0.271, -0.324, -0.358, -0.363, -0.346, -0.297, -0.213, -0.097, 0.039, 0.189, 0.352, 0.519, 0.681, 0.831, 0.982, 1.116, 1.252, 1.380, 1.509, 1.606, 1.668, 1.699, 1.713, 1.719, 1.720, 1.720, 1.720, 1.720 }, {-0.321, -0.323, -0.327, -0.338, -0.351, -0.365, -0.371, -0.367, -0.350, -0.321, -0.283, -0.237, -0.186, -0.129, -0.072, -0.019, 0.030, 0.076, 0.121, 0.163, 0.202, 0.233, 0.252, 0.258, 0.249, 0.224, 0.179, 0.118, 0.056, 0.000, -0.057, -0.112, -0.159, -0.184, -0.196, -0.203, -0.211, -0.216, -0.220, -0.221 }, { 0.073, 0.073, 0.073, 0.073, 0.073, 0.073, 0.066, 0.039, -0.004, -0.058, -0.102, -0.136, -0.149, -0.149, -0.139, -0.121, -0.087, -0.039, 0.020, 0.073, 0.124, 0.164, 0.197, 0.209, 0.199, 0.163, 0.118, 0.066, 0.015, -0.038, -0.083, -0.120, -0.147, -0.167, -0.182, -0.190, -0.197, -0.202, -0.206, -0.208 }, { 1.137, 1.138, 1.138, 1.142, 1.143, 1.148, 1.145, 1.133, 1.094, 1.027, 0.942, 0.838, 0.729, 0.608, 0.489, 0.367, 0.253, 0.143, 0.036, -0.078, -0.183, -0.277, -0.353, -0.422, -0.482, -0.532, -0.569, -0.589, -0.592, -0.588, -0.577, -0.573, -0.567, -0.577, -0.585, -0.599, -0.602, -0.606, -0.605, -0.605 }, { 1.430, 1.430, 1.430, 1.413, 1.374, 1.311, 1.240, 1.182, 1.134, 1.088, 1.022, 0.916, 0.773, 0.597, 0.407, 0.228, 0.051, -0.097, -0.239, -0.340, -0.410, -0.431, -0.428, -0.408, -0.381, -0.336, -0.263, -0.153, -0.014, 0.128, 0.247, 0.357, 0.474, 0.607, 0.729, 0.823, 0.877, 0.902, 0.912, 0.917 }, { 1.037, 1.040, 1.046, 1.051, 1.051, 1.051, 1.050, 1.047, 1.021, 0.973, 0.896, 0.804, 0.684, 0.534, 0.362, 0.182, 0.018, -0.133, -0.254, -0.343, -0.397, -0.422, -0.424, -0.396, -0.343, -0.263, -0.178, -0.068, 0.049, 0.200, 0.367, 0.550, 0.725, 0.874, 0.991, 1.067, 1.115, 1.142, 1.158, 1.165 } };
Referenced by core::scoring::methods::EnvSmoothEnergy::calc_energy().
|
static |
|
static |
|
static |
|
static |
|
static |
|
static |
|
static |
Referenced by build_optimal_water_O_on_donor(), and build_optimal_water_Os_on_acceptor().
Distance const core::scoring::methods::start_sig = 9.8 |
Referenced by core::scoring::methods::EnvSmoothEnergy::increment_f1_f2_for_atom_pair(), core::scoring::methods::MembraneEnvSmoothEnergy::increment_f1_f2_for_atom_pair(), core::scoring::methods::EnvSmoothEnergy::sigmoidish_neighbor(), and core::scoring::methods::MembraneEnvSmoothEnergy::sigmoidish_neighbor().
DistanceSquared const core::scoring::methods::start_sig2 = start_sig*start_sig |
Referenced by core::scoring::methods::EnvSmoothEnergy::increment_f1_f2_for_atom_pair(), core::scoring::methods::MembraneEnvSmoothEnergy::increment_f1_f2_for_atom_pair(), core::scoring::methods::EnvSmoothEnergy::sigmoidish_neighbor(), and core::scoring::methods::MembraneEnvSmoothEnergy::sigmoidish_neighbor().
|
static |
|
static |
|
static |
|
static |
|
static |
|
static |
Referenced by core::scoring::methods::LinearChainbreakEnergy::do_score_ovp(), core::scoring::methods::ResidualDipolarCouplingEnergy::eval_dipolar(), core::scoring::methods::DistanceChainbreakEnergy::finalize_total_energy(), core::scoring::methods::LinearChainbreakEnergy::finalize_total_energy(), get_residue_weight_by_ss(), core::scoring::methods::ResidualDipolarCouplingEnergy::setup_for_minimizing(), core::scoring::methods::ResidualDipolarCouplingEnergyRigidSegments::setup_for_minimizing(), and core::scoring::methods::CustomAtomPairEnergy::setup_for_scoring().
|
static |
|
static |
|
static |
|
static |
|
static |
|
static |
|
static |
Referenced by build_optimal_water_Os_on_acceptor(), core::scoring::methods::D2H_SA_Energy::D2H_SA_Energy(), core::scoring::methods::CartesianBondedEnergy::eval_improper_torsions(), core::scoring::methods::CartesianBondedEnergy::eval_interresidue_angle_energies_two_from_rsd1(), core::scoring::methods::CartesianBondedEnergy::eval_interresidue_angle_energies_two_from_rsd2(), core::scoring::methods::CartesianBondedEnergy::eval_interresidue_bond_energy(), core::scoring::methods::MMTorsionEnergy::eval_intrares_energy(), core::scoring::methods::MMBondLengthEnergy::eval_intrares_energy(), core::scoring::methods::MMBondAngleEnergy::eval_intrares_energy(), core::scoring::methods::CartesianBondedEnergy::eval_singleres_angle_energies(), core::scoring::methods::CartesianBondedEnergy::eval_singleres_improper_torsion_energies(), core::scoring::methods::CartesianBondedEnergy::eval_singleres_length_energies(), core::scoring::methods::CartesianBondedEnergy::eval_singleres_torsion_energies(), core::scoring::methods::D2H_SA_Energy::finalize_total_energy(), core::scoring::methods::ProQ_Energy::finalize_total_energy(), core::scoring::methods::IdealParametersDatabase::init(), core::scoring::methods::ProQ_Energy::initialize(), core::scoring::methods::LKB_ResidueInfo::initialize_residue_type(), core::scoring::methods::IdealParametersDatabase::lookup_angle(), core::scoring::methods::IdealParametersDatabase::lookup_length(), core::scoring::methods::NMerSVMEnergy::read_aa_encoding_matrix(), core::scoring::methods::IdealParametersDatabase::read_angle_database(), core::scoring::methods::GoapEnergy::read_angle_definitions(), core::scoring::methods::IdealParametersDatabase::read_length_database(), core::scoring::methods::NMerPSSMEnergy::read_nmer_pssm(), core::scoring::methods::NMerPSSMEnergy::read_nmer_pssm_list(), core::scoring::methods::NMerPSSMEnergy::read_nmer_pssms_from_options(), core::scoring::methods::NMerSVMEnergy::read_nmer_svm(), core::scoring::methods::NMerSVMEnergy::read_nmer_svm_list(), core::scoring::methods::NMerSVMEnergy::read_nmer_svms_from_options(), core::scoring::methods::NMerRefEnergy::read_nmer_table(), core::scoring::methods::NMerRefEnergy::read_nmer_table_list(), core::scoring::methods::NMerRefEnergy::read_nmer_tables_from_options(), core::scoring::methods::GoapEnergy::read_potential_values(), core::scoring::methods::ProQ_Energy::read_profiles_and_entropy(), core::scoring::methods::IdealParametersDatabase::read_torsion_database(), core::scoring::methods::MMTorsionEnergy::residue_pair_energy(), core::scoring::methods::MMBondLengthEnergy::residue_pair_energy(), core::scoring::methods::MMBondAngleEnergy::residue_pair_energy(), core::scoring::methods::LKB_ResidueInfo::setup_atom_weights(), core::scoring::methods::LK_BallEnergy::setup_d2_bounds(), core::scoring::methods::PoissonBoltzmannEnergy::setup_for_scoring(), core::scoring::methods::GoapEnergy::setup_for_scoring(), core::scoring::methods::CartesianBondedEnergy::setup_for_scoring(), setup_water_builders_for_residue_type(), and core::scoring::methods::UnfoldedStateEnergy::UnfoldedStateEnergy().
Real const core::scoring::methods::vdw_scale_factor(0.8) |