Rosetta
Public Member Functions | Static Public Member Functions | Private Member Functions | Private Attributes | List of all members
protocols::abinitio::JumpSpecificAbrelax Class Reference

application level code for Abrelax, Foldconstraints and JumpingFoldconstraints More...

#include <JumpSpecificAbrelax.hh>

Public Member Functions

 JumpSpecificAbrelax ()
 @detail c'stor - nothing special More...
 
void process_decoy (core::pose::Pose &pose, core::scoring::ScoreFunction const &, std::string tag, core::io::silent::ProteinSilentStruct &) const
 diagnostic stuff, i.e., computing numbers like an RMSD for each decoy and storing in silent-score-file put everything in here. — actually it mainly calls the evaluator_->apply method. add diagnostic stuff either here as explicit code or in form of a PoseEvaluator to evaluator_ ( see setup () ) the latter has the advantage that the specific evaluation can be carried out during the run of the protocol e.g., for abinitio:debug ( output to stage1_outfile stage2_outfile... ) More...
 
void add_constraints (core::pose::Pose &pose)
 read constraint set (self-initializing) and connect it to pose More...
 
void setup ()
 initialization of application: read some pdb files, set evaluator_ More...
 
void run ()
 run application code: calls do_rerun() or fold() depending on cmd-options More...
 
void do_rerun ()
 run process_decoy on all poses in silent-in file More...
 
void do_distributed_rerun ()
 run process_decoy on all poses in silent-in file – use of JobDistributor More...
 
void fold ()
 run abrelax-type protocols More...
 
bool close_loops (core::pose::Pose &pose, core::scoring::ScoreFunctionOP scorefxn, std::string const &tag)
 return pose with simple fold-tree that has small <0.1 RMSD to input pose More...
 
void relax (core::pose::Pose &pose, core::scoring::ScoreFunctionOP, std::string const &tag)
 relax structure ( fast / classic as controlled by cmd-options ) More...
 
bool multi_fast_relax (Protocol &abinitio_protocol, core::scoring::ScoreFunctionOP, jobdist::PlainSilentFileJobDistributor jobdist, int &curr_nstruct, jobdist::BasicJobOP &curr_job)
 relax multiple structures that are stored in abinitio_protocol.structure_store More...
 
void add_evaluation (evaluation::PoseEvaluatorOP)
 little helper: minimize structure to have lower chainbreak score ( seems particularly necessary after reading from silent-file ) More...
 
bool check_filters (core::pose::Pose &pose)
 check if the given pose passes the set of abinitio filters. More...
 

Static Public Member Functions

static void register_options ()
 

Private Member Functions

core::scoring::ScoreFunctionOP generate_scorefxn (bool fullatom=false)
 create score-functions for centroid and fullatom level More...
 
void setup_fold (core::pose::Pose &extended_pose, ProtocolOP &prot_ptr)
 setup everything needed for fold() — calls helper functions below More...
 
void copy_native_structure (core::pose::Pose &extended_pose) const
 -— Helper functions for setup_fold More...
 
void copy_structure (core::pose::Pose &extended_pose, core::pose::Pose &desired_pose) const
 copy torsions from the desired_pose, copy them into the extended_pose. More...
 
void generate_extended_pose (core::pose::Pose &extended_pose, std::string const &sequence) const
 steal native torsions from native_pose_ and apply to the "extended_pose" More...
 
void setup_fragments ()
 read fragment data More...
 
void setup_jumps (core::pose::Pose const &extended_pose)
 read jump definitions and set jump_def_ More...
 
void setup_templates ()
 initialize template_ More...
 
void insert_template_frags (core::pose::Pose &, core::kinematics::MoveMapOP movemap, std::string tag) const
 insert fragments from aligned regions More...
 
void initialize_constraint_forest (core::pose::Pose &pose)
 

Private Attributes

core::io::silent::SilentFileDataOP silent_score_file_
 ----------— Data ---------------------------— More...
 
core::pose::PoseOP native_pose_
 
core::pose::PoseOP init_pose_obj_
 
loops::Loops loops_in_
 
evaluation::PCA_OP pca_
 
bool bRelax_
 
std::string sequence_
 
core::scoring::constraints::ConstraintSetOP cstset_
 
core::scoring::constraints::ConstraintForestOP constraint_forest_
 
jumping::BaseJumpSetupOP jump_def_
 
jumping::SecondaryStructureOP ss_def_
 
