Module rosetta :: Module core :: Module pose
[hide private]
[frames] | no frames]

Module pose

Bindings for core::pose namespace

Classes [hide private]
  MiniPose
not quite (silent_structs don't necessarily have xyz).
  PDBInfo
maintains pdb residue & atom information inside a Pose
  PDBPoseMap
PDBPoseMap can be queried with PDB information (chain, sequence position) and returns a pose's resid position.
  Pose
The Pose class represents a molecular system (protein-dna-ligand...) as a container of Rosetta Residue objects together with a Conformation object that defines how internal coordinate changes propagate through the system and an Energies object that stores information from the last energy evaluation.
  PoseCoordPickMode
  ResidueIndexDescription
a class which can represent one of many ways in which to describe a particular residue in a pose, and can, when given a pose, find its index.
  ResidueIndexDescriptionFromFile
%ResidueIndexDescriptionFromFile differs from its parent only in its error reporting when a residue index resolution fails: it prints the file name and the line number that the residue index data came from.
  UnrecognizedAtomRecord
info about an atom in a unrecognized res (not in pose, but we want to remember it)
  xyzStripeHashPose
Functions [hide private]
 
addVirtualResAsRoot(*args, **kwargs)
Overloaded function.
 
add_comment(...)
add_comment(pose : rosetta.core.pose.Pose, key : unicode, val : unicode) -> NoneType
 
add_lower_terminus_type_to_pose_residue(...)
add_lower_terminus_type_to_pose_residue(pose : rosetta.core.pose.Pose, seqpos : int) -> NoneType
 
add_score_line_string(...)
add_score_line_string(pose : rosetta.core.pose.Pose, key : unicode, val : unicode) -> NoneType
 
add_upper_terminus_type_to_pose_residue(...)
add_upper_terminus_type_to_pose_residue(pose : rosetta.core.pose.Pose, seqpos : int) -> NoneType
 
add_variant_type_to_pose_residue(...)
add_variant_type_to_pose_residue(pose : rosetta.core.pose.Pose, variant_type : rosetta.core.chemical.VariantType, seqpos : int) -> NoneType
 
add_variant_type_to_residue(...)
add_variant_type_to_residue(old_rsd : rosetta.core.conformation.Residue, variant_type : rosetta.core.chemical.VariantType, pose : rosetta.core.pose.Pose) -> rosetta.core.conformation.Residue
 
annotated_to_oneletter_sequence(...)
annotated_to_oneletter_sequence(annotated_seq : unicode) -> unicode
 
append_pose_to_pose(*args, **kwargs)
Overloaded function.
 
append_pose_with_glycan_residues(...)
append_pose_with_glycan_residues(pose : rosetta.core.pose.Pose, residue_types : rosetta.utility.vector1_std_shared_ptr_const_core_chemical_ResidueType_t) -> NoneType
 
append_subpose_to_pose(*args, **kwargs)
Overloaded function.
 
atom_id_to_named_atom_id(...)
atom_id_to_named_atom_id(atom_id : rosetta.core.id.AtomID, pose : rosetta.core.pose.Pose) -> rosetta.core.id.NamedAtomID
 
canonical_atom_count(...)
canonical_atom_count(pose : rosetta.core.pose.Pose) -> int
 
canonical_residue_count(...)
canonical_residue_count(pose : rosetta.core.pose.Pose) -> int
 
center_of_mass(*args, **kwargs)
Overloaded function.
 
chain_end_res(*args, **kwargs)
Overloaded function.
 
clearPoseExtraScore(...)
clearPoseExtraScore(pose : rosetta.core.pose.Pose, name : unicode) -> NoneType
 
clearPoseExtraScores(...)
clearPoseExtraScores(pose : rosetta.core.pose.Pose) -> NoneType
 
compare_atom_coordinates(*args, **kwargs)
Overloaded function.
 
compare_binary_protein_silent_struct(...)
compare_binary_protein_silent_struct(lhs : rosetta.core.pose.Pose, rhs : rosetta.core.pose.Pose) -> bool
 
compute_unique_chains(...)
compute_unique_chains(pose : rosetta.core.pose.Pose) -> rosetta.utility.vector1_bool
 
conf2pdb_chain(...)
conf2pdb_chain(pose : rosetta.core.pose.Pose) -> rosetta.std.map_int_char
 
convert_from_std_map(...)
convert_from_std_map(atom_map : rosetta.std.map_core_id_AtomID_core_id_AtomID, pose : rosetta.core.pose.Pose) -> rosetta.core.id.AtomID_Map_core_id_AtomID_t
 
correctly_add_cutpoint_variants(*args, **kwargs)
Overloaded function.
 
create_subpose(...)
create_subpose(src : rosetta.core.pose.Pose, positions : rosetta.utility.vector1_unsigned_long, f : rosetta.core.kinematics.FoldTree, pose : rosetta.core.pose.Pose) -> NoneType
 
delete_comment(...)
delete_comment(pose : rosetta.core.pose.Pose, key : unicode) -> NoneType
 
dump_comment_pdb(...)
dump_comment_pdb(file_name : unicode, pose : rosetta.core.pose.Pose) -> NoneType
 
energy_from_pose(*args, **kwargs)
Overloaded function.
 
extract_tag_from_pose(...)
extract_tag_from_pose(pose : rosetta.core.pose.Pose) -> unicode
 
getPoseExtraScore(*args, **kwargs)
Overloaded function.
 
get_all_comments(...)
get_all_comments(pose : rosetta.core.pose.Pose) -> rosetta.std.map_std_string_std_string
 
get_all_score_line_strings(...)
get_all_score_line_strings(pose : rosetta.core.pose.Pose) -> rosetta.std.map_std_string_std_string
 
get_bb_torsion(...)
get_bb_torsion(torsion_id : int, pose : rosetta.core.pose.Pose, sequence_position : int) -> float
 
get_center_of_mass(...)
get_center_of_mass(pose : rosetta.core.pose.Pose) -> rosetta.numeric.xyzVector_double_t
 
get_chain_from_chain_id(...)
get_chain_from_chain_id(chain_id : int, pose : rosetta.core.pose.Pose) -> unicode
 
get_chain_from_jump_id(...)
get_chain_from_jump_id(jump_id : int, pose : rosetta.core.pose.Pose) -> unicode
 
get_chain_id_from_chain(*args, **kwargs)
Overloaded function.
 
get_chain_id_from_jump_id(...)
get_chain_id_from_jump_id(jump_id : int, pose : rosetta.core.pose.Pose) -> int
 
get_chain_ids_from_chain(*args, **kwargs)
Overloaded function.
 
get_chain_ids_from_chains(...)
get_chain_ids_from_chains(chains : rosetta.utility.vector1_std_string, pose : rosetta.core.pose.Pose) -> rosetta.utility.vector1_unsigned_long
 
get_chain_residues(...)
get_chain_residues(pose : rosetta.core.pose.Pose, chain_id : int) -> rosetta.utility.vector1_std_shared_ptr_const_core_conformation_Residue_t
 
get_chains(...)
get_chains(pose : rosetta.core.pose.Pose) -> rosetta.utility.vector1_int
 
get_comment(...)
get_comment(pose : rosetta.core.pose.Pose, key : unicode, val : unicode) -> bool
 
get_constraints_from_link_records(...)
get_constraints_from_link_records(pose : rosetta.core.pose.Pose, sfr : rosetta.core.io.StructFileRep) -> NoneType
 
get_hash_excluding_chain(...)
get_hash_excluding_chain(chain : unicode, pose : rosetta.core.pose.Pose) -> int
 
get_hash_from_chain(...)
get_hash_from_chain(chain : unicode, pose : rosetta.core.pose.Pose) -> int
 
get_jump_id_from_chain(*args, **kwargs)
Overloaded function.
 
get_jump_id_from_chain_id(...)
get_jump_id_from_chain_id(chain_id : int, pose : rosetta.core.pose.Pose) -> int
 
get_jump_ids_from_chain(*args, **kwargs)
Overloaded function.
 
get_jump_ids_from_chain_ids(...)
get_jump_ids_from_chain_ids(chain_ids : rosetta.std.set_unsigned_long_std_less_unsigned_long_std_allocator_unsigned_long_t, pose : rosetta.core.pose.Pose) -> rosetta.std.set_unsigned_long_std_less_unsigned_long_std_allocator_unsigned_long_t
 
get_resnum(*args, **kwargs)
Overloaded function.
 
get_resnum_list(*args, **kwargs)
Overloaded function.
 
get_resnum_list_ordered(...)
get_resnum_list_ordered(str : unicode, pose : rosetta.core.pose.Pose) -> rosetta.utility.vector1_unsigned_long
 
get_resnumber_from_reference_pose(...)
get_resnumber_from_reference_pose(refpose_name : unicode, refpose_number : int, refpose_offset : int, pose : rosetta.core.pose.Pose) -> int
 
get_rsd_type_from_aa(...)
get_rsd_type_from_aa(residue_set : rosetta.core.chemical.ResidueTypeSet, my_aa : rosetta.core.chemical.AA, is_lower_terminus : bool, is_upper_terminus : bool) -> rosetta.core.chemical.ResidueType
 
get_score_line_string(...)
get_score_line_string(pose : rosetta.core.pose.Pose, key : unicode, val : unicode) -> bool
 
get_sequence_len(...)
get_sequence_len(sequence_in : unicode) -> int
 
get_sha1_hash_excluding_chain(...)
get_sha1_hash_excluding_chain(chain : unicode, pose : rosetta.core.pose.Pose) -> unicode
 
hasPoseExtraScore(...)
hasPoseExtraScore(pose : rosetta.core.pose.Pose, name : unicode) -> bool
 
has_chain(*args, **kwargs)
Overloaded function.
 
initialize_atomid_map_AtomID(*args, **kwargs)
Overloaded function.
 
initialize_atomid_map_core_id_AtomID_t(*args, **kwargs)
Overloaded function.
 
initialize_disulfide_bonds(*args, **kwargs)
Overloaded function.
 
is_atom_axial_or_equatorial_to_ring(...)
is_atom_axial_or_equatorial_to_ring(pose : rosetta.core.pose.Pose, seqpos : int, query_atom : int, ring_atoms : rosetta.utility.vector1_unsigned_long) -> rosetta.core.chemical.rings.AxEqDesignation
 
is_ideal_pose(...)
is_ideal_pose(pose : rosetta.core.pose.Pose) -> bool
 
is_ideal_position(...)
is_ideal_position(seqpos : int, pose : rosetta.core.pose.Pose) -> bool
 
is_lower_terminus(...)
is_lower_terminus(pose : rosetta.core.pose.Pose, resid : int) -> bool
 
is_position_conserved_residue(...)
is_position_conserved_residue(pose : rosetta.core.pose.Pose, residue : int) -> bool
 
is_referencepose_number(...)
is_referencepose_number(str : unicode, refpose_string : unicode, refpose_resnumber : int, refpose_offset : int) -> bool
 
is_upper_terminus(...)
is_upper_terminus(pose : rosetta.core.pose.Pose, resid : int) -> bool
 
jumps_from_pose(...)
jumps_from_pose(pose : rosetta.core.pose.Pose, jumps : rosetta.std.set_int_std_less_int_std_allocator_int_t) -> NoneType
 
make_atom_map(...)
make_atom_map(p : rosetta.core.pose.Pose, m : rosetta.core.pose.PoseCoordPickMode) -> rosetta.core.id.AtomID_Map_double_t
 
make_pose_from_saccharide_sequence(*args, **kwargs)
Overloaded function.
 
make_pose_from_sequence(*args, **kwargs)
Overloaded function.
 
mass(...)
mass(begin : int, end : int, pose : rosetta.core.pose.Pose) -> float
 
named_atom_id_to_atom_id(*args, **kwargs)
Overloaded function.
 
named_stub_id_to_stub_id(...)
named_stub_id_to_stub_id(named_stub_id : rosetta.core.id.NamedStubID, pose : rosetta.core.pose.Pose) -> rosetta.core.id.StubID
 
noncanonical_atom_count(...)
noncanonical_atom_count(pose : rosetta.core.pose.Pose) -> int
 
noncanonical_chi_count(...)
noncanonical_chi_count(pose : rosetta.core.pose.Pose) -> int
 
noncanonical_residue_count(...)
noncanonical_residue_count(pose : rosetta.core.pose.Pose) -> int
 
nres_protein(...)
nres_protein(pose : rosetta.core.pose.Pose) -> int
 
num_atoms(...)
num_atoms(begin : int, end : int, pose : rosetta.core.pose.Pose) -> int
 
num_chi_angles(...)
num_chi_angles(begin : int, end : int, pose : rosetta.core.pose.Pose) -> int
 
num_hbond_acceptors(...)
num_hbond_acceptors(begin : int, end : int, pose : rosetta.core.pose.Pose) -> int
 
num_hbond_donors(...)
num_hbond_donors(begin : int, end : int, pose : rosetta.core.pose.Pose) -> int
 
num_heavy_atoms(...)
num_heavy_atoms(begin : int, end : int, pose : rosetta.core.pose.Pose) -> int
 
parse_PDBnum_icode(...)
parse_PDBnum_icode(token : unicode, fname : unicode, lineno : int, PDBnum : int, icode : unicode) -> NoneType
 
parse_resnum(*args, **kwargs)
Overloaded function.
 
parse_sequence(...)
parse_sequence(sequence_in : unicode, fullname_list : rosetta.utility.vector1_std_string, oneletter_to_fullname_index : rosetta.std.vector_unsigned_long, one_letter_sequence : unicode) -> NoneType
 
partition_pose_by_jump(...)
partition_pose_by_jump(src : rosetta.core.pose.Pose, jump_number : int, partner1 : rosetta.core.pose.Pose, partner2 : rosetta.core.pose.Pose) -> NoneType
 
pdb_to_pose(*args, **kwargs)
Overloaded function.
 
pdbslice(*args, **kwargs)
Overloaded function.
 
pose_from_saccharide_sequence(*args, **kwargs)
Overloaded function.
 
pose_max_nbr_radius(...)
pose_max_nbr_radius(pose : rosetta.core.pose.Pose) -> float
 
pose_residue_is_terminal(...)
pose_residue_is_terminal(pose : rosetta.core.pose.Pose, resid : int) -> bool
 
pose_to_pdb(...)
pose_to_pdb(pose : rosetta.core.pose.Pose, pose_res : rosetta.utility.vector1_unsigned_long) -> rosetta.utility.vector1_unsigned_long
 
read_comment_pdb(...)
read_comment_pdb(file_name : unicode, pose : rosetta.core.pose.Pose) -> NoneType
 
read_psipred_ss2_file(...)
read_psipred_ss2_file(pose : rosetta.core.pose.Pose) -> rosetta.utility.vector1_char
 
remove_ligand_canonical_residues(...)
remove_ligand_canonical_residues(pose : rosetta.core.pose.Pose) -> NoneType
 
remove_lower_terminus_type_from_pose_residue(...)
remove_lower_terminus_type_from_pose_residue(pose : rosetta.core.pose.Pose, seqpos : int) -> NoneType
 
remove_nonprotein_residues(...)
remove_nonprotein_residues(pose : rosetta.core.pose.Pose) -> NoneType
 
remove_upper_terminus_type_from_pose_residue(...)
remove_upper_terminus_type_from_pose_residue(pose : rosetta.core.pose.Pose, seqpos : int) -> NoneType
 
remove_variant_type_from_pose_residue(...)
remove_variant_type_from_pose_residue(pose : rosetta.core.pose.Pose, variant_type : rosetta.core.chemical.VariantType, seqpos : int) -> NoneType
 
remove_variant_type_from_residue(...)
remove_variant_type_from_residue(old_rsd : rosetta.core.conformation.Residue, variant_type : rosetta.core.chemical.VariantType, pose : rosetta.core.pose.Pose) -> rosetta.core.conformation.Residue
 
remove_virtual_residues(...)
remove_virtual_residues(pose : rosetta.core.pose.Pose) -> NoneType
 
renumber_pdbinfo_based_on_conf_chains(*args, **kwargs)
Overloaded function.
 
reorder_saccharide_residue_types(...)
reorder_saccharide_residue_types(residue_types : rosetta.utility.vector1_std_shared_ptr_const_core_chemical_ResidueType_t) -> NoneType
 
replace_pose_residue_copying_existing_coordinates(...)
replace_pose_residue_copying_existing_coordinates(pose : rosetta.core.pose.Pose, seqpos : int, new_rsd_type : rosetta.core.chemical.ResidueType) -> NoneType
 
res_in_chain(...)
res_in_chain(pose : rosetta.core.pose.Pose, resnum : int, chain : unicode) -> bool
 
residue_center_of_mass(*args, **kwargs)
Overloaded function.
 
residue_types_from_saccharide_sequence(...)
residue_types_from_saccharide_sequence(sequence : unicode, residue_set : rosetta.core.chemical.ResidueTypeSet) -> rosetta.utility.vector1_std_shared_ptr_const_core_chemical_ResidueType_t
 
residue_types_from_sequence(*args, **kwargs)
Overloaded function.
 
return_nearest_residue(*args, **kwargs)
Overloaded function.
 
sequence_map_from_pdbinfo(...)
sequence_map_from_pdbinfo(first : rosetta.core.pose.Pose, second : rosetta.core.pose.Pose) -> rosetta.core.id.SequenceMapping
 
setPoseExtraScore(*args, **kwargs)
Overloaded function.
 
set_bb_torsion(...)
set_bb_torsion(torsion_id : int, pose : rosetta.core.pose.Pose, sequence_position : int, new_angle : float) -> NoneType
 
set_bfactors_from_atom_id_map(...)
set_bfactors_from_atom_id_map(pose : rosetta.core.pose.Pose, bfactors : rosetta.core.id.AtomID_Map_double_t) -> NoneType
 
set_reasonable_fold_tree(...)
set_reasonable_fold_tree(pose : rosetta.core.pose.Pose) -> NoneType
 
set_ss_from_phipsi(...)
set_ss_from_phipsi(pose : rosetta.core.pose.Pose) -> NoneType
 
setup_dof_mask_from_move_map(...)
setup_dof_mask_from_move_map(mm : core::kinematics::MoveMap, pose : rosetta.core.pose.Pose, dof_mask : rosetta.core.id.DOF_ID_Map_bool_t) -> NoneType
 
setup_dof_to_torsion_map(...)
setup_dof_to_torsion_map(pose : rosetta.core.pose.Pose, dof_map : rosetta.core.id.DOF_ID_Map_core_id_TorsionID_t) -> NoneType
 
sort_pose_by_score(...)
sort_pose_by_score(pose1 : rosetta.core.pose.Pose, pose2 : rosetta.core.pose.Pose) -> bool
 
stub_id_to_named_stub_id(...)
stub_id_to_named_stub_id(stub_id : rosetta.core.id.StubID, pose : rosetta.core.pose.Pose) -> rosetta.core.id.NamedStubID
 
swap_transform(...)
swap_transform(jump_num : int, xform : rosetta.core.kinematics.RT, pose : rosetta.core.pose.Pose) -> NoneType
 
tag_from_pose(...)
tag_from_pose(pose : rosetta.core.pose.Pose) -> unicode
 
tag_into_pose(...)
tag_into_pose(pose : rosetta.core.pose.Pose, tag : unicode) -> NoneType
 
total_energy_from_pose(...)
total_energy_from_pose(pose : rosetta.core.pose.Pose) -> float
 
transfer_jumps(...)
transfer_jumps(srcpose : rosetta.core.pose.Pose, tgtpose : rosetta.core.pose.Pose) -> NoneType
 
transfer_phi_psi(*args, **kwargs)
Overloaded function.
Variables [hide private]
  PoseCoordPickMode_ALL = PoseCoordPickMode.PoseCoordPickMode_ALL
  PoseCoordPickMode_BB = PoseCoordPickMode.PoseCoordPickMode_BB
  PoseCoordPickMode_BNP = PoseCoordPickMode.PoseCoordPickMode_BNP
  PoseCoordPickMode_CA = PoseCoordPickMode.PoseCoordPickMode_CA
  PoseCoordPickMode_CB = PoseCoordPickMode.PoseCoordPickMode_CB
  PoseCoordPickMode_CB_else_CA = PoseCoordPickMode.PoseCoordPick...
  PoseCoordPickMode_CBorCA = PoseCoordPickMode.PoseCoordPickMode...
  PoseCoordPickMode_HVY = PoseCoordPickMode.PoseCoordPickMode_HVY
  PoseCoordPickMode_HVY_IF_NP = PoseCoordPickMode.PoseCoordPickM...
  PoseCoordPickMode_NBR = PoseCoordPickMode.PoseCoordPickMode_NBR
  PoseCoordPickMode_NUL = PoseCoordPickMode.PoseCoordPickMode_NUL
  PoseCoordPickMode_N_CA_C = PoseCoordPickMode.PoseCoordPickMode...
  PoseCoordPickMode_N_CA_C_CB = PoseCoordPickMode.PoseCoordPickM...
  PoseCoordPickMode_N_C_O = PoseCoordPickMode.PoseCoordPickMode_...
  __package__ = None
Function Details [hide private]

addVirtualResAsRoot(*args, **kwargs)

 
Overloaded function.

1. addVirtualResAsRoot(pose : rosetta.core.pose.Pose) -> NoneType

Adds a VRT res to the end of the pose at the center of mass.
 Reroots the structure on this res.

2. addVirtualResAsRoot(xyz : rosetta.numeric.xyzVector_double_t, pose : rosetta.core.pose.Pose) -> NoneType

Adds a virtual residue to the end of the pose at the specified location.
 Roots the structure on this residue.

add_comment(...)

 
add_comment(pose : rosetta.core.pose.Pose, key : unicode, val : unicode) -> NoneType

Adds a key-value pair to the STRING_MAP in the Pose DataCache. If
 there is no STRING_MAP in the DataCache, one is created.

add_score_line_string(...)

 
add_score_line_string(pose : rosetta.core.pose.Pose, key : unicode, val : unicode) -> NoneType

Sets a PDB-style REMARK entry in the Pose.
 

 This is different from a comment in its interpretation by the
 silent-file output machinery. A REMARK is written on its own separate line
 in the output silent-file, while a comment is written as part of the Pose
 SCORE: lines.

add_variant_type_to_pose_residue(...)

 

add_variant_type_to_pose_residue(pose : rosetta.core.pose.Pose, variant_type : rosetta.core.chemical.VariantType, seqpos : int) -> NoneType

Construct a variant of an existing pose residue.

add_variant_type_to_residue(...)

 

add_variant_type_to_residue(old_rsd : rosetta.core.conformation.Residue, variant_type : rosetta.core.chemical.VariantType, pose : rosetta.core.pose.Pose) -> rosetta.core.conformation.Residue

Construct a variant of an existing residue.

annotated_to_oneletter_sequence(...)

 
annotated_to_oneletter_sequence(annotated_seq : unicode) -> unicode

Returns the oneletter_sequence that corresponds to the given
 annotated sequence.

append_pose_to_pose(*args, **kwargs)

 
Overloaded function.

1. append_pose_to_pose(pose1 : rosetta.core.pose.Pose, pose2 : rosetta.core.pose.Pose) -> NoneType

Append residues of pose2 to pose1.

2. append_pose_to_pose(pose1 : rosetta.core.pose.Pose, pose2 : rosetta.core.pose.Pose, new_chain : bool) -> NoneType

Append residues of pose2 to pose1.

append_pose_with_glycan_residues(...)

 

append_pose_with_glycan_residues(pose : rosetta.core.pose.Pose, residue_types : rosetta.utility.vector1_std_shared_ptr_const_core_chemical_ResidueType_t) -> NoneType

Append an empty or current Pose with saccharide residues, building branches as necessary.

append_subpose_to_pose(*args, **kwargs)

 
Overloaded function.

1. append_subpose_to_pose(pose1 : rosetta.core.pose.Pose, pose2 : rosetta.core.pose.Pose, start_res : int, end_res : int) -> NoneType

Append specified residues of pose2 to pose1.

2. append_subpose_to_pose(pose1 : rosetta.core.pose.Pose, pose2 : rosetta.core.pose.Pose, start_res : int, end_res : int, new_chain : bool) -> NoneType

Append specified residues of pose2 to pose1.

canonical_atom_count(...)

 

canonical_atom_count(pose : rosetta.core.pose.Pose) -> int

count the number of canonical amino acid atoms in the pose

canonical_residue_count(...)

 

canonical_residue_count(pose : rosetta.core.pose.Pose) -> int

count the number of canonical residues in the pose

center_of_mass(*args, **kwargs)

 
Overloaded function.

1. center_of_mass(pose : rosetta.core.pose.Pose, residues : rosetta.utility.vector1_bool) -> rosetta.numeric.xyzVector_double_t

2. center_of_mass(pose : rosetta.core.pose.Pose, start : int, stop : int) -> rosetta.numeric.xyzVector_double_t

chain_end_res(*args, **kwargs)

 
Overloaded function.

1. chain_end_res(pose : rosetta.core.pose.Pose, chain : int) -> int

compute last residue number of a chain

2. chain_end_res(pose : rosetta.core.pose.Pose) -> rosetta.utility.vector1_unsigned_long

compute last residue numbers of all chains

compare_atom_coordinates(*args, **kwargs)

 
Overloaded function.

1. compare_atom_coordinates(lhs : rosetta.core.pose.Pose, rhs : rosetta.core.pose.Pose) -> bool

this function compares pose atom coordinates for equality; it is not the == operator because it does not compare all pose data.
 

 Steven Lewis smlewi.com
 

 one pose to compare
 

 one pose to compare
 

 number of decimal places to compare for the coordinates (remember == doesn't work for float); defaults to 3 which is PDB accuracy

2. compare_atom_coordinates(lhs : rosetta.core.pose.Pose, rhs : rosetta.core.pose.Pose, n_dec_places : int) -> bool

this function compares pose atom coordinates for equality; it is not the == operator because it does not compare all pose data.
 

 Steven Lewis smlewi.com
 

 one pose to compare
 

 one pose to compare
 

 number of decimal places to compare for the coordinates (remember == doesn't work for float); defaults to 3 which is PDB accuracy

compare_binary_protein_silent_struct(...)

 

compare_binary_protein_silent_struct(lhs : rosetta.core.pose.Pose, rhs : rosetta.core.pose.Pose) -> bool

this function compares poses for equality up to the information stored in the binary protein silent struct format.

compute_unique_chains(...)

 
compute_unique_chains(pose : rosetta.core.pose.Pose) -> rosetta.utility.vector1_bool

Compute uniq chains in a complex
 

 Returns a vector of pose length with true/false of uniq chain
    true is unique, false is not

conf2pdb_chain(...)

 
conf2pdb_chain(pose : rosetta.core.pose.Pose) -> rosetta.std.map_int_char

get Conformation chain -> PDBInfo chain mapping
 

 Any chains whose PDBInfo chain records are marked entirely as
  PDBInfo::empty_record() will be mapped to that character.  Note that
  Conformation -> PDBInfo is always unique, but the reverse may not be true.
 

 the mapping if PDBInfo available and chains appear consistent,
  otherwise returns an empty mapping

correctly_add_cutpoint_variants(*args, **kwargs)

 
Overloaded function.

1. correctly_add_cutpoint_variants(pose : rosetta.core.pose.Pose) -> NoneType

Add cutpoint variants to all residues annotated as cutpoints in the pose.

2. correctly_add_cutpoint_variants(pose : rosetta.core.pose.Pose, cutpoint_res : int) -> NoneType

3. correctly_add_cutpoint_variants(pose : rosetta.core.pose.Pose, cutpoint_res : int, check_fold_tree : bool) -> NoneType

create_subpose(...)

 

create_subpose(src : rosetta.core.pose.Pose, positions : rosetta.utility.vector1_unsigned_long, f : rosetta.core.kinematics.FoldTree, pose : rosetta.core.pose.Pose) -> NoneType

Create a subpose of the src pose. PDBInfo is set as NULL.

delete_comment(...)

 
delete_comment(pose : rosetta.core.pose.Pose, key : unicode) -> NoneType

Deletes the entry in the STRING_MAP associated with the
 given key.

dump_comment_pdb(...)

 

dump_comment_pdb(file_name : unicode, pose : rosetta.core.pose.Pose) -> NoneType

dumps pose+ comments to pdb file

energy_from_pose(*args, **kwargs)

 
Overloaded function.

1. energy_from_pose(pose : rosetta.core.pose.Pose, sc_type : rosetta.core.scoring.ScoreType) -> float

2. energy_from_pose(pose : rosetta.core.pose.Pose, sc_type : unicode) -> float

extract_tag_from_pose(...)

 

extract_tag_from_pose(pose : rosetta.core.pose.Pose) -> unicode

Returns a string giving the pose's tag if there is such a thing or "UnknownTag" otherwise.

getPoseExtraScore(*args, **kwargs)

 
Overloaded function.

1. getPoseExtraScore(pose : rosetta.core.pose.Pose, name : unicode, value : float) -> bool

getters/setters for things in the Pose DataCache

2. getPoseExtraScore(pose : rosetta.core.pose.Pose, name : unicode) -> float

3. getPoseExtraScore(pose : rosetta.core.pose.Pose, name : unicode, value : unicode) -> bool

get_all_comments(...)

 
get_all_comments(pose : rosetta.core.pose.Pose) -> rosetta.std.map_std_string_std_string

Gets a map< string, string > representing comments about the Pose in
 the form of key-value pairs.

get_all_score_line_strings(...)

 
get_all_score_line_strings(pose : rosetta.core.pose.Pose) -> rosetta.std.map_std_string_std_string

Gets a map< string, string > representing score_line_strings about the Pose in
 the form of key-value pairs.

get_bb_torsion(...)

 
get_bb_torsion(torsion_id : int, pose : rosetta.core.pose.Pose, sequence_position : int) -> float

Get a particular backbone torsion, phi, psi, omega (see core::types)
 Works with carbohydrates.
 Think about moving this to pose itself.

get_center_of_mass(...)

 

get_center_of_mass(pose : rosetta.core.pose.Pose) -> rosetta.numeric.xyzVector_double_t

Get center of mass of a pose.

get_chain_id_from_chain(*args, **kwargs)

 
Overloaded function.

1. get_chain_id_from_chain(chain : unicode, pose : rosetta.core.pose.Pose) -> int

2. get_chain_id_from_chain(chain : unicode, pose : rosetta.core.pose.Pose) -> int

get_chain_ids_from_chain(*args, **kwargs)

 
Overloaded function.

1. get_chain_ids_from_chain(chain : unicode, pose : rosetta.core.pose.Pose) -> rosetta.utility.vector1_unsigned_long

2. get_chain_ids_from_chain(chain : unicode, pose : rosetta.core.pose.Pose) -> rosetta.utility.vector1_unsigned_long

get_chains(...)

 

get_chains(pose : rosetta.core.pose.Pose) -> rosetta.utility.vector1_int

Get all the chains from conformation

get_comment(...)

 
get_comment(pose : rosetta.core.pose.Pose, key : unicode, val : unicode) -> bool

Attempts to access the entry in the STRING_MAP associated with the
 given key. If an entry for the key exists, the value associated with the key
 is put into val, and this function returns true. Otherwise, this function
 returns false and val left unmodified.

get_jump_id_from_chain(*args, **kwargs)

 
Overloaded function.

1. get_jump_id_from_chain(chain : unicode, pose : rosetta.core.pose.Pose) -> int

2. get_jump_id_from_chain(chain : unicode, pose : rosetta.core.pose.Pose) -> int

get_jump_ids_from_chain(*args, **kwargs)

 
Overloaded function.

1. get_jump_ids_from_chain(chain : unicode, pose : rosetta.core.pose.Pose) -> rosetta.utility.vector1_unsigned_long

2. get_jump_ids_from_chain(chain : unicode, pose : rosetta.core.pose.Pose) -> rosetta.utility.vector1_unsigned_long

get_resnum(*args, **kwargs)

 
Overloaded function.

1. get_resnum(tag_ptr : rosetta.utility.tag.Tag, pose : rosetta.core.pose.Pose) -> int

2. get_resnum(tag_ptr : rosetta.utility.tag.Tag, pose : rosetta.core.pose.Pose, prefix : unicode) -> int

get_resnum_list(*args, **kwargs)

 
Overloaded function.

1. get_resnum_list(tag_ptr : rosetta.utility.tag.Tag, tag : unicode, pose : rosetta.core.pose.Pose) -> rosetta.utility.vector1_unsigned_long

Extracts a list of residue numbers from a tag.
 

 The tag should contain a comma-separated list of numbers, in either
   pdb or rosetta format (

 parse_resnum for details)

2. get_resnum_list(str : unicode, pose : rosetta.core.pose.Pose) -> rosetta.std.set_unsigned_long_std_less_unsigned_long_std_allocator_unsigned_long_t

returns a resnum list directly from a string

get_resnum_list_ordered(...)

 

get_resnum_list_ordered(str : unicode, pose : rosetta.core.pose.Pose) -> rosetta.utility.vector1_unsigned_long

returns a resnum list directly from a string, preserving order

get_resnumber_from_reference_pose(...)

 
get_resnumber_from_reference_pose(refpose_name : unicode, refpose_number : int, refpose_offset : int, pose : rosetta.core.pose.Pose) -> int

Given the name of a ReferencePose object in the pose, a residue number in that reference pose, and a residue offset,
 this function returns the Rosetta number of the corresponding residue in the pose.  Should throw an error if the ReferencePose
 doesn't exist in the pose, or 0 if no corresponding residue exists in the pose.
 

 Vikram K. Mulligan, Baker laboratory (vmullig.edu)

get_rsd_type_from_aa(...)

 

get_rsd_type_from_aa(residue_set : rosetta.core.chemical.ResidueTypeSet, my_aa : rosetta.core.chemical.AA, is_lower_terminus : bool, is_upper_terminus : bool) -> rosetta.core.chemical.ResidueType

use efficient residue type finder to find simplest residue type with this AA & requested termini.

get_sequence_len(...)

 

get_sequence_len(sequence_in : unicode) -> int

Get the real length of a annotated sequence

has_chain(*args, **kwargs)

 
Overloaded function.

1. has_chain(chain : unicode, pose : rosetta.core.pose.Pose) -> bool

2. has_chain(chain : unicode, pose : rosetta.core.pose.Pose) -> bool

3. has_chain(chain_id : int, pose : rosetta.core.pose.Pose) -> bool

initialize_atomid_map_AtomID(*args, **kwargs)

 
Overloaded function.

1. initialize_atomid_map_AtomID(atom_map : rosetta.core.id.AtomID_Map_core_id_AtomID_t, pose : rosetta.core.pose.Pose) -> NoneType

2. initialize_atomid_map_AtomID(atom_map : rosetta.core.id.AtomID_Map_core_id_AtomID_t, pose : rosetta.core.pose.Pose, value : rosetta.core.id.AtomID) -> NoneType

3. initialize_atomid_map_AtomID(atom_map : rosetta.core.id.AtomID_Map_core_id_AtomID_t, conformation : rosetta.core.conformation.Conformation) -> NoneType

4. initialize_atomid_map_AtomID(atom_map : rosetta.core.id.AtomID_Map_core_id_AtomID_t, conformation : rosetta.core.conformation.Conformation, value : rosetta.core.id.AtomID) -> NoneType

initialize_atomid_map_core_id_AtomID_t(*args, **kwargs)

 
Overloaded function.

1. initialize_atomid_map_core_id_AtomID_t(atom_map : rosetta.core.id.AtomID_Map_core_id_AtomID_t, pose : rosetta.core.pose.Pose) -> NoneType

2. initialize_atomid_map_core_id_AtomID_t(atom_map : rosetta.core.id.AtomID_Map_core_id_AtomID_t, pose : rosetta.core.pose.Pose, value : rosetta.core.id.AtomID) -> NoneType

3. initialize_atomid_map_core_id_AtomID_t(atom_map : rosetta.core.id.AtomID_Map_core_id_AtomID_t, conformation : rosetta.core.conformation.Conformation) -> NoneType

4. initialize_atomid_map_core_id_AtomID_t(atom_map : rosetta.core.id.AtomID_Map_core_id_AtomID_t, conformation : rosetta.core.conformation.Conformation, value : rosetta.core.id.AtomID) -> NoneType

initialize_disulfide_bonds(*args, **kwargs)

 
Overloaded function.

1. initialize_disulfide_bonds(pose : rosetta.core.pose.Pose) -> NoneType

detect and fix disulfide bonds

2. initialize_disulfide_bonds(pose : rosetta.core.pose.Pose, fd : rosetta.core.io.StructFileRep) -> NoneType

detect and fix disulfide bonds

is_atom_axial_or_equatorial_to_ring(...)

 

is_atom_axial_or_equatorial_to_ring(pose : rosetta.core.pose.Pose, seqpos : int, query_atom : int, ring_atoms : rosetta.utility.vector1_unsigned_long) -> rosetta.core.chemical.rings.AxEqDesignation

Is the query atom in this pose residue axial or equatorial to the given ring or neither?

is_ideal_pose(...)

 
is_ideal_pose(pose : rosetta.core.pose.Pose) -> bool

Returns true if the  <pose>  geometry is ideal
 

 The Pose to check.
 

 true if all pose positions have ideal bond lengths and angles
  up to some very small epsilon

is_ideal_position(...)

 
is_ideal_position(seqpos : int, pose : rosetta.core.pose.Pose) -> bool

Returns true if the  <pose> geometry is ideal in position  <seqpos>
 

 The Pose to check.
 

 true if position seqpos has ideal bond lengths and angles
  up to some very small epsilon

is_lower_terminus(...)

 

is_lower_terminus(pose : rosetta.core.pose.Pose, resid : int) -> bool

checks to see if this is a lower chain ending more intelligently than just checking residue variants

is_position_conserved_residue(...)

 

is_position_conserved_residue(pose : rosetta.core.pose.Pose, residue : int) -> bool

Returns true if <residue> is positionally conserved, false otherwise

is_referencepose_number(...)

 
is_referencepose_number(str : unicode, refpose_string : unicode, refpose_resnumber : int, refpose_offset : int) -> bool

Is a string of the format "refpose(<refposename>,<refposenumber>)" or "refpose(<refposename>,<refposenumber>)+/-<number>"?
 

  If this successfully determines that this is a string of this format, it populates the refpose_string, refpose_resnumber,
 and refpose_offset variables with the name of the ReferencePose, the number of the residue in the reference pose, and the +/- offset
 number parsed from this string.
 

 Vikram K. Mulligan, Baker laboratory (vmullig.edu)

is_upper_terminus(...)

 

is_upper_terminus(pose : rosetta.core.pose.Pose, resid : int) -> bool

checks to see if this is a lower chain ending more intelligently than just checking residue variants

jumps_from_pose(...)

 
jumps_from_pose(pose : rosetta.core.pose.Pose, jumps : rosetta.std.set_int_std_less_int_std_allocator_int_t) -> NoneType

Retrieves jump information from <pose>, storing the result in <jumps>.
 Jumps are keyed by their jump id.

make_pose_from_saccharide_sequence(*args, **kwargs)

 
Overloaded function.

1. make_pose_from_saccharide_sequence(pose : rosetta.core.pose.Pose, sequence : unicode, residue_set : rosetta.core.chemical.ResidueTypeSet) -> NoneType

Create a Pose from an annotated, linear, IUPAC polysaccharide sequence <sequence> with ResidueTypeSet
 <residue_set> and store it in <pose>.

2. make_pose_from_saccharide_sequence(pose : rosetta.core.pose.Pose, sequence : unicode, residue_set : rosetta.core.chemical.ResidueTypeSet, auto_termini : bool) -> NoneType

Create a Pose from an annotated, linear, IUPAC polysaccharide sequence <sequence> with ResidueTypeSet
 <residue_set> and store it in <pose>.

3. make_pose_from_saccharide_sequence(pose : rosetta.core.pose.Pose, sequence : unicode, residue_set : rosetta.core.chemical.ResidueTypeSet, auto_termini : bool, idealize_linkages : bool) -> NoneType

Create a Pose from an annotated, linear, IUPAC polysaccharide sequence <sequence> with ResidueTypeSet
 <residue_set> and store it in <pose>.

4. make_pose_from_saccharide_sequence(pose : rosetta.core.pose.Pose, sequence : unicode) -> NoneType

Create a Pose from an annotated, linear, IUPAC polysaccharide sequence <sequence> with residue type set name
 <type_set_name> and store it in <pose>.

5. make_pose_from_saccharide_sequence(pose : rosetta.core.pose.Pose, sequence : unicode, type_set_name : unicode) -> NoneType

Create a Pose from an annotated, linear, IUPAC polysaccharide sequence <sequence> with residue type set name
 <type_set_name> and store it in <pose>.

6. make_pose_from_saccharide_sequence(pose : rosetta.core.pose.Pose, sequence : unicode, type_set_name : unicode, auto_termini : bool) -> NoneType

Create a Pose from an annotated, linear, IUPAC polysaccharide sequence <sequence> with residue type set name
 <type_set_name> and store it in <pose>.

7. make_pose_from_saccharide_sequence(pose : rosetta.core.pose.Pose, sequence : unicode, type_set_name : unicode, auto_termini : bool, idealize_linkages : bool) -> NoneType

Create a Pose from an annotated, linear, IUPAC polysaccharide sequence <sequence> with residue type set name
 <type_set_name> and store it in <pose>.

make_pose_from_sequence(*args, **kwargs)

 
Overloaded function.

1. make_pose_from_sequence(pose : rosetta.core.pose.Pose, requested_types : rosetta.utility.vector1_std_shared_ptr_const_core_chemical_ResidueType_t) -> NoneType

Creates a Pose from the annotated protein sequence  <sequence>
 with ResidueTypeSet  <residue_set>  and stores it in  <pose>
 

: any existing data in  <pose>  is cleared, auto_termini
 mark position 1, last_residue with lower, upper termini; default true

 example(s):
     make_pose_from_sequence(pose,"THANKSEVAN",core::chemical::FA_STANDARD)
 See also:
     Pose
     PDBInfo
     pose_from_pdb
     pose_from_rcsb
     pose_from_sequence

2. make_pose_from_sequence(pose : rosetta.core.pose.Pose, requested_types : rosetta.utility.vector1_std_shared_ptr_const_core_chemical_ResidueType_t, auto_termini : bool) -> NoneType

Creates a Pose from the annotated protein sequence  <sequence>
 with ResidueTypeSet  <residue_set>  and stores it in  <pose>
 

: any existing data in  <pose>  is cleared, auto_termini
 mark position 1, last_residue with lower, upper termini; default true

 example(s):
     make_pose_from_sequence(pose,"THANKSEVAN",core::chemical::FA_STANDARD)
 See also:
     Pose
     PDBInfo
     pose_from_pdb
     pose_from_rcsb
     pose_from_sequence

3. make_pose_from_sequence(pose : rosetta.core.pose.Pose, sequence : unicode, residue_set : rosetta.core.chemical.ResidueTypeSet) -> NoneType

4. make_pose_from_sequence(pose : rosetta.core.pose.Pose, sequence : unicode, residue_set : rosetta.core.chemical.ResidueTypeSet, auto_termini : bool) -> NoneType

5. make_pose_from_sequence(pose : rosetta.core.pose.Pose, sequence : unicode, residue_set : rosetta.core.chemical.ResidueTypeSet) -> NoneType

6. make_pose_from_sequence(pose : rosetta.core.pose.Pose, sequence : unicode, residue_set : rosetta.core.chemical.ResidueTypeSet, auto_termini : bool) -> NoneType

7. make_pose_from_sequence(pose : rosetta.core.pose.Pose, sequence : unicode, type_set_name : unicode) -> NoneType

Creates a Pose from the annotated protein sequence  <sequence>
 with the desired  <type_set_name>  and stores it in  <pose>
 

: any existing data in  <pose>  is cleared, auto_termini
 mark position 1, last_residue with lower, upper termini; default true

8. make_pose_from_sequence(pose : rosetta.core.pose.Pose, sequence : unicode, type_set_name : unicode, auto_termini : bool) -> NoneType

Creates a Pose from the annotated protein sequence  <sequence>
 with the desired  <type_set_name>  and stores it in  <pose>
 

: any existing data in  <pose>  is cleared, auto_termini
 mark position 1, last_residue with lower, upper termini; default true

named_atom_id_to_atom_id(*args, **kwargs)

 
Overloaded function.

1. named_atom_id_to_atom_id(named_atom_id : rosetta.core.id.NamedAtomID, pose : rosetta.core.pose.Pose) -> rosetta.core.id.AtomID

2. named_atom_id_to_atom_id(named_atom_id : rosetta.core.id.NamedAtomID, pose : rosetta.core.pose.Pose, raise_exception : bool) -> rosetta.core.id.AtomID

noncanonical_atom_count(...)

 

noncanonical_atom_count(pose : rosetta.core.pose.Pose) -> int

count the number of non-canonical amino acids in thepose

noncanonical_chi_count(...)

 

noncanonical_chi_count(pose : rosetta.core.pose.Pose) -> int

count the number of non-canonical chi angles in the pose

noncanonical_residue_count(...)

 

noncanonical_residue_count(pose : rosetta.core.pose.Pose) -> int

count the number of non-canonical residues in the pose

nres_protein(...)

 
nres_protein(pose : rosetta.core.pose.Pose) -> int

Number of protein residues in the pose
 

 No virtuals, membrane residues or embedding residues counted

parse_PDBnum_icode(...)

 
parse_PDBnum_icode(token : unicode, fname : unicode, lineno : int, PDBnum : int, icode : unicode) -> NoneType

Take the string "token" and try to interpret it as a PDB identifier in the form of an
 integer as well as an optional insertion code.  For example the string "25A" would be
 interpretted as the residue 25 with the insertion code "A."  Throws an exception if
 the input string is misformatted.

parse_resnum(*args, **kwargs)

 
Overloaded function.

1. parse_resnum(resnum : unicode, pose : rosetta.core.pose.Pose) -> int

Extracts a residue number from a string.
 

 Recognizes three forms of numbering:
   - Rosetta residue numbers (numbered sequentially from 1 to the last residue
     in the pose). These have the form [0-9]+
   - PDB numbers. These have the form [0-9]+[A-Z], where the trailing letter
     is the chain ID.
  - Reference pose numbers.  These have the form refpose([refpose name], [refpose number]).
 In addition, relative numbers are permitted (of the form +[number] or -[number]) in conjunction
 with reference pose numbering.  For example, one might say "refpose(state1,17)+3", which means
 three residues past the residue correpsonding to residue 17 in the reference pose called "state1".
 

 the rosetta residue number for the string, or 0 upon an error

2. parse_resnum(resnum : unicode, pose : rosetta.core.pose.Pose, check_for_refpose : bool) -> int

Extracts a residue number from a string.
 

 Recognizes three forms of numbering:
   - Rosetta residue numbers (numbered sequentially from 1 to the last residue
     in the pose). These have the form [0-9]+
   - PDB numbers. These have the form [0-9]+[A-Z], where the trailing letter
     is the chain ID.
  - Reference pose numbers.  These have the form refpose([refpose name], [refpose number]).
 In addition, relative numbers are permitted (of the form +[number] or -[number]) in conjunction
 with reference pose numbering.  For example, one might say "refpose(state1,17)+3", which means
 three residues past the residue correpsonding to residue 17 in the reference pose called "state1".
 

 the rosetta residue number for the string, or 0 upon an error

parse_sequence(...)

 

parse_sequence(sequence_in : unicode, fullname_list : rosetta.utility.vector1_std_string, oneletter_to_fullname_index : rosetta.std.vector_unsigned_long, one_letter_sequence : unicode) -> NoneType

Parse the input annotated sequence

pdb_to_pose(*args, **kwargs)

 
Overloaded function.

1. pdb_to_pose(pose : rosetta.core.pose.Pose, pdb_res : rosetta.utility.vector1_int) -> rosetta.utility.vector1_unsigned_long

Convert PDB numbering to pose numbering. Must exist somewhere else, but I couldn't find it. -- rhiju

2. pdb_to_pose(pose : rosetta.core.pose.Pose, pdb_res : (rosetta.utility.vector1_int, rosetta.utility.vector1_char)) -> rosetta.utility.vector1_unsigned_long

Convert PDB numbering/chain to pose numbering. Must exist somewhere else, but I couldn't find it. -- rhiju

3. pdb_to_pose(pose : rosetta.core.pose.Pose, res_num : int) -> int

Convert PDB numbering to pose numbering. Must exist somewhere else, but I couldn't find it. -- rhiju

4. pdb_to_pose(pose : rosetta.core.pose.Pose, res_num : int, chain : unicode) -> int

Convert PDB numbering to pose numbering. Must exist somewhere else, but I couldn't find it. -- rhiju

pdbslice(*args, **kwargs)

 
Overloaded function.

1. pdbslice(new_pose : rosetta.core.pose.Pose, pose : rosetta.core.pose.Pose, slice_res : rosetta.utility.vector1_unsigned_long) -> NoneType

Create a subpose of the src pose -- figures out a reasonable fold tree.

2. pdbslice(pose : rosetta.core.pose.Pose, slice_res : rosetta.utility.vector1_unsigned_long) -> NoneType

Create a subpose of the src pose -- figures out a reasonable fold tree.

pose_from_saccharide_sequence(*args, **kwargs)

 
Overloaded function.

1. pose_from_saccharide_sequence(sequence : unicode) -> rosetta.core.pose.Pose

Return a Pose from an annotated, linear, IUPAC polysaccharide sequence <sequence> with residue type set name
 <type_set_name>.

2. pose_from_saccharide_sequence(sequence : unicode, type_set_name : unicode) -> rosetta.core.pose.Pose

Return a Pose from an annotated, linear, IUPAC polysaccharide sequence <sequence> with residue type set name
 <type_set_name>.

3. pose_from_saccharide_sequence(sequence : unicode, type_set_name : unicode, auto_termini : bool) -> rosetta.core.pose.Pose

Return a Pose from an annotated, linear, IUPAC polysaccharide sequence <sequence> with residue type set name
 <type_set_name>.

4. pose_from_saccharide_sequence(sequence : unicode, type_set_name : unicode, auto_termini : bool, idealize_linkages : bool) -> rosetta.core.pose.Pose

Return a Pose from an annotated, linear, IUPAC polysaccharide sequence <sequence> with residue type set name
 <type_set_name>.

pose_max_nbr_radius(...)

 

pose_max_nbr_radius(pose : rosetta.core.pose.Pose) -> float

returns a Distance

pose_residue_is_terminal(...)

 

pose_residue_is_terminal(pose : rosetta.core.pose.Pose, resid : int) -> bool

returns true if the given residue in the pose is a chain ending or has upper/lower terminal variants

pose_to_pdb(...)

 

pose_to_pdb(pose : rosetta.core.pose.Pose, pose_res : rosetta.utility.vector1_unsigned_long) -> rosetta.utility.vector1_unsigned_long

Convert pose numbering to pdb numbering. Must exist somewhere else, but I couldn't find it. -- rhiju

read_comment_pdb(...)

 

read_comment_pdb(file_name : unicode, pose : rosetta.core.pose.Pose) -> NoneType

Reads the comments from the pdb file and adds it into comments

remove_ligand_canonical_residues(...)

 

remove_ligand_canonical_residues(pose : rosetta.core.pose.Pose) -> NoneType

this function removes all residues with both UPPER and LOWER terminus types. This is intended for removing ligands that are canonical residues.

remove_nonprotein_residues(...)

 

remove_nonprotein_residues(pose : rosetta.core.pose.Pose) -> NoneType

this function removes all residues from the pose which are not protein residues. This removal includes, but is not limited to, metals, DNA, RNA, and ligands. It will NOT remove ligands which are canonical residues (for example, if a protein binds an alanine monomer, the monomer will be untouched).

remove_variant_type_from_pose_residue(...)

 

remove_variant_type_from_pose_residue(pose : rosetta.core.pose.Pose, variant_type : rosetta.core.chemical.VariantType, seqpos : int) -> NoneType

Construct a non-variant of an existing pose residue.

remove_variant_type_from_residue(...)

 

remove_variant_type_from_residue(old_rsd : rosetta.core.conformation.Residue, variant_type : rosetta.core.chemical.VariantType, pose : rosetta.core.pose.Pose) -> rosetta.core.conformation.Residue

Remove variant from an existing residue.

remove_virtual_residues(...)

 

remove_virtual_residues(pose : rosetta.core.pose.Pose) -> NoneType

Removes all virtual residues from <pose>

renumber_pdbinfo_based_on_conf_chains(*args, **kwargs)

 
Overloaded function.

1. renumber_pdbinfo_based_on_conf_chains(pose : rosetta.core.pose.Pose) -> bool

renumber PDBInfo based on Conformation chains; each chain starts from 1
 

 The Pose to modify.
 

 If true, the procedure will attempt to fix any empty record
  characters it finds in the PDBInfo. (default true)
 

 If true, will attempt to start each
  chain from the existing numbering in the PDBInfo.  E.g. if the first residue
  of chain 2 in the Conformation is 27, then the renumbering of the chain in
  PDBInfo will start from 27. (default true)
 

 If true, will maintain insertion codes and
  will not increment the pdb residue numbering for those residues.  This means
  new numbering with insertion codes will only reflect properly if the
  old numbering included the base numbering of the insertion code residues,
  i.e. 100 100A 100B and not just 100A 100B (with 100 never appearing).
  (default false)
 

 If true, allows support for more than 26 pdb chains
  by rotating [A,Z] continuously.  WARNING: This will break the assumption
  made by the PDBPoseMap that each pdb chain id is unique, so make sure you
  are not using the PDBPoseMap feature downstream in your code path without
  corrections! (default false)
 

 If fixing chains and there is only one chain and the PDBInfo exists
  but all records are marked as empty, will renumber and set the PDBInfo chain
  to 'A'.
 

 true if renumbering successful, false otherwise

2. renumber_pdbinfo_based_on_conf_chains(pose : rosetta.core.pose.Pose, fix_chains : bool) -> bool

renumber PDBInfo based on Conformation chains; each chain starts from 1
 

 The Pose to modify.
 

 If true, the procedure will attempt to fix any empty record
  characters it finds in the PDBInfo. (default true)
 

 If true, will attempt to start each
  chain from the existing numbering in the PDBInfo.  E.g. if the first residue
  of chain 2 in the Conformation is 27, then the renumbering of the chain in
  PDBInfo will start from 27. (default true)
 

 If true, will maintain insertion codes and
  will not increment the pdb residue numbering for those residues.  This means
  new numbering with insertion codes will only reflect properly if the
  old numbering included the base numbering of the insertion code residues,
  i.e. 100 100A 100B and not just 100A 100B (with 100 never appearing).
  (default false)
 

 If true, allows support for more than 26 pdb chains
  by rotating [A,Z] continuously.  WARNING: This will break the assumption
  made by the PDBPoseMap that each pdb chain id is unique, so make sure you
  are not using the PDBPoseMap feature downstream in your code path without
  corrections! (default false)
 

 If fixing chains and there is only one chain and the PDBInfo exists
  but all records are marked as empty, will renumber and set the PDBInfo chain
  to 'A'.
 

 true if renumbering successful, false otherwise

3. renumber_pdbinfo_based_on_conf_chains(pose : rosetta.core.pose.Pose, fix_chains : bool, start_from_existing_numbering : bool) -> bool

renumber PDBInfo based on Conformation chains; each chain starts from 1
 

 The Pose to modify.
 

 If true, the procedure will attempt to fix any empty record
  characters it finds in the PDBInfo. (default true)
 

 If true, will attempt to start each
  chain from the existing numbering in the PDBInfo.  E.g. if the first residue
  of chain 2 in the Conformation is 27, then the renumbering of the chain in
  PDBInfo will start from 27. (default true)
 

 If true, will maintain insertion codes and
  will not increment the pdb residue numbering for those residues.  This means
  new numbering with insertion codes will only reflect properly if the
  old numbering included the base numbering of the insertion code residues,
  i.e. 100 100A 100B and not just 100A 100B (with 100 never appearing).
  (default false)
 

 If true, allows support for more than 26 pdb chains
  by rotating [A,Z] continuously.  WARNING: This will break the assumption
  made by the PDBPoseMap that each pdb chain id is unique, so make sure you
  are not using the PDBPoseMap feature downstream in your code path without
  corrections! (default false)
 

 If fixing chains and there is only one chain and the PDBInfo exists
  but all records are marked as empty, will renumber and set the PDBInfo chain
  to 'A'.
 

 true if renumbering successful, false otherwise

4. renumber_pdbinfo_based_on_conf_chains(pose : rosetta.core.pose.Pose, fix_chains : bool, start_from_existing_numbering : bool, keep_insertion_codes : bool) -> bool

renumber PDBInfo based on Conformation chains; each chain starts from 1
 

 The Pose to modify.
 

 If true, the procedure will attempt to fix any empty record
  characters it finds in the PDBInfo. (default true)
 

 If true, will attempt to start each
  chain from the existing numbering in the PDBInfo.  E.g. if the first residue
  of chain 2 in the Conformation is 27, then the renumbering of the chain in
  PDBInfo will start from 27. (default true)
 

 If true, will maintain insertion codes and
  will not increment the pdb residue numbering for those residues.  This means
  new numbering with insertion codes will only reflect properly if the
  old numbering included the base numbering of the insertion code residues,
  i.e. 100 100A 100B and not just 100A 100B (with 100 never appearing).
  (default false)
 

 If true, allows support for more than 26 pdb chains
  by rotating [A,Z] continuously.  WARNING: This will break the assumption
  made by the PDBPoseMap that each pdb chain id is unique, so make sure you
  are not using the PDBPoseMap feature downstream in your code path without
  corrections! (default false)
 

 If fixing chains and there is only one chain and the PDBInfo exists
  but all records are marked as empty, will renumber and set the PDBInfo chain
  to 'A'.
 

 true if renumbering successful, false otherwise

5. renumber_pdbinfo_based_on_conf_chains(pose : rosetta.core.pose.Pose, fix_chains : bool, start_from_existing_numbering : bool, keep_insertion_codes : bool, rotate_chain_ids : bool) -> bool

renumber PDBInfo based on Conformation chains; each chain starts from 1
 

 The Pose to modify.
 

 If true, the procedure will attempt to fix any empty record
  characters it finds in the PDBInfo. (default true)
 

 If true, will attempt to start each
  chain from the existing numbering in the PDBInfo.  E.g. if the first residue
  of chain 2 in the Conformation is 27, then the renumbering of the chain in
  PDBInfo will start from 27. (default true)
 

 If true, will maintain insertion codes and
  will not increment the pdb residue numbering for those residues.  This means
  new numbering with insertion codes will only reflect properly if the
  old numbering included the base numbering of the insertion code residues,
  i.e. 100 100A 100B and not just 100A 100B (with 100 never appearing).
  (default false)
 

 If true, allows support for more than 26 pdb chains
  by rotating [A,Z] continuously.  WARNING: This will break the assumption
  made by the PDBPoseMap that each pdb chain id is unique, so make sure you
  are not using the PDBPoseMap feature downstream in your code path without
  corrections! (default false)
 

 If fixing chains and there is only one chain and the PDBInfo exists
  but all records are marked as empty, will renumber and set the PDBInfo chain
  to 'A'.
 

 true if renumbering successful, false otherwise

reorder_saccharide_residue_types(...)

 

reorder_saccharide_residue_types(residue_types : rosetta.utility.vector1_std_shared_ptr_const_core_chemical_ResidueType_t) -> NoneType

This is a subroutine/helper function to reorder saccharide ResidueTypes generated from an IUPAC sequence.

res_in_chain(...)

 

res_in_chain(pose : rosetta.core.pose.Pose, resnum : int, chain : unicode) -> bool

Is residue number in this chain?

residue_center_of_mass(*args, **kwargs)

 
Overloaded function.

1. residue_center_of_mass(pose : rosetta.core.pose.Pose, residues : rosetta.utility.vector1_bool) -> int

2. residue_center_of_mass(pose : rosetta.core.pose.Pose, start : int, stop : int) -> int

residue_types_from_saccharide_sequence(...)

 
residue_types_from_saccharide_sequence(sequence : unicode, residue_set : rosetta.core.chemical.ResidueTypeSet) -> rosetta.utility.vector1_std_shared_ptr_const_core_chemical_ResidueType_t

Return a list of carbohydrate ResidueTypes corresponding to an annotated, linear, IUPAC polysaccharide
 sequence.

residue_types_from_sequence(*args, **kwargs)

 
Overloaded function.

1. residue_types_from_sequence(sequence_in : unicode, residue_set : rosetta.core.chemical.ResidueTypeSet) -> rosetta.utility.vector1_std_shared_ptr_const_core_chemical_ResidueType_t

return a list of ResidueTypes corresponding to an annotated protein sequence
 

 an annotated sequence
 

 the desired residue set
 

 mark position 1, last_residue with lower, upper termini; default true

2. residue_types_from_sequence(sequence_in : unicode, residue_set : rosetta.core.chemical.ResidueTypeSet, auto_termini : bool) -> rosetta.utility.vector1_std_shared_ptr_const_core_chemical_ResidueType_t

return a list of ResidueTypes corresponding to an annotated protein sequence
 

 an annotated sequence
 

 the desired residue set
 

 mark position 1, last_residue with lower, upper termini; default true

return_nearest_residue(*args, **kwargs)

 
Overloaded function.

1. return_nearest_residue(pose : rosetta.core.pose.Pose, residues : rosetta.utility.vector1_bool, center : rosetta.numeric.xyzVector_double_t) -> int

2. return_nearest_residue(pose : rosetta.core.pose.Pose, begin : int, end : int, center : rosetta.numeric.xyzVector_double_t) -> int

sequence_map_from_pdbinfo(...)

 
sequence_map_from_pdbinfo(first : rosetta.core.pose.Pose, second : rosetta.core.pose.Pose) -> rosetta.core.id.SequenceMapping

Create a sequence map of first pose onto the second, matching the PDBInfo
    If the PDBInfo of either Pose is missing or invalid, do a simple sequence alignment matching.

setPoseExtraScore(*args, **kwargs)

 
Overloaded function.

1. setPoseExtraScore(pose : rosetta.core.pose.Pose, name : unicode, value : float) -> NoneType

2. setPoseExtraScore(pose : rosetta.core.pose.Pose, name : unicode, value : unicode) -> NoneType

set_bb_torsion(...)

 
set_bb_torsion(torsion_id : int, pose : rosetta.core.pose.Pose, sequence_position : int, new_angle : float) -> NoneType

Set the BB torsion, phi, psi, omega (see core::types).
 Works with carbohydrates.
 Think about moving this to pose itself.

set_bfactors_from_atom_id_map(...)

 

set_bfactors_from_atom_id_map(pose : rosetta.core.pose.Pose, bfactors : rosetta.core.id.AtomID_Map_double_t) -> NoneType

Set bfactors in a pose PDBInfo

set_ss_from_phipsi(...)

 
set_ss_from_phipsi(pose : rosetta.core.pose.Pose) -> NoneType

Analyzes  <pose>  residue phi/psi sets and guesses the secondary
 structure, ideally dssp should be used for that

setup_dof_mask_from_move_map(...)

 

setup_dof_mask_from_move_map(mm : core::kinematics::MoveMap, pose : rosetta.core.pose.Pose, dof_mask : rosetta.core.id.DOF_ID_Map_bool_t) -> NoneType

convert from allow-bb/allow-chi MoveMap to simple DOF_ID boolean mask needed by the minimizer

setup_dof_to_torsion_map(...)

 

setup_dof_to_torsion_map(pose : rosetta.core.pose.Pose, dof_map : rosetta.core.id.DOF_ID_Map_core_id_TorsionID_t) -> NoneType

set up a map to look up TORSION_ID by DOF_ID (Map[DOF_ID] = TORISION_ID)

swap_transform(...)

 

swap_transform(jump_num : int, xform : rosetta.core.kinematics.RT, pose : rosetta.core.pose.Pose) -> NoneType

Updates the rigid-body transform of the specified jump in <pose>

tag_from_pose(...)

 

tag_from_pose(pose : rosetta.core.pose.Pose) -> unicode

////////////////////////////////////////////////////////////////

transfer_phi_psi(*args, **kwargs)

 
Overloaded function.

1. transfer_phi_psi(srcpose : rosetta.core.pose.Pose, tgtpose : rosetta.core.pose.Pose, ir : int, jr : int) -> NoneType

2. transfer_phi_psi(srcpose : rosetta.core.pose.Pose, tgtpose : rosetta.core.pose.Pose) -> NoneType


Variables Details [hide private]

PoseCoordPickMode_CB_else_CA

Value:
PoseCoordPickMode.PoseCoordPickMode_CB_else_CA

PoseCoordPickMode_CBorCA

Value:
PoseCoordPickMode.PoseCoordPickMode_CBorCA

PoseCoordPickMode_HVY_IF_NP

Value:
PoseCoordPickMode.PoseCoordPickMode_HVY_IF_NP

PoseCoordPickMode_N_CA_C

Value:
PoseCoordPickMode.PoseCoordPickMode_N_CA_C

PoseCoordPickMode_N_CA_C_CB

Value:
PoseCoordPickMode.PoseCoordPickMode_N_CA_C_CB

PoseCoordPickMode_N_C_O

Value:
PoseCoordPickMode.PoseCoordPickMode_N_C_O