Rosetta
|
#include <protocols/frags/VallData.fwd.hh>
#include <core/fragment/ConstantLengthFragSet.hh>
#include <core/fragment/FragSet.hh>
#include <core/fragment/Frame.hh>
#include <core/fragment/picking_old/vall/util.hh>
#include <core/scoring/methods/Methods.hh>
#include <core/scoring/ScoreType.hh>
#include <core/scoring/EnergyGraph.hh>
#include <protocols/simple_moves/BackboneMover.hh>
#include <protocols/minimization_packing/MinMover.hh>
#include <protocols/moves/MonteCarlo.hh>
#include <protocols/moves/MoverContainer.hh>
#include <protocols/minimization_packing/PackRotamersMover.hh>
#include <protocols/minimization_packing/RotamerTrialsMover.hh>
#include <protocols/simple_moves/FragmentMover.hh>
#include <protocols/viewer/viewers.hh>
#include <core/types.hh>
#include <core/chemical/AA.hh>
#include <core/conformation/Residue.hh>
#include <core/chemical/ResidueTypeSet.hh>
#include <core/conformation/ResidueFactory.hh>
#include <core/conformation/util.hh>
#include <core/chemical/VariantType.hh>
#include <core/chemical/ChemicalManager.fwd.hh>
#include <core/scoring/rms_util.hh>
#include <core/scoring/ScoreFunction.hh>
#include <core/scoring/ScoreFunctionFactory.hh>
#include <core/pack/task/PackerTask.hh>
#include <core/pack/task/TaskFactory.hh>
#include <core/pack/task/operation/TaskOperations.hh>
#include <protocols/toolbox/IGEdgeReweighters.hh>
#include <core/pack/task/IGEdgeReweightContainer.hh>
#include <core/kinematics/FoldTree.hh>
#include <core/kinematics/MoveMap.hh>
#include <core/pose/Pose.hh>
#include <core/pose/variant_util.hh>
#include <core/pose/PDBInfo.hh>
#include <core/pose/metrics/CalculatorFactory.hh>
#include <basic/options/util.hh>
#include <basic/MetricValue.hh>
#include <devel/init.hh>
#include <utility/vector1.hh>
#include <utility/file/file_sys_util.hh>
#include <numeric/random/random.hh>
#include <core/scoring/func/FlatHarmonicFunc.hh>
#include <core/scoring/constraints/CoordinateConstraint.hh>
#include <cstdlib>
#include <fstream>
#include <string>
#include <basic/Tracer.hh>
#include <basic/options/keys/in.OptionKeys.gen.hh>
#include <basic/options/keys/out.OptionKeys.gen.hh>
#include <basic/options/keys/score.OptionKeys.gen.hh>
#include <basic/options/keys/pepspec.OptionKeys.gen.hh>
#include <basic/options/keys/constraints.OptionKeys.gen.hh>
#include <protocols/pose_metric_calculators/DecomposeAndReweightEnergiesCalculator.hh>
#include <protocols/pose_metric_calculators/ResidueDecompositionByChainCalculator.hh>
#include <core/pose/metrics/simple_calculators/InterfaceNeighborDefinitionCalculator.hh>
#include <core/pose/metrics/simple_calculators/InterfaceSasaDefinitionCalculator.hh>
#include <core/pose/metrics/simple_calculators/InterfaceDeltaEnergeticsCalculator.hh>
#include <core/import_pose/import_pose.hh>
#include <core/util/SwitchResidueTypeSet.hh>
#include <utility/excn/Exceptions.hh>
#include <core/pose/init_id_map.hh>
#include <core/pose/util.hh>
#include <core/scoring/Energies.hh>
#include <basic/options/option.hh>
#include <core/kinematics/RT.hh>
Classes | |
struct | pep_coord_cst |
class | myMC |
Functions | |
Size | prot_chain (0) |
Size | prot_begin (0) |
Size | prot_anchor (0) |
Size | prot_end (0) |
Size | pep_jump (2) |
Size | pep_chain (0) |
Size | pep_begin (0) |
Size | pep_anchor (0) |
Size | pep_end (0) |
Size | aa2index (chemical::AA aa) |
Size | get_n_pep_nbrs (pose::Pose const &pose, vector1< bool > const is_pep, Real const cutoff_cg) |
void | make_sequence_change (Size const seqpos, AA const &new_aa, pose::Pose &pose) |
bool | has_clash (pose::Pose pose, vector1< bool > is_checked, scoring::ScoreFunctionOP const &scorefxn, Real const clash_threshold) |
vector1< std::pair< Size, Size > > | get_clash_pairs (pose::Pose pose, vector1< bool > is_checked, scoring::ScoreFunctionOP const &scorefxn, Real const clash_threshold) |
std::string | pep_rmsd_analysis (pose::Pose pose) |
std::string | pep_phipsi_analysis (pose::Pose pose) |
void | add_termini (pose::Pose &pose) |
void | add_pep_res (pose::Pose &pose, bool add_nterm, bool add_cterm) |
void | remove_pep_res (pose::Pose &pose, bool add_nterm, bool add_cterm) |
void | initialize_peptide (pose::Pose &pose) |
void | set_pep_csts (pose::Pose &pose) |
core::fragment::FragSetCOP | make_frags (core::Size const start, core::Size const stop, std::string const &seq) |
helper code for fragments generation, copied from S.M.Lewis More... | |
core::fragment::FragSetCOP | make_1mer_frags (core::Size const seqpos_start, core::Size const seqpos_stop, std::string const &seq, Size const nfrags) |
void | gen_pep_bb_sequential (pose::Pose &pose, scoring::ScoreFunctionOP cen_scorefxn) |
void | perturb_pep_bb (pose::Pose &pose, kinematics::MoveMapOP mm_move, scoring::ScoreFunctionOP cen_scorefxn, Size n_iter) |
void | mutate_random_residue (Pose &pose, vector1< bool > is_mutable, ScoreFunctionOP soft_scorefxn, ScoreFunctionOP full_scorefxn) |
void | packmin_unbound_pep (pose::Pose &pose, scoring::ScoreFunctionOP full_scorefxn) |
Real | get_binding_score (Pose pose, Size pep_chain, ScoreFunctionOP full_scorefxn) |
void | print_pep_analysis (std::string pdb_name, std::fstream &out_file, Pose pose, Real prot_score, ScoreFunctionOP full_scorefxn, bool dump_pdb) |
void | RunPepSpec () |
void * | my_main (void *) |
int | main (int argc, char *argv[]) |
Variables | |
static basic::Tracer | TR ("apps.public.pepspec") |
std::string | input_seq |
vector1< pep_coord_cst > | pep_coord_csts |
Size aa2index | ( | chemical::AA | aa | ) |
References aa, enumerate_junctions::default, and ObjexxFCL::index().
void add_pep_res | ( | pose::Pose & | pose, |
bool | add_nterm, | ||
bool | add_cterm | ||
) |
References add_termini(), pep_anchor(), pep_begin(), pep_end(), and beta_nonlocal::pose.
void add_termini | ( | pose::Pose & | pose | ) |
References pep_begin(), pep_end(), and beta_nonlocal::pose.
void gen_pep_bb_sequential | ( | pose::Pose & | pose, |
scoring::ScoreFunctionOP | cen_scorefxn | ||
) |
References create_a3b_hbs::best_score, pepspec::cg_res_type(), basic::options::OptionKeys::pepspec::cg_res_type, check_clash(), pepspec::clash_cutoff(), basic::options::OptionKeys::pepspec::clash_cutoff, clash_score(), utility::graph::Node::const_edge_list_end(), basic::options::OptionKeys::constraints::cst_weight, test.Workshop4test::fragset, pepspec::gen_pep_bb_sequential(), get_clash_pairs(), utility::graph::Edge::get_node(), has_clash(), pepspec::homol_csts(), create_a3b_hbs::i, create_a3b_hbs::ii, input_seq, pepspec::input_seq(), make_1mer_frags(), make_sequence_change(), max(), SmotifHasher::min_score, basic::options::OptionKeys::MonteCarlo::MonteCarlo, pepspec::n_append(), basic::options::OptionKeys::pepspec::n_append, pepspec::n_build_loop(), basic::options::OptionKeys::pepspec::n_build_loop, pepspec::n_prepend(), basic::options::OptionKeys::pepspec::n_prepend, basic::options::OptionKeys::ddg::nfrags, pepspec::no_cen_rottrials(), option, pep_anchor(), pep_begin(), pep_end(), beta_nonlocal::pose, prot_begin(), prot_end(), res, numeric::random::rg(), basic::options::OptionKeys::frags::scoring::scoring, set_pep_csts(), pna::test_score, numeric::random::RandomGenerator::uniform(), pepspec::use_input_bb(), basic::options::OptionKeys::inout::dbms::user, and basic::options::OptionKeys::remodel::vdw.
References packmin_unbound_pep(), pep_chain(), and beta_nonlocal::pose.
Size get_n_pep_nbrs | ( | pose::Pose const & | pose, |
vector1< bool > const | is_pep, | ||
Real const | cutoff_cg | ||
) |
bool has_clash | ( | pose::Pose | pose, |
vector1< bool > | is_checked, | ||
scoring::ScoreFunctionOP const & | scorefxn, | ||
Real const | clash_threshold | ||
) |
void initialize_peptide | ( | pose::Pose & | pose | ) |
References pepspec::cg_res_type(), basic::options::OptionKeys::pepspec::cg_res_type, pepspec::input_seq(), make_sequence_change(), pepspec::no_design(), option, pep_anchor(), pep_begin(), pep_end(), beta_nonlocal::pose, prot_anchor(), prot_chain(), pepspec::remove_input_bb(), res, test.T200_Scoring::rsd1, test.T200_Scoring::rsd2, pepspec::use_input_bb(), and basic::options::OptionKeys::inout::dbms::user.
int main | ( | int | argc, |
char * | argv[] | ||
) |
References argv, test.T009_Exceptions::e, basic::Tracer::flush(), basic::init(), my_main(), TR, and viewer_main().
core::fragment::FragSetCOP make_1mer_frags | ( | core::Size const | seqpos_start, |
core::Size const | seqpos_stop, | ||
std::string const & | seq, | ||
Size const | nfrags | ||
) |
References test.Workshop4test::fragset, numeric::kinematic_closure::frame(), pepspec::input_seq(), create_a3b_hbs::j, basic::options::OptionKeys::in::file::list, basic::options::OptionKeys::ddg::nfrags, option, numeric::random::rg(), beta_sc_scan::seq, pepspec::ss_type(), numeric::random::uniform(), and basic::options::OptionKeys::inout::dbms::user.
core::fragment::FragSetCOP make_frags | ( | core::Size const | start, |
core::Size const | stop, | ||
std::string const & | seq | ||
) |
helper code for fragments generation, copied from S.M.Lewis
References test.Workshop4test::fragset, numeric::kinematic_closure::frame(), create_a3b_hbs::j, basic::options::OptionKeys::in::file::list, beta_sc_scan::seq, and basic::options::OptionKeys::cutoutdomain::start.
void make_sequence_change | ( | Size const | seqpos, |
AA const & | new_aa, | ||
pose::Pose & | pose | ||
) |
This function will make a sequence mutation while trying to preserve the variants
References beta_nonlocal::pose, and TR.
void mutate_random_residue | ( | Pose & | pose, |
vector1< bool > | is_mutable, | ||
ScoreFunctionOP | soft_scorefxn, | ||
ScoreFunctionOP | full_scorefxn | ||
) |
References utility::graph::Node::const_edge_list_end(), debug_assert, utility::graph::Edge::get_node(), create_a3b_hbs::i, make_sequence_change(), vancomycin::min_mover, basic::options::OptionKeys::mutate::mutate, pep_anchor(), beta_nonlocal::pose, numeric::random::rg(), numeric::random::uniform(), and numeric::random::RandomGenerator::uniform().
void* my_main | ( | void * | ) |
References utility::options::OptionKeys::options::exit, and RunPepSpec().
void packmin_unbound_pep | ( | pose::Pose & | pose, |
scoring::ScoreFunctionOP | full_scorefxn | ||
) |
References vancomycin::min_mover, beta_nonlocal::mm, vancomycin::pack, beta_nonlocal::pose, and vancomycin::task.
Size pep_anchor | ( | 0 | ) |
Size pep_begin | ( | 0 | ) |
Size pep_chain | ( | 0 | ) |
Size pep_end | ( | 0 | ) |
Size pep_jump | ( | 2 | ) |
std::string pep_phipsi_analysis | ( | pose::Pose | pose | ) |
References ObjexxFCL::abs(), in::file::native(), pepspec::native_pep_anchor(), pepspec::native_pep_chain(), basic::options::OptionKeys::AnchoredDesign::filters::omega, option, pepspec::pep_anchor(), pep_anchor(), pep_begin(), pepspec::pep_chain(), pep_end(), oop_conformations::phi, beta_nonlocal::pose, pyrosetta.distributed.io::pose_from_file, oop_conformations::psi, ObjexxFCL::string_of(), and basic::options::OptionKeys::inout::dbms::user.
std::string pep_rmsd_analysis | ( | pose::Pose | pose | ) |
References create_a3b_hbs::i, in::file::native(), pepspec::native_align(), pepspec::native_pep_anchor(), pepspec::native_pep_chain(), num_chains(), option, pepspec::pep_anchor(), pep_anchor(), pep_begin(), pepspec::pep_chain(), pep_end(), beta_nonlocal::pose, pyrosetta.distributed.io::pose_from_file, prot_begin(), prot_end(), basic::options::OptionKeys::pepspec::rmsd_analysis, sd(), ObjexxFCL::string_of(), superimpose_pose(), and basic::options::OptionKeys::inout::dbms::user.
void perturb_pep_bb | ( | pose::Pose & | pose, |
kinematics::MoveMapOP | mm_move, | ||
scoring::ScoreFunctionOP | cen_scorefxn, | ||
Size | n_iter | ||
) |
void print_pep_analysis | ( | std::string | pdb_name, |
std::fstream & | out_file, | ||
Pose | pose, | ||
Real | prot_score, | ||
ScoreFunctionOP | full_scorefxn, | ||
bool | dump_pdb | ||
) |
References pepspec::binding_score(), pepspec::calc_sasa(), basic::options::OptionKeys::constraints::cst_weight, basic::options::OptionKeys::matdes::dock::dump_pdb, get_binding_score(), pepspec::homol_csts(), create_a3b_hbs::i, option, pep_begin(), pep_chain(), pep_end(), beta_nonlocal::pose, ObjexxFCL::string_of(), pepspec::upweight_interface(), basic::options::OptionKeys::inout::dbms::user, and basic::MetricValue< T >::value().
Size prot_anchor | ( | 0 | ) |
Size prot_begin | ( | 0 | ) |
Size prot_chain | ( | 0 | ) |
Size prot_end | ( | 0 | ) |
void remove_pep_res | ( | pose::Pose & | pose, |
bool | add_nterm, | ||
bool | add_cterm | ||
) |
References add_termini(), pep_anchor(), pep_begin(), pep_end(), and beta_nonlocal::pose.
void RunPepSpec | ( | ) |
References pepspec::add_buffer_res(), add_termini(), pep_coord_cst::atom_name, pepspec::binding_score(), pepspec::cen_wts(), utility::file::create_directory(), pyrosetta::create_score_function, basic::options::OptionKeys::cluster::energy_based_clustering::cst_file, basic::options::OptionKeys::constraints::cst_weight, extract_by_sidechain_sasa_score::cutoff, pepspec::diversify_lvl(), pepspec::diversify_pep_seqs(), pepspec::dump_cg_bb(), create_a3b_hbs::f, gen_pep_bb_sequential(), get_binding_score(), getline(), pepspec::homol_csts(), create_a3b_hbs::i, create_a3b_hbs::ii, initialize_peptide(), input_seq, pepspec::input_seq(), pepspec::interface_cutoff(), create_a3b_hbs::j, beta_nonlocal::jj, make_sequence_change(), vancomycin::min_mover, basic::options::OptionKeys::MonteCarlo::MonteCarlo, mutate_random_residue(), pepspec::n_append(), basic::options::OptionKeys::pepspec::n_append, pepspec::n_build_loop(), pepspec::n_cgrelax_loop(), basic::options::OptionKeys::pepspec::n_cgrelax_loop, pepspec::n_peptides(), basic::options::OptionKeys::pepspec::n_peptides, pepspec::n_prepend(), basic::options::OptionKeys::pepspec::n_prepend, pepspec::no_cen(), pepspec::no_design(), num_chains(), out::file::o(), option, erraser_single_res_analysis::out, packmin_unbound_pep(), demo.D010_Pose_structure::pdb_filename, pepspec::pdb_list(), pepspec::pep_anchor(), pep_anchor(), pep_begin(), pepspec::pep_chain(), pep_chain(), pep_coord_csts, pep_end(), pep_jump(), pep_coord_cst::pep_pos, perturb_pep_bb(), beta_nonlocal::pose, pyrosetta.distributed.io::pose_from_file, print_pep_analysis(), prot_anchor(), prot_begin(), prot_chain(), prot_end(), myMC::recover_low(), predPRE::resnum, numeric::random::rg(), myMC::roll(), test.T200_Scoring::rsd1, test.T200_Scoring::rsd2, pepspec::run_sequential(), pepspec::save_all_pdbs(), basic::options::OptionKeys::pepspec::save_all_pdbs, pepspec::save_low_pdbs(), basic::options::OptionKeys::pepspec::save_low_pdbs, pep_coord_cst::sd, set_pep_csts(), pepspec::soft_wts(), basic::options::start_file(), ObjexxFCL::string_of(), pep_coord_cst::tol, TR, numeric::random::RandomGenerator::uniform(), pepspec::upweight_interface(), pepspec::use_input_bb(), basic::options::OptionKeys::inout::dbms::user, utility_exit_with_message, basic::options::OptionKeys::remodel::vdw, score::weights(), pep_coord_cst::x, pep_coord_cst::x0, pep_coord_cst::y, and pep_coord_cst::z.
void set_pep_csts | ( | pose::Pose & | pose | ) |
References pep_coord_cst::atom_name, basic::options::OptionKeys::constraints::constraints, option, pepspec::p_homol_csts(), pep_anchor(), pep_begin(), pep_coord_csts, pep_end(), pep_coord_cst::pep_pos, beta_nonlocal::pose, prot_anchor(), numeric::random::rg(), pep_coord_cst::sd, pep_coord_cst::tol, numeric::random::uniform(), pep_coord_cst::x, numeric::xyzVector< T >::x(), pep_coord_cst::x0, pep_coord_cst::y, numeric::xyzVector< T >::y(), pep_coord_cst::z, and numeric::xyzVector< T >::z().
std::string input_seq |
vector1< pep_coord_cst > pep_coord_csts |
|
static |
Referenced by main(), make_sequence_change(), and RunPepSpec().