TemplatesOP templates_
 
core::fragment::FragSetOP fragset_large_
 
core::fragment::FragSetOP fragset_small_
 
core::fragment::FragSetOP fragset_templates_
 
evaluation::MetaPoseEvaluatorOP evaluator_
 
checkpoint::CheckPointer abrelax_checkpoints_
 

Detailed Description

application level code for Abrelax, Foldconstraints and JumpingFoldconstraints

Constructor & Destructor Documentation

◆ JumpSpecificAbrelax()

protocols::abinitio::JumpSpecificAbrelax::JumpSpecificAbrelax ( )

@detail c'stor - nothing special

Member Function Documentation

◆ add_constraints()

void protocols::abinitio::JumpSpecificAbrelax::add_constraints ( core::pose::Pose pose)

◆ add_evaluation()

void protocols::abinitio::JumpSpecificAbrelax::add_evaluation ( evaluation::PoseEvaluatorOP  )

little helper: minimize structure to have lower chainbreak score ( seems particularly necessary after reading from silent-file )

@detail add a PoseEvaluator derived instance for decoy-processing

add a PoseEvaluator derived instance for decoy-processing

References evaluator_.

Referenced by add_constraints(), do_distributed_rerun(), do_rerun(), fold(), and setup().

◆ check_filters()

bool protocols::abinitio::JumpSpecificAbrelax::check_filters ( core::pose::Pose pose)

◆ close_loops()

bool protocols::abinitio::JumpSpecificAbrelax::close_loops ( core::pose::Pose pose,
core::scoring::ScoreFunctionOP  scorefxn,
std::string const &  tag 
)

◆ copy_native_structure()

void protocols::abinitio::JumpSpecificAbrelax::copy_native_structure ( core::pose::Pose extended_pose) const
private

-— Helper functions for setup_fold

steal native torsions from native_pose_ and apply to the extended_pose.

@detail called by setup_fold() if option[ start_native ] is active the routine defines a fragment of the length of the structure steals the fragment from the native and applies it to the decoy native needs to be idealized!

References copy_structure(), basic::options::OptionKeys::in::file::extended_pose, basic::Tracer::Info, native_pose_, and protocols::abinitio::tr.

Referenced by setup_fold().

◆ copy_structure()

void protocols::abinitio::JumpSpecificAbrelax::copy_structure ( core::pose::Pose extended_pose,
core::pose::Pose desired_pose 
) const
private

copy torsions from the desired_pose, copy them into the extended_pose.

References basic::options::OptionKeys::in::file::extended_pose, create_a3b_hbs::i, basic::Tracer::Info, min(), and protocols::abinitio::tr.

Referenced by copy_native_structure(), and setup_fold().

◆ do_distributed_rerun()

void protocols::abinitio::JumpSpecificAbrelax::do_distributed_rerun ( )

run process_decoy on all poses in silent-in file – use of JobDistributor

@detail loop over structures in silent-input file small trick is used to also have native structure in the set of analysis: it is added to the collection of silent_file-structures manually TODO we need to do something about difference between fullatom and centroid input!

References add_constraints(), add_evaluation(), begin, basic::options::OptionKeys::abinitio::bGDT, bRelax_, check_filters(), close_loops(), close_loops(), basic::options::OptionKeys::run::condor, loopfcst::coord_cst_all_atom(), evaluator_, basic::options::OptionKeys::abinitio::fastrelax, lactamize::filename, generate_scorefxn(), basic::Tracer::Info, bin_torsions::job, kic_runner::loop_file, loops_in_, max(), jumps::no_chainbreak_in_relax(), basic::options::OptionKeys::run::no_prof_info_in_silentout, cal_vdw_radius_pool::nproc, local::nstruct, out::nstruct(), option, drrafter_rna::output_tag, basic::options::OptionKeys::jumps::overlap_chainbreak, beta_nonlocal::pose, basic::options::OptionKeys::run::proc_id, process_decoy(), basic::options::OptionKeys::loops::random_grow_loops_by, relax(), basic::options::OptionKeys::abinitio::relax, basic::options::OptionKeys::abinitio::relax_with_jumps, basic::options::OptionKeys::rigid::rigid, sfd, basic::options::OptionKeys::in::file::silent, in::file::silent(), silent_score_file_, ObjexxFCL::string_of(), tag, protocols::abinitio::tr, basic::options::OptionKeys::inout::dbms::user, and utility_exit_with_message.

Referenced by run().

◆ do_rerun()

void protocols::abinitio::JumpSpecificAbrelax::do_rerun ( )

◆ fold()

void protocols::abinitio::JumpSpecificAbrelax::fold ( )

◆ generate_extended_pose()

void protocols::abinitio::JumpSpecificAbrelax::generate_extended_pose ( core::pose::Pose extended_pose,
std::string const &  sequence 
) const
private

steal native torsions from native_pose_ and apply to the "extended_pose"

@detail called by setup_fold(): setup the decoy pose with correct target sequence and extended structure

References basic::Tracer::Debug, basic::options::OptionKeys::in::file::extended_pose, make_symmdef_file_denovo::pos, basic::options::OptionKeys::in::file::residue_type_set, basic::options::OptionKeys::relax::sequence, and protocols::abinitio::tr.

Referenced by setup_fold().

◆ generate_scorefxn()

scoring::ScoreFunctionOP protocols::abinitio::JumpSpecificAbrelax::generate_scorefxn ( bool  fullatom = false)
private

◆ initialize_constraint_forest()

void protocols::abinitio::JumpSpecificAbrelax::initialize_constraint_forest ( core::pose::Pose pose)
private

◆ insert_template_frags()

void protocols::abinitio::JumpSpecificAbrelax::insert_template_frags ( core::pose::Pose ,
core::kinematics::MoveMapOP  movemap,
std::string  tag 
) const
private

◆ multi_fast_relax()

bool protocols::abinitio::JumpSpecificAbrelax::multi_fast_relax ( Protocol &  abinitio_protocol,
core::scoring::ScoreFunctionOP  ,
jobdist::PlainSilentFileJobDistributor  jobdist,
int &  curr_nstruct,
jobdist::BasicJobOP &  curr_job 
)

relax multiple structures that are stored in abinitio_protocol.structure_store

@detail do fast relax on multiple structures that have been visited during abinitio-protocol. MIKE: please give more documentation to this

References create_a3b_hbs::i, min(), process_decoy(), ObjexxFCL::right_string_of(), oop_conformations::scorefxn, silent_score_file_, subloop_histogram::size, protocols::abinitio::sort_PoseWithScore(), and ObjexxFCL::string_of().

Referenced by fold().

◆ process_decoy()

void protocols::abinitio::JumpSpecificAbrelax::process_decoy ( core::pose::Pose pose,
core::scoring::ScoreFunction const &  ,
std::string  tag,
core::io::silent::ProteinSilentStruct &   
) const

diagnostic stuff, i.e., computing numbers like an RMSD for each decoy and storing in silent-score-file put everything in here. — actually it mainly calls the evaluator_->apply method. add diagnostic stuff either here as explicit code or in form of a PoseEvaluator to evaluator_ ( see setup () ) the latter has the advantage that the specific evaluation can be carried out during the run of the protocol e.g., for abinitio:debug ( output to stage1_outfile stage2_outfile... )

@detail run all evaluations on the decoy from this function if you want these evaluations also available during internal stages of the protocols --> put them into a PoseEvaluator and use add_evaluation in setup() otherwise you can also use "manual" code right here in process_decoy --> this will only appear in final silent_out and silent_score - files.

References jumps::evaluate(), evaluator_, native_pose_, option, beta_nonlocal::pose, oop_conformations::scorefxn, tag, and utility_exit_with_message.

Referenced by do_distributed_rerun(), do_rerun(), fold(), and multi_fast_relax().

◆ register_options()

void protocols::abinitio::JumpSpecificAbrelax::register_options ( )
static

registering of options that are relevant for JumpSpecificAbrelax

References frags::annotate(), basic::options::OptionKeys::abinitio::bGDT, close_loops(), constraints::compute_total_dist_cst(), basic::options::OptionKeys::run::condor, templates::config(), loopfcst::coord_cst_all_atom(), loopfcst::coord_cst_weight(), loopfcst::coord_cst_weight_array(), constraints::cst_file(), constraints::cull_with_native(), abinitio::debug(), basic::options::OptionKeys::loops::debug_loop_closure, abinitio::detect_disulfide_before_relax(), loopfcst::dump_coord_cst_weight_array(), constraints::dump_cst_set(), basic::options::OptionKeys::abinitio::dump_frags, jumps::evaluate(), constraints::evaluate_max_seq_sep(), jumps::extra_frags_for_ss(), in::file::fasta(), abinitio::fastrelax(), templates::fix_aligned_residues(), jumps::fix_chainbreak(), templates::fix_frag_file(), jumps::fix_jumps(), templates::fix_margin(), abinitio::fix_residues_to_native(), constraints::forest_file(), in::file::frag3(), in::file::frag9(), basic::options::OptionKeys::abinitio::jdist_rerun, jumps::jump_lib(), jumps::loop_definition_from_file(), loops::loop_file(), templates::min_nr_large_frags(), templates::min_nr_small_frags(), abinitio::multifastrelax(), in::file::native(), in::file::native_exclude_res(), NEW_OPT, jumps::no_chainbreak_in_relax(), constraints::no_cst_in_relax(), constraints::no_linearize_bounded(), templates::no_pick_fragments(), basic::options::OptionKeys::run::no_prof_info_in_silentout, cal_vdw_radius_pool::nproc, frags::nr_large_copies(), templates::nr_large_copies(), templates::nr_small_copies(), out::nstruct(), abinitio::number_3mer_frags(), abinitio::number_9mer_frags(), OPT, jumps::pairing_file(), templates::pairings(), basic::options::OptionKeys::in::file::pca, perturb(), templates::pick_multiple_sizes(), basic::options::OptionKeys::run::proc_id, abinitio::process_store(), register_options(), abinitio::relax(), abinitio::relax_with_jumps(), basic::options::OptionKeys::abinitio::rerun, jumps::residue_pair_jump_file(), abinitio::return_full_atom(), basic::options::OptionKeys::abinitio::rmsd_residues, basic::options::OptionKeys::loops::scored_frag_cycles, basic::options::OptionKeys::out::sf, jumps::sheets(), basic::options::OptionKeys::loops::short_frag_cycles, in::file::silent(), out::file::silent(), basic::options::OptionKeys::abinitio::start_native, basic::options::OptionKeys::abinitio::steal_3mers, basic::options::OptionKeys::abinitio::steal_9mers, templates::strand_constraint(), jumps::topology_file(), abinitio::use_filters(), loopfcst::use_general_protocol(), templates::vary_frag_size(), basic::options::OptionKeys::constraints::viol, basic::options::OptionKeys::constraints::viol_level, and basic::options::OptionKeys::constraints::viol_type.

◆ relax()

void protocols::abinitio::JumpSpecificAbrelax::relax ( core::pose::Pose pose,
core::scoring::ScoreFunctionOP  scorefxn,
std::string const &  tag 
)

relax structure ( fast / classic as controlled by cmd-options )

@detail full-atom relax of decoys uses either ClassicRelax or FastRelax protocols.

References abrelax_checkpoints_, basic::options::OptionKeys::abinitio::detect_disulfide_before_relax, basic::options::OptionKeys::abinitio::fastrelax, constraints::no_cst_in_relax(), option, beta_nonlocal::pose, basic::options::OptionKeys::abinitio::relax, oop_conformations::scorefxn, and tag.

Referenced by do_distributed_rerun(), and fold().

◆ run()

void protocols::abinitio::JumpSpecificAbrelax::run ( )

◆ setup()

void protocols::abinitio::JumpSpecificAbrelax::setup ( )

◆ setup_fold()

void protocols::abinitio::JumpSpecificAbrelax::setup_fold ( core::pose::Pose extended_pose,
ProtocolOP &  prot_ptr 
)
private

setup everything needed for fold() — calls helper functions below

@detail setup_fold() all initialization that is necessary to run abinitio production loop in fold() read fragments, make pose from sequence, get constraints, set jumps, movemap .etc the two parameters are OUTPUT: extended_pose to run A) with ( might actually contain native starting structure (option!) ) prot_ptr: an initialized instance of ClassicAbinitio, FoldConstraints or JumpingFoldConstraints depending on user settings.

References add_constraints(), bRelax_, close_loops(), loopfcst::coord_cst_all_atom(), loopfcst::coord_cst_weight(), loopfcst::coord_cst_weight_array(), copy_native_structure(), copy_structure(), basic::Tracer::Debug, loopfcst::dump_coord_cst_weight_array(), end, evaluator_, basic::options::OptionKeys::in::file::extended_pose, basic::options::OptionKeys::abinitio::fastrelax, evaluate_beta_mutants::file, lactamize::filename, basic::options::OptionKeys::abinitio::fix_residues_to_native, kmeans_adaptive_kernel_density_bb_dependent_rotlib::fn, fragset_large_, fragset_small_, in::file::fullatom(), generate_extended_pose(), create_a3b_hbs::i, basic::Tracer::Info, initialize_constraint_forest(), rna_decompose::input_pdb, jump_def_, kic_runner::loop_file, loops_in_, basic::options::OptionKeys::in::file::movemap, basic::options::OptionKeys::abinitio::multifastrelax, native_pose_, option, make_symmdef_file_denovo::pos, pyrosetta.distributed.io::pose_from_file, test.T300_PyJobDistributor::pp, basic::options::OptionKeys::loops::random_grow_loops_by, utility::io::read_vector(), basic::options::OptionKeys::abinitio::relax, basic::options::OptionKeys::abinitio::return_full_atom, in::file::s(), basic::options::OptionKeys::loops::scored_frag_cycles, sequence_, setup_fragments(), setup_jumps(), basic::options::OptionKeys::loops::short_frag_cycles, ss_def_, basic::options::OptionKeys::cutoutdomain::start, basic::options::OptionKeys::abinitio::start_native, protocols::abinitio::tr, basic::options::OptionKeys::loopfcst::use_general_protocol, basic::options::OptionKeys::inout::dbms::user, utility_exit_with_message, basic::options::OptionKeys::constraints::viol_level, and weights().

Referenced by fold().

◆ setup_fragments()

void protocols::abinitio::JumpSpecificAbrelax::setup_fragments ( )
private

◆ setup_jumps()

void protocols::abinitio::JumpSpecificAbrelax::setup_jumps ( core::pose::Pose const &  extended_pose)
private

◆ setup_templates()

void protocols::abinitio::JumpSpecificAbrelax::setup_templates ( )
private

Member Data Documentation

◆ abrelax_checkpoints_

checkpoint::CheckPointer protocols::abinitio::JumpSpecificAbrelax::abrelax_checkpoints_
private

Referenced by close_loops(), fold(), and relax().

◆ bRelax_

bool protocols::abinitio::JumpSpecificAbrelax::bRelax_
private

◆ constraint_forest_

core::scoring::constraints::ConstraintForestOP protocols::abinitio::JumpSpecificAbrelax::constraint_forest_
private

◆ cstset_

core::scoring::constraints::ConstraintSetOP protocols::abinitio::JumpSpecificAbrelax::cstset_
private

◆ evaluator_

evaluation::MetaPoseEvaluatorOP protocols::abinitio::JumpSpecificAbrelax::evaluator_
private

◆ fragset_large_

core::fragment::FragSetOP protocols::abinitio::JumpSpecificAbrelax::fragset_large_
private

◆ fragset_small_

core::fragment::FragSetOP protocols::abinitio::JumpSpecificAbrelax::fragset_small_
private

◆ fragset_templates_

core::fragment::FragSetOP protocols::abinitio::JumpSpecificAbrelax::fragset_templates_
private

Referenced by setup_fragments().

◆ init_pose_obj_

core::pose::PoseOP protocols::abinitio::JumpSpecificAbrelax::init_pose_obj_
private

◆ jump_def_

jumping::BaseJumpSetupOP protocols::abinitio::JumpSpecificAbrelax::jump_def_
private

◆ loops_in_

loops::Loops protocols::abinitio::JumpSpecificAbrelax::loops_in_
private

Referenced by do_distributed_rerun(), and setup_fold().

◆ native_pose_

core::pose::PoseOP protocols::abinitio::JumpSpecificAbrelax::native_pose_
private

◆ pca_

evaluation::PCA_OP protocols::abinitio::JumpSpecificAbrelax::pca_
private

◆ sequence_

std::string protocols::abinitio::JumpSpecificAbrelax::sequence_
private

Referenced by setup(), setup_fold(), and setup_templates().

◆ silent_score_file_

core::io::silent::SilentFileDataOP protocols::abinitio::JumpSpecificAbrelax::silent_score_file_
private

----------— Data ---------------------------—

Referenced by do_distributed_rerun(), do_rerun(), fold(), multi_fast_relax(), and setup().

◆ ss_def_

jumping::SecondaryStructureOP protocols::abinitio::JumpSpecificAbrelax::ss_def_
private

Referenced by setup_fold(), and setup_jumps().

◆ templates_

TemplatesOP protocols::abinitio::JumpSpecificAbrelax::templates_
private

The documentation for this class was generated from the following files: