mmtbx - macromolecular crystallography¶
The mmtbx
module has two purposes: firstly, it introduces additional
crystallographic algorithms that are traditionally specific to macromolecular
structures, such as bulk-solvent correction, absolute scaling, maximum
likelihood targets, non-crystallographic symmetry, weighted maps, and
real-space refinement; and secondly, it provides many
higher-level classes for querying and manipulating molecular structures and
writing full-featured macromolecular crystallography applications. Most of the
core functions of the program phenix.refine are
part of mmtbx, and the module also includes the complete code for the
programs phenix.xtriage
, phenix.maps
, phenix.ensemble_refinement
,
phenix.model_vs_data
, and phenix.pdbtools
, plus the backend logic for
the MolProbity server.
For new developers, the module mmtbx.command_line
provides a
simplified frontend for running routine setup tasks (such as bulk solvent
correction or geometry restraints interpretation) and populating many of the
standard data structures. (The source code also provides a suitable example
should you wish to instantiate these objects yourself.) However, since the
resulting objects tend to be especially complex, some knowledge of their
internals and purpose is helpful.
The most important modules in mmtbx
can be summarized as follows:
mmtbx.f_model
: encapsulates most functionality for calculating F(model) (i.e. F(calc)) and comparing it against experimental data. The calculation of weighted electron density maps usually starts from this point.mmtbx.monomer_library.pdb_interpretation
: processing of models (in PDB or mmCIF format) and interpretation with respect to a library of geometry restraints (provided as part of Phenix, but the CCP4 Monomer Library may also be used).mmtbx.scaling
: absolute scaling routines plus analyses of experimental data to assess quality and detect possible pathologies such as twinning. This module is slightly misnamed, since it is primarily used as the backend forXtriage
.mmtbx.validation
: tools for assessing model quality, based either on geometric criteria or fit to data. Also seemmtbx.rotamer
, the lower-level code for analyzing conformation.mmtbx.refinement
: routines for model optimization against either reciprocal space or real-space (i.e. electron density map) data.mmtbx.pdbtools
: a small library (as well as a standalone program) for various common model manipulations.
Subpackages¶
- mmtbx.building package
- Submodules
- mmtbx.building.extend_sidechains module
- mmtbx.building.make_library module
ensembler
extract_and_superpose()
extract_peptide_fragments_by_sequence()
extract_related_models
fetch_similar_pdb_ids()
find_similar_chains()
join_hierarchies()
load_all_models_in_directory()
load_pdb_models()
load_related_models_from_pdb()
load_related_models_in_directory()
related_chain
selection_by_symmetry()
- Module contents
atom_group_as_hierarchy()
box_build_refine_base
box_build_refine_base.anneal()
box_build_refine_base.cc_model_map()
box_build_refine_base.fit_residue_in_box()
box_build_refine_base.geometry_minimization()
box_build_refine_base.get_selected_sites()
box_build_refine_base.mean_density_at_sites()
box_build_refine_base.only_residue()
box_build_refine_base.real_space_refine()
box_build_refine_base.restrain_atoms()
box_build_refine_base.update_coordinates()
box_build_refine_base.update_original_coordinates()
box_build_refine_base.update_sites_from_pdb_atoms()
extract_iselection()
generate_sidechain_clusters()
get_difference_maps()
get_model_map_stats()
get_nearby_water_selection()
get_non_hydrogen_atom_indices()
get_window_around_residue()
is_stub_residue()
iter_residue_groups()
local_density_quality
local_density_quality.atoms_below_fofc_map_level()
local_density_quality.atoms_below_two_fofc_map_level()
local_density_quality.atoms_outside_density()
local_density_quality.density_at_atom()
local_density_quality.fraction_of_nearby_grid_points_above_cutoff()
local_density_quality.max_fofc_value()
local_density_quality.number_of_atoms_below_fofc_map_level()
local_density_quality.number_of_atoms_below_two_fofc_map_level()
local_density_quality.number_of_atoms_outside_density()
local_density_quality.show_atoms_outside_density()
remove_sidechain_atoms()
reprocess_pdb()
residue_density_quality()
residues_are_adjacent()
run_real_space_annealing()
show_chain_resseq_ranges()
- mmtbx.bulk_solvent package
- Submodules
- mmtbx.bulk_solvent.bulk_solvent_and_scaling module
bulk_solvent_and_scales
bulk_solvent_and_scales.apply_back_trace_of_overall_exp_scale_matrix()
bulk_solvent_and_scales.b_cart()
bulk_solvent_and_scales.b_sols()
bulk_solvent_and_scales.format_scale_matrix()
bulk_solvent_and_scales.k_anisotropic()
bulk_solvent_and_scales.k_isotropic()
bulk_solvent_and_scales.k_masks()
bulk_solvent_and_scales.k_sols()
bulk_solvent_and_scales.r_all()
bulk_solvent_and_scales.r_factor()
bulk_solvent_and_scales.u_star()
k_sol_b_sol_b_cart_minimizer()
kb_range()
ksol_bsol_result
- mmtbx.bulk_solvent.scaler module
moving_average()
run
run.anisotropic_scaling()
run.apply_back_trace_of_overall_exp_scale_matrix()
run.apply_overall_scale()
run.bulk_solvent_scaling()
run.estimate_scale_k1()
run.format_scale_matrix()
run.get_k_total()
run.is_converged()
run.is_flags_good()
run.k_anisotropic()
run.k_isotropic()
run.k_mask_grid_search()
run.k_masks()
run.overall_isotropic_kb_estimate()
run.populate_bin_to_individual_k_mask_linear_interpolation()
run.r_all()
run.r_factor()
run.r_work()
run.set_k_isotropic_exp()
run.show()
run.smooth()
run.try_scale()
run_simple()
tmp
- Module contents
- mmtbx.cablam package
- mmtbx.chemical_components package
- Submodules
- mmtbx.chemical_components.cif_parser module
- Module contents
find_data_dir()
generate_chemical_components_codes()
get_alternative_name()
get_as_atom_group()
get_as_hierarchy()
get_atom_names()
get_atom_type_symbol()
get_bond_pairs()
get_cif_dictionary()
get_cif_filename()
get_field_simple()
get_group()
get_header()
get_hydrogen_names()
get_name()
get_restraints_group()
get_smiles()
get_type()
is_chemical_components_file()
is_code()
is_residue_specified()
- mmtbx.command_line package
- API documentation
check_files()
generate_master_phil_with_inputs()
generic_simple_input_phil()
load_and_validate_unmerged_data()
load_model_and_data
load_model_and_data.args
load_model_and_data.cif_file_names
load_model_and_data.cif_objects
load_model_and_data.crystal_symmetry
load_model_and_data.f_obs
load_model_and_data.fmodel
load_model_and_data.geometry
load_model_and_data.hl_coeffs
load_model_and_data.intensity_flag
load_model_and_data.log
load_model_and_data.master_phil
load_model_and_data.miller_arrays
load_model_and_data.params
load_model_and_data.pdb_file_names
load_model_and_data.pdb_hierarchy
load_model_and_data.pdb_inp
load_model_and_data.processed_pdb_file
load_model_and_data.r_free_flags
load_model_and_data.raw_data
load_model_and_data.raw_flags
load_model_and_data.sequence
load_model_and_data.test_flag_value
load_model_and_data.unknown_residues_flag
load_model_and_data.unknown_residues_error_message
load_model_and_data.unmerged_i_obs
load_model_and_data.working_phil
load_model_and_data.xray_structure
load_model_and_data.create_model_manager()
load_model_and_data.save_data_mtz()
load_model_and_data.start_log_file()
show_symmetry_error()
validate_input_params()
- API documentation
- mmtbx.conformation_dependent_library package
- Submodules
- mmtbx.conformation_dependent_library.altloc_weighting module
- mmtbx.conformation_dependent_library.bond_angle_registry module
- mmtbx.conformation_dependent_library.cdl_database module
- mmtbx.conformation_dependent_library.rdl_database module
- mmtbx.conformation_dependent_library.rotamers module
- mmtbx.conformation_dependent_library.tst_cdl module
- mmtbx.conformation_dependent_library.test_interpolation module
- mmtbx.conformation_dependent_library.tst_rdl module
- mmtbx.conformation_dependent_library.utils module
- Module contents
- mmtbx.den package
- Submodules
- mmtbx.den.plot_weights module
- mmtbx.den.refinement module
- Module contents
den_restraints
den_restraints.build_den_proxies()
den_restraints.build_den_restraints()
den_restraints.check_den_pair_consistency()
den_restraints.count_atoms_per_chain()
den_restraints.dump_den_network()
den_restraints.find_atom_pairs()
den_restraints.get_current_eq_distances()
den_restraints.get_den_atom_pairs()
den_restraints.get_n_proxies()
den_restraints.get_optimization_grid()
den_restraints.get_selection_strings()
den_restraints.import_eq_distances()
den_restraints.load_den_network()
den_restraints.output_kinemage()
den_restraints.proxy_select()
den_restraints.remove_non_matching_pairs()
den_restraints.select_random_den_restraints()
den_restraints.show_den_summary()
den_restraints.target_and_gradients()
den_restraints.update_eq_distances()
distance_squared()
- mmtbx.density_modification package
- Module contents
density_modification
density_modification.active_indices
density_modification.anisotropic_correction()
density_modification.calculate_solvent_mask()
density_modification.compute_map()
density_modification.compute_map_coefficients()
density_modification.compute_phase_source()
density_modification.d_min
density_modification.density_truncation()
density_modification.f_obs_active
density_modification.get_stats()
density_modification.hl_coeffs_in_original_setting
density_modification.map_coeffs_in_original_setting
density_modification.matthews_analysis()
density_modification.miller_array_in_original_setting()
density_modification.ncs_averaging()
density_modification.next_cycle()
density_modification.radius
density_modification.show_cycle_summary()
density_modification.solvent_adjust()
density_modification.solvent_flattening()
density_modification.solvent_flipping()
density_modification.start_and_end_fom()
dm_stats
local_standard_deviation_map
rms()
- Module contents
- mmtbx.dynamics package
- Submodules
- mmtbx.dynamics.cartesian_dynamics module
- mmtbx.dynamics.constants module
- mmtbx.dynamics.ensemble_cd module
cartesian_dynamics
cartesian_dynamics.accelerations()
cartesian_dynamics.center_of_mass_info()
cartesian_dynamics.interleaved_minimization()
cartesian_dynamics.print_detailed_dynamics_stats()
cartesian_dynamics.set_velocities()
cartesian_dynamics.stop_global_motion()
cartesian_dynamics.store_temperatures()
cartesian_dynamics.velocity_rescaling()
cartesian_dynamics.verlet_leapfrog_integration()
cartesian_dynamics.xray_grads()
interleaved_lbfgs_minimization
random_velocities()
- mmtbx.dynamics.simulated_annealing module
- Module contents
- mmtbx.f_model
- mmtbx.geometry package
- Submodules
- mmtbx.geometry.altloc module
- mmtbx.geometry.asa module
AccessibleSurfaceAreas
AccessibleSurfaceResult
CompositeCheckerBuilder
SeparateCheckerBuilder
altloc_averaged_calculation()
calculate()
coordinate_adaptor()
create_and_populate_indexer()
create_description()
get_hash_indexer_for()
get_linear_indexer_for()
get_optimal_indexer_for()
get_voxelizer_for()
identity()
radius_adaptor()
simple_surface_calculation()
- mmtbx.geometry.clash module
ASUContent
AtomDescriptor
Case
ClashCalculation
ClashCollection
ClashCountCalculation
ClashPoint
ClashingPair
DistanceCalculation
ElementAccumulator
Model
ReducingAccumulator
SphereModel
SphereModelGroup
SymmetryEquivalent
altloc_strategy_from_atom()
calculate()
calculate_contents()
element_of()
hash_indexer_for()
linear_indexer_for()
to_xray_structure()
- mmtbx.geometry.indexing module
composite_predicate
containment_predicate
direct()
filter()
identity_predicate
overlap_predicate
structure_indexer
structure_indexer.add_atoms_in()
structure_indexer.composite_distance_predicate()
structure_indexer.coordinate_of()
structure_indexer.data_of()
structure_indexer.exclude_predicate()
structure_indexer.hash()
structure_indexer.identity_predicate()
structure_indexer.include_predicate()
structure_indexer.interaction_counts_with()
structure_indexer.interaction_ranges_with()
structure_indexer.interactions_with()
structure_indexer.overlap_predicate()
structure_indexer.simple_distance_predicate()
- mmtbx.geometry.primitive module
- mmtbx.geometry.shared_types module
- mmtbx.geometry.sphere_surface_sampling module
- mmtbx.geometry.topology module
- mmtbx.geometry.volume module
- Module contents
- mmtbx.geometry_restraints package
- Submodules
- mmtbx.geometry_restraints.c_beta module
- mmtbx.geometry_restraints.external module
- mmtbx.geometry_restraints.flags module
- mmtbx.geometry_restraints.hbond module
- mmtbx.geometry_restraints.ramachandran module
is_proxy_present()
load_emsley8k_tables()
load_phi_psi_2_tables()
load_tables()
ramachandran_manager
ramachandran_manager.append_emsley8k_proxies()
ramachandran_manager.append_emsley_proxies()
ramachandran_manager.append_oldfield_proxies()
ramachandran_manager.append_phi_psi_2_proxies()
ramachandran_manager.extract_proxies()
ramachandran_manager.get_n_emsley8k_proxies()
ramachandran_manager.get_n_emsley_proxies()
ramachandran_manager.get_n_oldfield_proxies()
ramachandran_manager.get_n_phi_psi_2_proxies()
ramachandran_manager.get_n_proxies()
ramachandran_manager.proxy_select()
ramachandran_manager.show_sorted()
ramachandran_manager.target_and_gradients()
ramachandran_manager.update_phi_psi_targets()
ramachandran_manager.update_phi_psi_targets_on_init()
ramachandran_plot_data
- mmtbx.geometry_restraints.reference module
- mmtbx.geometry_restraints.rotamer module
- Module contents
- mmtbx.hydrogens package
- Submodules
- mmtbx.hydrogens.build_hydrogens module
- mmtbx.hydrogens.find module
all_master_params()
assert_water_is_consistent()
atom_as_str()
atom_scat()
build_dod_and_od()
build_water_hydrogens_from_map()
build_water_hydrogens_from_map2()
choose_h_for_water()
distances_to_peaks()
extract_hoh_peaks()
find_hydrogen_peaks()
fit_water()
get_pdb_oxygen()
h_peak
insert_atom_into_model()
len_peaks()
make_peak_dict()
map_peak_filter()
match_dod()
match_od()
obs_map()
one_water_correlation()
print_atom()
print_scat()
print_scats()
remove_zero_occupancy()
run()
scatterers_info()
select_one_water()
water_and_peaks
water_bond_angle()
water_map_correlations()
- Module contents
- mmtbx.ias package
- mmtbx.ions package
- Subpackages
- mmtbx.ions.svm package
- Submodules
- Module contents
ion_anomalous_vector()
ion_class()
ion_electron_density_vector()
ion_geometry_vector()
ion_model_vector()
ion_nearby_atoms_vector()
ion_valence_vector()
ion_vector()
manager
predict_ion()
svm_prediction
svm_prediction.i_seq
svm_prediction.pdb_id_str
svm_prediction.atom_info_str
svm_prediction.map_stats
svm_prediction.atom_types
svm_prediction.scores
svm_prediction.final_choice
svm_prediction.atom_info_str
svm_prediction.atom_types
svm_prediction.final_choice
svm_prediction.i_seq
svm_prediction.map_stats
svm_prediction.pdb_id_str
svm_prediction.scores
svm_prediction.show()
svm_prediction.show_brief()
- mmtbx.ions.svm package
- Submodules
- mmtbx.ions.build module
- mmtbx.ions.environment module
ChemicalEnvironment
ChemicalEnvironment.atom
ChemicalEnvironment.contacts
ChemicalEnvironment.contacts_no_alts
ChemicalEnvironment.chemistry
ChemicalEnvironment.geometry
ChemicalEnvironment.atom
ChemicalEnvironment.chemistry
ChemicalEnvironment.contacts
ChemicalEnvironment.contacts_no_alts
ChemicalEnvironment.geometry
ChemicalEnvironment.get_valence()
ScatteringEnvironment
ScatteringEnvironment.d_min
ScatteringEnvironment.wavelengeth
ScatteringEnvironment.fp
ScatteringEnvironment.fpp
ScatteringEnvironment.b_iso
ScatteringEnvironment.b_mean_hoh
ScatteringEnvironment.occ
ScatteringEnvironment.fo_density
ScatteringEnvironment.fofo_density
ScatteringEnvironment.anom_density
ScatteringEnvironment.pai
ScatteringEnvironment.anom_density
ScatteringEnvironment.b_iso
ScatteringEnvironment.b_mean_hoh
ScatteringEnvironment.d_min
ScatteringEnvironment.fo_density
ScatteringEnvironment.fofc_density
ScatteringEnvironment.fp
ScatteringEnvironment.fpp
ScatteringEnvironment.occ
ScatteringEnvironment.pai
ScatteringEnvironment.wavelength
atom_contact
atom_contact.atom
atom_contact.charge
atom_contact.element
atom_contact.rt_mx
atom_contact.site_cart
atom_contact.vector
atom_contact.altloc()
atom_contact.atom
atom_contact.atom_i_seq()
atom_contact.atom_id_no_altloc()
atom_contact.atom_name()
atom_contact.charge
atom_contact.distance()
atom_contact.distance_from()
atom_contact.element
atom_contact.id_str()
atom_contact.is_carboxy_terminus
atom_contact.occ
atom_contact.resname()
atom_contact.rt_mx
atom_contact.site_cart
atom_contact.vector
find_nearby_atoms()
- mmtbx.ions.geometry module
- mmtbx.ions.halides module
- mmtbx.ions.identify module
AtomProperties
AtomProperties.ANOM_PEAK
AtomProperties.BAD_COORD_ATOM
AtomProperties.BAD_COORD_RESIDUE
AtomProperties.BAD_FPP
AtomProperties.BAD_GEOMETRY
AtomProperties.BAD_HALIDE
AtomProperties.BAD_VALENCES
AtomProperties.BAD_VECTORS
AtomProperties.CLOSE_CONTACT
AtomProperties.COORDING_GEOMETRY
AtomProperties.FOFC_HOLE
AtomProperties.FOFC_PEAK
AtomProperties.HIGH_2FOFC
AtomProperties.HIGH_B
AtomProperties.HIGH_OCC
AtomProperties.LIKE_COORD
AtomProperties.LOW_B
AtomProperties.LOW_OCC
AtomProperties.NO_2FOFC_PEAK
AtomProperties.NO_ANOM_PEAK
AtomProperties.NO_GEOMETRY
AtomProperties.TOO_FEW_COORD
AtomProperties.TOO_FEW_NON_WATERS
AtomProperties.TOO_MANY_COORD
AtomProperties.VERY_BAD_VALENCES
AtomProperties.atom_weight()
AtomProperties.check_fpp_ratio()
AtomProperties.check_ion_environment()
AtomProperties.error_strs
AtomProperties.get_atom_type()
AtomProperties.has_compatible_ligands()
AtomProperties.identity()
AtomProperties.is_compatible_anomalous_scattering()
AtomProperties.is_compatible_site()
AtomProperties.is_correctly_identified()
AtomProperties.looks_like_nucleotide_phosphate_site()
AtomProperties.number_of_atoms_within_radius()
AtomProperties.number_of_backbone_oxygens()
AtomProperties.number_of_favored_ligand_residues()
AtomProperties.show_ion_results()
AtomProperties.show_properties()
create_manager()
find_anomalous_scatterers()
ion_master_phil()
ion_result
ion_result.altloc
ion_result.atom_selection
ion_result.b_iso
ion_result.chain_id
ion_result.chem_env
ion_result.element
ion_result.icode
ion_result.model_id
ion_result.name
ion_result.occupancy
ion_result.outlier
ion_result.resname
ion_result.resseq
ion_result.scatter_env
ion_result.score
ion_result.segid
ion_result.show()
ion_result.show_brief()
ion_result.symop
ion_result.xyz
manager
manager.analyze_substructure()
manager.analyze_water()
manager.analyze_waters()
manager.find_nearby_atoms()
manager.get_b_iso()
manager.get_fp()
manager.get_fpp()
manager.get_initial_b_iso()
manager.get_map()
manager.get_map_gaussian_fit()
manager.get_map_sphere_variance()
manager.get_strict_valence_flag()
manager.guess_b_iso_real()
manager.guess_molecular_weight()
manager.looks_like_halide_ion()
manager.map_stats()
manager.principal_axes_of_inertia()
manager.refine_anomalous_substructure()
manager.show_current_scattering_statistics()
manager.update_maps()
manager.update_structure()
manager.validate_ion()
manager.validate_ions()
manager.water_selection()
water_result
- mmtbx.ions.utils module
- Module contents
atom_type_flags
atom_type_flags.bad_coord_atom
atom_type_flags.bad_coord_residue
atom_type_flags.bad_geom
atom_type_flags.bad_halide
atom_type_flags.bad_valence
atom_type_flags.bad_vectors
atom_type_flags.close_contact
atom_type_flags.coord_geom
atom_type_flags.flag_names_and_labels
atom_type_flags.get_flag_captions()
atom_type_flags.high_anom
atom_type_flags.high_b_iso
atom_type_flags.high_fdp
atom_type_flags.high_fofc
atom_type_flags.high_occ
atom_type_flags.high_two_fofc
atom_type_flags.like_coord
atom_type_flags.low_anom
atom_type_flags.low_b_iso
atom_type_flags.low_fdp
atom_type_flags.low_fofc
atom_type_flags.low_occ
atom_type_flags.low_two_fofc
atom_type_flags.missing_geom
atom_type_flags.name
atom_type_flags.show()
atom_type_flags.too_few_coord
atom_type_flags.too_few_non_waters
atom_type_flags.too_many_coord
atom_type_flags.very_bad_valence
check_supported()
metal_parameters
parameter_server
parameter_server.params
parameter_server.calculate_valence()
parameter_server.calculate_valences()
parameter_server.get_charge()
parameter_server.get_charges()
parameter_server.get_element()
parameter_server.get_metal_parameters()
parameter_server.get_valence_params()
parameter_server.is_supported_donor()
parameter_server.is_supported_element()
parameter_server.params
- Subpackages
- mmtbx.kinemage package
- Submodules
- mmtbx.kinemage.validation module
add_fan()
add_spring()
angle_outlier_as_kinemage()
bond_outlier_as_kinemage()
build_name_hash()
cbeta_dev()
chiral_outlier_as_kinemage()
export_molprobity_result_as_kinemage()
get_altid_controls()
get_angle_outliers()
get_bond_outliers()
get_chain_color()
get_default_header()
get_footer()
get_ions()
get_kin_lots()
get_master_phil()
get_residue_bonds()
make_multikin()
make_probe_dots()
midpoint()
pperp_outliers()
rama_outliers()
rotamer_outliers()
run()
usage()
- Module contents
- mmtbx.maps package
- Submodules
- mmtbx.maps.composite_omit_map module
- mmtbx.maps.fem module
- mmtbx.maps.fobs_minus_fobs_map module
- mmtbx.maps.kick module
- mmtbx.maps.superpose module
- mmtbx.maps.utils module
create_map_from_pdb_and_mtz()
decode_resolve_map_coeffs()
extract_map_coeffs()
extract_phenix_refine_map_coeffs()
fast_maps_from_hkl_file
format_map_coeffs_for_resolve()
generate_water_omit_map
get_anomalous_map()
get_default_map_coefficients_phil()
get_map_coeff_labels()
get_map_coeffs_for_build()
get_maps_from_fmodel()
map_coeffs_from_mtz_file()
write_map_coeffs()
write_xplor_map()
write_xplor_map_file()
- Module contents
- mmtbx.masks package
- mmtbx.max_lik package
- Submodules
- mmtbx.max_lik.max_like_non_uniform module
- mmtbx.max_lik.maxlik module
- Module contents
- mmtbx.monomer_library package
- Submodules
- mmtbx.monomer_library.bondlength_defaults module
- mmtbx.monomer_library.cif_triage module
- mmtbx.monomer_library.cif_types module
apply_chem_mod_list()
chem_comp
chem_comp_angle
chem_comp_atom
chem_comp_bond
chem_comp_chir
chem_comp_deriv
chem_comp_plane_atom
chem_comp_rotamer_info
chem_comp_synonym
chem_comp_synonym_atom
chem_comp_tor
chem_comp_tree
chem_link
chem_link_angle
chem_link_bond
chem_link_chir
chem_link_plane
chem_link_tor
chem_mod
chem_mod_angle
chem_mod_atom
chem_mod_bond
chem_mod_chir
chem_mod_plane_atom
chem_mod_tor
chem_mod_tree
chem_plane
comp_comp_id
comp_comp_id.angle_list
comp_comp_id.apply_mod()
comp_comp_id.as_geometry_restraints_motif()
comp_comp_id.atom_by_id()
comp_comp_id.atom_dict()
comp_comp_id.atom_ids()
comp_comp_id.atom_list
comp_comp_id.bond_list
comp_comp_id.change_atom_in_place()
comp_comp_id.chem_comp
comp_comp_id.chir_list
comp_comp_id.cif_object
comp_comp_id.classification
comp_comp_id.delete_atom_in_place()
comp_comp_id.get_angle()
comp_comp_id.get_bond()
comp_comp_id.get_chir_bonds_and_angles()
comp_comp_id.get_chir_volume_ideal()
comp_comp_id.get_classification()
comp_comp_id.get_planes()
comp_comp_id.hydrogen_deuterium_aliases()
comp_comp_id.i_atom_by_id()
comp_comp_id.is_dna()
comp_comp_id.is_peptide()
comp_comp_id.is_rna()
comp_comp_id.is_rna_dna()
comp_comp_id.is_water()
comp_comp_id.non_hydrogen_atoms()
comp_comp_id.normalize_atom_ids_in_place()
comp_comp_id.normalized_angle_list()
comp_comp_id.normalized_bond_list()
comp_comp_id.normalized_rna_dna
comp_comp_id.plane_atom_list
comp_comp_id.rotamer_info()
comp_comp_id.rotamer_info_phil_str_list
comp_comp_id.rotamer_iterator()
comp_comp_id.set_classification()
comp_comp_id.show()
comp_comp_id.source_info
comp_comp_id.test_for_peptide()
comp_comp_id.test_for_rna_dna()
comp_comp_id.test_for_water()
comp_comp_id.tor_list
energy_lib_atom
energy_lib_synonym
energy_lib_vdw
esd_as_weight()
get_bond()
get_chir_volume_ideal()
group_planes()
link_link_id
looped_data
mod_mod_id
new_if_defined()
normalized_bond_list()
show_loop()
- mmtbx.monomer_library.conformation_dependent_restraints module
- mmtbx.monomer_library.conv_v2_v3 module
- mmtbx.monomer_library.correct_hydrogen_geometries module
- mmtbx.monomer_library.glyco_chiral_values module
- mmtbx.monomer_library.glyco_utils module
apply_glyco_link_using_proxies_and_atoms()
generate_atoms_from_atom_groups()
get_C1_carbon()
get_alpha_beta()
get_anomeric_carbon()
get_anomeric_hydrogen()
get_any_linking_carbon()
get_chiral_sign()
get_distance2()
get_glyco_link_atoms()
get_link_carbon()
get_link_carbon_on_distance()
get_link_oxygen()
get_link_oxygen_on_distance()
get_link_phi_carbon()
get_ring_carbon()
get_ring_oxygen()
get_ring_oxygen_substitute()
glyco_link_class
is_standard_glyco_link()
- mmtbx.monomer_library.hydrogen_restrictions module
- mmtbx.monomer_library.idealized_aa module
- mmtbx.monomer_library.linking_mixins module
- mmtbx.monomer_library.linking_setup module
- mmtbx.monomer_library.linking_utils module
check_for_acid()
check_valence()
check_valence_and_acid()
empty
generate_atoms_from_atom_groups()
get_angles_from_included_bonds()
get_bonded()
get_bonded_from_atom_groups()
get_chiral_volume()
get_classes()
get_distance2()
get_hand()
get_volume()
is_atom_group_pair_linked()
is_atom_metal_coordinated()
is_atom_pair_linked()
is_atom_pair_linked_tuple()
is_glyco_amino_bond()
is_glyco_bond()
is_n_glyco_bond()
is_o_glyco_bond()
print_apply()
process_atom_groups_for_linking_single_link()
- mmtbx.monomer_library.pdb_interpretation module
ad_hoc_single_atom_residue
add_angle_proxies
add_bond_proxies
add_chirality_proxies
add_dihedral_proxies
add_parallelity_proxies
add_planarity_proxies
all_atoms_are_in_main_conf()
build_all_chain_proxies
build_all_chain_proxies.atom_selection()
build_all_chain_proxies.construct_geometry_restraints_manager()
build_all_chain_proxies.create_disulfides()
build_all_chain_proxies.create_link()
build_all_chain_proxies.extract_secondary_structure()
build_all_chain_proxies.extract_xray_structure()
build_all_chain_proxies.fatal_problems_message()
build_all_chain_proxies.fatal_problems_report()
build_all_chain_proxies.iselection()
build_all_chain_proxies.phil_atom_selection()
build_all_chain_proxies.phil_atom_selection_multiple()
build_all_chain_proxies.phil_atom_selections_as_i_seqs()
build_all_chain_proxies.phil_atom_selections_as_i_seqs_multiple()
build_all_chain_proxies.process_apply_cif_link()
build_all_chain_proxies.process_apply_cif_modification()
build_all_chain_proxies.process_custom_links()
build_all_chain_proxies.process_custom_nonbonded_exclusions()
build_all_chain_proxies.process_custom_nonbonded_symmetry_exclusions()
build_all_chain_proxies.process_geometry_restraints_edits()
build_all_chain_proxies.process_geometry_restraints_edits_angle()
build_all_chain_proxies.process_geometry_restraints_edits_bond()
build_all_chain_proxies.process_geometry_restraints_edits_dihedral()
build_all_chain_proxies.process_geometry_restraints_edits_parallelity()
build_all_chain_proxies.process_geometry_restraints_edits_planarity()
build_all_chain_proxies.process_geometry_restraints_remove()
build_all_chain_proxies.process_geometry_restraints_scale()
build_all_chain_proxies.process_hydrogen_bonds()
build_all_chain_proxies.sel_backbone()
build_all_chain_proxies.sel_backbone_or_sidechain()
build_all_chain_proxies.sel_classification()
build_all_chain_proxies.sel_phosphate()
build_all_chain_proxies.sel_ribose()
build_all_chain_proxies.sel_sidechain()
build_all_chain_proxies.sel_within()
build_all_chain_proxies.selection()
build_all_chain_proxies.site_symmetry_table()
build_all_chain_proxies.sites_cart_exact()
build_all_chain_proxies.update_internals_due_to_coordinates_change()
build_chain_proxies
cif_output_holder
conformer_i_seq
counters
discard_conflicting_pdb_element_column()
ener_lib_as_nonbonded_params()
evaluate_registry_process_result()
flush_log()
format_exception_message()
geometry_restraints_proxy_registries
get_lib_link()
get_lib_link_peptide()
get_restraints_loading_flags()
involves_broken_bonds()
is_same_model_as_before()
link_match
link_match_one
monomer_mapping
monomer_mapping.active_atoms
monomer_mapping.add_angle_proxies()
monomer_mapping.add_bond_proxies()
monomer_mapping.add_chirality_proxies()
monomer_mapping.add_dihedral_proxies()
monomer_mapping.add_parallelity_proxies()
monomer_mapping.add_planarity_proxies()
monomer_mapping.angle_counters
monomer_mapping.apply_mod()
monomer_mapping.atom_name_interpretation
monomer_mapping.atom_names_given
monomer_mapping.atom_names_mappings
monomer_mapping.bond_counters
monomer_mapping.chainid
monomer_mapping.chem_mod_ids
monomer_mapping.chirality_counters
monomer_mapping.classification
monomer_mapping.conf_altloc
monomer_mapping.dihedral_counters
monomer_mapping.duplicate_atoms
monomer_mapping.expected_atoms
monomer_mapping.i_conformer
monomer_mapping.ignored_atoms
monomer_mapping.incomplete_info
monomer_mapping.is_first_conformer_in_chain
monomer_mapping.is_rna2p
monomer_mapping.is_rna_dna
monomer_mapping.is_terminus
monomer_mapping.is_unusual
monomer_mapping.lib_link
monomer_mapping.missing_hydrogen_atoms
monomer_mapping.missing_non_hydrogen_atoms
monomer_mapping.mon_lib_names
monomer_mapping.mon_lib_srv
monomer_mapping.monomer
monomer_mapping.monomer_atom_dict
monomer_mapping.parallelity_counters
monomer_mapping.pdb_atoms
monomer_mapping.pdb_residue
monomer_mapping.pdb_residue_id_str
monomer_mapping.planarity_counters
monomer_mapping.residue_altloc()
monomer_mapping.residue_name
monomer_mapping.resolve_unexpected()
monomer_mapping.summary()
monomer_mapping.unexpected_atoms
monomer_mapping_summary
monomer_mapping_summary.all_associated_i_seqs()
monomer_mapping_summary.classification
monomer_mapping_summary.conf_altloc
monomer_mapping_summary.duplicate_atoms
monomer_mapping_summary.expected_atoms
monomer_mapping_summary.ignored_atoms
monomer_mapping_summary.incomplete_info
monomer_mapping_summary.is_terminus
monomer_mapping_summary.is_unusual
monomer_mapping_summary.residue_name
monomer_mapping_summary.summary()
monomer_mapping_summary.unexpected_atoms
nonbonded_energy_type_registry
print_dict()
process
residue_id_str()
run()
scattering_type_registry
selection_manager
selection_manager.iselection()
selection_manager.phil_atom_selection()
selection_manager.sel_backbone()
selection_manager.sel_backbone_or_sidechain()
selection_manager.sel_classification()
selection_manager.sel_phosphate()
selection_manager.sel_residues_within()
selection_manager.sel_ribose()
selection_manager.sel_sidechain()
selection_manager.sel_within()
selection_manager.selection()
show_residue_groups()
source_info_server
special_dispensation()
special_position_dict
type_symbol_registry_base
type_symbol_registry_base.assign_charge()
type_symbol_registry_base.assign_directly()
type_symbol_registry_base.assign_from_monomer_mapping()
type_symbol_registry_base.discard_tables()
type_symbol_registry_base.expand_with_ncs()
type_symbol_registry_base.get_unknown_atoms()
type_symbol_registry_base.n_unknown_type_symbols()
type_symbol_registry_base.report()
type_symbol_registry_base.report_unknown_message()
validate_geometry_edits_params()
- mmtbx.monomer_library.rna_sugar_pucker_analysis module
evaluate
evaluate.assign()
evaluate.delta
evaluate.epsilon
evaluate.is_2p
evaluate.is_2p_delta
evaluate.is_2p_o3p_distance_c1p_outbound_line
evaluate.is_2p_p_distance_c1p_outbound_line
evaluate.is_3p_delta
evaluate.is_delta_outlier
evaluate.is_epsilon_outlier
evaluate.o3p_distance_c1p_outbound_line
evaluate.o3p_perp_xyz
evaluate.p_distance_c1p_outbound_line
evaluate.p_perp_xyz
- mmtbx.monomer_library.rotamer_utils module
- mmtbx.monomer_library.server module
MonomerLibraryServerError
convert_comp_list()
convert_link_list()
convert_list_block()
convert_mod_list()
ener_lib
find_mon_lib_file()
geostd_list_cif()
get_rows()
id_dict
load_mon_lib_file()
merge_and_overwrite_cifs()
mon_lib_cif_loader
mon_lib_ener_lib_cif()
mon_lib_list_cif()
print_filtered_cif()
process_cif_mixin
read_cif()
server
server.convert_all()
server.convert_ccp4_tor_list()
server.convert_comp_list()
server.convert_comp_synonym_atom_list()
server.convert_comp_synonym_list()
server.convert_deriv_list_dict()
server.convert_link_list()
server.convert_mod_list()
server.get_comp_comp_id_and_atom_name_interpretation()
server.get_comp_comp_id_direct()
server.get_comp_comp_id_mod()
server.process_geostd_rna_dna()
server.rotamer_iterator()
trivial_html_tag_filter
- Module contents
- mmtbx.ncs
- Submodules
- mmtbx.ncs.ligands module
- mmtbx.ncs.ncs module
abs()
crystal_symmetry_to_ncs()
euler_frac_to_rot_trans()
generate_ncs_ops()
get_c_symmetry()
get_d_symmetry()
get_helical_symmetry()
get_ncs_from_text()
get_rot_y()
get_rot_z()
is_identity()
is_in_range()
is_same_transform()
ncs
ncs.add_cc_list()
ncs.add_identity_op()
ncs.add_source_info()
ncs.adjust_magnification()
ncs.apply_ncs_to_sites()
ncs.as_ncs_spec_string()
ncs.change_of_basis()
ncs.coordinate_offset()
ncs.deep_copy()
ncs.display_all()
ncs.extend_helix_operators()
ncs.format_all_for_biomt()
ncs.format_all_for_group_specification()
ncs.format_all_for_phenix_refine()
ncs.format_all_for_resolve()
ncs.format_phil_for_ncs()
ncs.format_phil_for_phenix_refine()
ncs.get_1_char_after_key()
ncs.get_1_value_after_key()
ncs.get_3_values_after_key()
ncs.get_helix_parameters()
ncs.get_ncs_name()
ncs.get_res_range_after_key()
ncs.identity_op_id_in_first_group()
ncs.import_ncs_group()
ncs.init_ncs_group()
ncs.init_oper()
ncs.invert_matrices()
ncs.is_helical_along_z()
ncs.is_point_group_symmetry()
ncs.is_similar_ncs_object()
ncs.magnification()
ncs.map_inside_unit_cell()
ncs.max_operators()
ncs.ncs_from_import()
ncs.ncs_from_pdb_input_BIOMT()
ncs.ncs_groups()
ncs.ncs_oper_in_first_group()
ncs.ncs_read()
ncs.overall_cc()
ncs.overall_note()
ncs.overall_rmsd()
ncs.read_ncs()
ncs.rotate_about_y()
ncs.rotate_about_z()
ncs.rotate_matrices()
ncs.save_existing_group_info()
ncs.save_ncs_group()
ncs.save_oper()
ncs.select_first_ncs_group()
ncs.select_first_ncs_operator()
ncs.set_ncs_name()
ncs.set_shift_cart()
ncs.set_unit_ncs()
ncs.shift_back_cart()
ncs.shift_cart()
ncs.show_summary()
ncs.sort_by_z_translation()
ncs_group
ncs_group.add_cc()
ncs_group.add_chain_residue_id()
ncs_group.add_identity_op()
ncs_group.add_note()
ncs_group.add_residues_in_common_list()
ncs_group.add_rmsd_list()
ncs_group.adjust_magnification()
ncs_group.apply_cob_to_vector()
ncs_group.cc()
ncs_group.centers()
ncs_group.chain_residue_id()
ncs_group.copy_rot_trans()
ncs_group.copy_vector_list()
ncs_group.deep_copy()
ncs_group.deep_copy_ops_to_keep()
ncs_group.deep_copy_order()
ncs_group.delete_inv()
ncs_group.display_summary()
ncs_group.extend_helix_operators()
ncs_group.extract_point_group_symmetry()
ncs_group.format_for_biomt()
ncs_group.format_for_phenix_refine()
ncs_group.format_for_resolve()
ncs_group.format_group_specification()
ncs_group.get_forwards_reverse_helix()
ncs_group.get_helix_parameters()
ncs_group.get_helix_theta()
ncs_group.get_helix_z_translation()
ncs_group.get_inverses()
ncs_group.get_new_group()
ncs_group.get_order_dict()
ncs_group.get_theta_along_z()
ncs_group.get_trans_along_z()
ncs_group.helix_rt_forwards()
ncs_group.helix_rt_reverse()
ncs_group.identity_op_id()
ncs_group.invert_matrices()
ncs_group.is_helical_along_z()
ncs_group.is_point_group_symmetry()
ncs_group.is_similar_ncs_group()
ncs_group.map_inside_unit_cell()
ncs_group.n_ncs_oper()
ncs_group.ncs_domain_pdb()
ncs_group.note()
ncs_group.oper_adds_offset()
ncs_group.print_list()
ncs_group.residues_in_common_list()
ncs_group.rmsd_list()
ncs_group.rota_matrices()
ncs_group.rota_matrices_inv()
ncs_group.rotate_matrices()
ncs_group.rotations_translations_forward_euler()
ncs_group.round()
ncs_group.sort_by_z_translation()
ncs_group.source_of_ncs_info()
ncs_group.translations_orth()
ncs_group.translations_orth_inv()
offset_inside_cell()
offset_inside_zero_one()
remove_extra()
remove_ncs_not_consistent_with_space_group_number()
remove_quotes_from_chain_id()
remove_single_quotes()
value()
- mmtbx.ncs.restraints module
- mmtbx.ncs.ncs_search module
Chains_info
find_ncs_in_hierarchy()
get_bool_selection_to_keep()
get_chain_xyz()
get_chains_info()
get_copy_master_selections_from_match_dict()
get_info_from_match_dict()
get_match_rmsd()
get_matching_atoms()
get_preliminary_ncs_groups()
make_flips_if_necessary_torsion()
mmtbx_res_alignment()
my_get_rot_trans()
my_selection()
ncs_grouping_and_group_dict()
remove_far_atoms()
search_ncs_relations()
shortcut_1()
- mmtbx.ncs.ncs_utils module
- Module contents
- mmtbx.pdbtools - model manipulation utilities
- mmtbx.polygon package
- Submodules
- mmtbx.polygon.output module
- Module contents
- mmtbx.real_space package
- mmtbx.refinement package
- Subpackages
- mmtbx.refinement.ensemble_refinement package
- Submodules
- mmtbx.refinement.ensemble_refinement.ensemble_utils module
closest_to_mean()
dist2()
ensemble_mean_hierarchy()
get_centroid_hierarchy()
get_rmsf_B_factor_per_residue_per_atom()
get_selected_hierarchys()
get_sites_carts()
manager
manager.bin_generator_equal_range()
manager.bin_generator_equal_size()
manager.bivariate_histogram()
manager.ensemble_mean_geometry_stats()
manager.ensemble_reduction()
manager.ensemble_rmsf_stats()
manager.kinetic_energy_stats()
manager.print_atom_statisitics()
manager.write_centroid_hierarchy()
manager.write_mean_hierarchy()
selector()
- Module contents
- mmtbx.refinement.real_space package
- Submodules
- mmtbx.refinement.real_space.fit_residue module
- mmtbx.refinement.real_space.fit_residues module
- mmtbx.refinement.real_space.fit_water module
- mmtbx.refinement.real_space.individual_sites module
- mmtbx.refinement.real_space.rigid_body module
- mmtbx.refinement.real_space.weight module
- Module contents
aa_residue_axes_and_clusters
check_sites_match()
cluster
common_map_values()
flatten()
generate_angles_nested()
get_radii()
get_radius()
negate_map_around_selected_atoms_except_selected_atoms()
residue_monitor
rsr_model
score
score2
score3
score4
selection_around_to_negate()
setup_test()
side_chain_fit_evaluator
structure_monitor
torsion_search()
torsion_search_nested()
- mmtbx.refinement.ensemble_refinement package
- Submodules
- mmtbx.refinement.adp_refinement module
- mmtbx.refinement.anomalous_scatterer_groups module
- mmtbx.refinement.fit_rotamers module
- mmtbx.refinement.flip_peptides module
- mmtbx.refinement.geometry_minimization module
- mmtbx.refinement.group module
- mmtbx.refinement.inspect_tardy_trajectory module
- mmtbx.refinement.minimization module
- mmtbx.refinement.minimization_ncs_constraints module
- mmtbx.refinement.occupancies module
- mmtbx.refinement.orca module
- mmtbx.refinement.print_statistics module
- mmtbx.refinement.refinement_flags module
- mmtbx.refinement.rigid_body module
- mmtbx.refinement.select_best_starting_model module
- mmtbx.refinement.tardy module
- mmtbx.refinement.targets module
- mmtbx.refinement.weights_params module
- mmtbx.refinement.wx_tardy_pdb module
- Module contents
- Subpackages
- mmtbx.rotamer package
- Submodules
- mmtbx.rotamer.graphics module
- mmtbx.rotamer.n_dim_table module
- mmtbx.rotamer.ramachandran_eval module
- mmtbx.rotamer.rotamer_eval module
- mmtbx.rotamer.sidechain_angles module
PropertyFile
SidechainAngles
SidechainAngles.anglesForAA
SidechainAngles.anglesForRot
SidechainAngles.atomsForAngle
SidechainAngles.atomsMoveWithAngle
SidechainAngles.chisPerAA
SidechainAngles.extract_chi_atoms()
SidechainAngles.frequencies_from_rotamer
SidechainAngles.get_rotamer_angles()
SidechainAngles.get_rotamer_expectation_frequencies()
SidechainAngles.get_rotamers()
SidechainAngles.measureAngle()
SidechainAngles.measureChiAngles()
SidechainAngles.resAtomsToChi
SidechainAngles.rotamersForAA
collect_residue_torsion_angles()
collect_sidechain_chi_angles()
find_source_dir()
makeAtomDict()
- Module contents
- mmtbx.rsr package
- mmtbx.scaling package
- Submodules
- mmtbx.scaling.absence_likelihood module
- mmtbx.scaling.absences module
- mmtbx.scaling.absolute_scaling module
anisotropic_correction()
expected_intensity
gamma_nucleic
gamma_protein
kernel_normalisation
ml_aniso_absolute_scaling
ml_aniso_absolute_scaling.analyze_aniso_correction()
ml_aniso_absolute_scaling.aniso_ratio_p_value()
ml_aniso_absolute_scaling.compute_functional_and_gradients()
ml_aniso_absolute_scaling.format_it()
ml_aniso_absolute_scaling.pack()
ml_aniso_absolute_scaling.summarize_issues()
ml_aniso_absolute_scaling.unpack()
ml_iso_absolute_scaling
scattering_information
- mmtbx.scaling.basic_analyses module
- mmtbx.scaling.data_statistics module
- mmtbx.scaling.fa_estimation module
- mmtbx.scaling.fest module
- mmtbx.scaling.make_param module
- mmtbx.scaling.massage_twin_detwin_data module
- mmtbx.scaling.matthews module
- mmtbx.scaling.outlier_plots module
- mmtbx.scaling.outlier_rejection module
outlier_manager
outlier_manager.apply_scale_to_original_data()
outlier_manager.basic_wilson_outliers()
outlier_manager.beamstop_shadow_outliers()
outlier_manager.extreme_wilson_outliers()
outlier_manager.make_log_beam_stop()
outlier_manager.make_log_model()
outlier_manager.make_log_wilson()
outlier_manager.model_based_outliers()
- mmtbx.scaling.pair_analyses module
- mmtbx.scaling.pre_scale module
- mmtbx.scaling.random_omit module
- mmtbx.scaling.relative_scaling module
- mmtbx.scaling.relative_wilson module
- mmtbx.scaling.remove_outliers module
- mmtbx.scaling.rip_scale module
- mmtbx.scaling.sad_scale module
- mmtbx.scaling.sigmaa_estimation module
- mmtbx.scaling.sir_scale module
- mmtbx.scaling.siras_scale module
- mmtbx.scaling.ta_alpha_beta_calc module
- mmtbx.scaling.thorough_outlier_test module
- mmtbx.scaling.twin_analyses module
analyze_intensity_statistics()
britton_test
correlation_analyses
detect_pseudo_translations
get_twin_laws()
h_test
l_test
merge_data_and_guess_space_groups()
ml_murray_rust
ml_murray_rust_with_ncs
n_z_test
obliquity
r_values
symmetry_issues
twin_analyses
twin_analyses_brief()
twin_law
twin_law_dependent_twin_tests
twin_law_quality
twin_laws
twin_results_interpretation
twin_results_interpretation.compute_maha_l()
twin_results_interpretation.has_abnormal_intensity_statistics()
twin_results_interpretation.has_higher_symmetry()
twin_results_interpretation.has_pseudo_translational_symmetry()
twin_results_interpretation.has_twinning()
twin_results_interpretation.make_sym_op_table()
twin_results_interpretation.max_twin_fraction()
twin_results_interpretation.patterson_verdict()
twin_results_interpretation.show_verdict()
twin_results_interpretation.summarize_issues()
weighted_cc()
wilson_moments
wilson_normalised_intensities
- mmtbx.scaling.twmad_scale module
- mmtbx.scaling.xtriage module
change_symmetry()
check_for_pathological_input_data()
data_summary
finish_job()
launcher
make_big_header()
merging_statistics
print_banner()
print_help()
run()
summary
validate_params()
xtriage_analyses
xtriage_analyses.aniso_b_min
xtriage_analyses.aniso_b_ratio
xtriage_analyses.aniso_range_of_b
xtriage_analyses.estimate_d_min()
xtriage_analyses.i_over_sigma_outer_shell
xtriage_analyses.is_twinned()
xtriage_analyses.iso_b_wilson
xtriage_analyses.l_test_mean_l
xtriage_analyses.l_test_mean_l_squared
xtriage_analyses.low_d_cut
xtriage_analyses.matthews_n_copies()
xtriage_analyses.max_estimated_twin_fraction
xtriage_analyses.new_format
xtriage_analyses.number_of_wilson_outliers
xtriage_analyses.overall_i_sig_i
xtriage_analyses.patterson_verdict
xtriage_analyses.resolution_cut()
xtriage_analyses.resolution_limit_of_anomalous_signal()
xtriage_analyses.summarize_issues()
xtriage_summary
- Module contents
data_analysis
loggraph_output
loggraph_output.gui_output
loggraph_output.newline()
loggraph_output.show_big_header()
loggraph_output.show_header()
loggraph_output.show_lines()
loggraph_output.show_paragraph_header()
loggraph_output.show_plot()
loggraph_output.show_plots_row()
loggraph_output.show_preformatted_text()
loggraph_output.show_sub_header()
loggraph_output.show_table()
loggraph_output.show_text()
loggraph_output.show_text_columns()
loggraph_output.warn()
loggraph_output.write()
printed_output
printed_output.newline()
printed_output.out
printed_output.show_big_header()
printed_output.show_header()
printed_output.show_lines()
printed_output.show_paragraph_header()
printed_output.show_plot()
printed_output.show_plots_row()
printed_output.show_preformatted_text()
printed_output.show_sub_header()
printed_output.show_table()
printed_output.show_text()
printed_output.show_text_columns()
printed_output.warn()
printed_output.write()
xtriage_analysis
xtriage_output
xtriage_output.flush()
xtriage_output.gui_output
xtriage_output.newline()
xtriage_output.show()
xtriage_output.show_big_header()
xtriage_output.show_header()
xtriage_output.show_lines()
xtriage_output.show_paragraph_header()
xtriage_output.show_plot()
xtriage_output.show_plots_row()
xtriage_output.show_preformatted_text()
xtriage_output.show_sub_header()
xtriage_output.show_table()
xtriage_output.show_text()
xtriage_output.show_text_columns()
xtriage_output.warn()
xtriage_output.write()
- mmtbx.secondary_structure package
- Subpackages
- Submodules
- mmtbx.secondary_structure.base_pairing module
- mmtbx.secondary_structure.dssp module
- mmtbx.secondary_structure.proteins module
- mmtbx.secondary_structure.utils module
- Module contents
contiguous_ss_selections()
get_ksdssp_exe_path()
manager
manager.apply_phil_str()
manager.as_phil_str()
manager.base_pair_selection()
manager.base_pair_selections()
manager.beta_selection()
manager.beta_selections()
manager.calculate_structure_content()
manager.create_all_new_restraints()
manager.create_protein_hbond_proxies()
manager.find_approximate_helices()
manager.find_automatically()
manager.find_base_pairs()
manager.find_sec_str()
manager.get_default_ss_params()
manager.get_helix_types()
manager.get_simple_bonds()
manager.helix_selection()
manager.helix_selections()
manager.initialize()
manager.records_for_pdb_file()
manager.show_summary()
run_ksdssp()
run_ksdssp_direct()
sec_str_from_phil()
- mmtbx.solvent package
- mmtbx.tls package
- Submodules
- mmtbx.tls.command_line module
- mmtbx.tls.ladp module
- mmtbx.tls.tls_as_xyz module
- mmtbx.tls.tools module
combine_tls_and_u_local()
extract_tls_from_pdb()
finite_differences_grads_of_xray_target_wrt_tls()
generate_tlsos()
get_u_cart()
make_tlso_compatible_with_u_positive_definite()
remark_3_tls()
show_times()
show_tls
show_tls_one_group
split_u()
tls_from_pdb_inp()
tls_from_u_cart()
tls_from_uaniso_minimizer
tls_from_uanisos()
tls_from_uiso_minimizer
tls_group
tls_groups
tls_refinement
tls_xray_grads
tls_xray_target_minimizer
u_cart_from_ensemble()
u_cart_from_tls()
u_tls_vs_u_ens
update_xray_structure_with_tls()
water_in_tls_selections()
- Module contents
- mmtbx.ligands package
- mmtbx.torsion_restraints package
- mmtbx.twinning package
- Submodules
- mmtbx.twinning.probabalistic_detwinning module
- mmtbx.twinning.twin_f_model module
get_initial_scale()
kb_range()
ls_ff_weights()
ls_sigma_weights()
n_as_s()
resolution_bin
scaling_parameter_mask
scaling_parameters_object
scaling_parameters_object.d_t_d_k_overall_ref()
scaling_parameters_object.d_t_d_k_part_ref()
scaling_parameters_object.d_t_d_k_sol_ref()
scaling_parameters_object.d_t_d_u_part_ref()
scaling_parameters_object.d_t_d_u_sol_ref()
scaling_parameters_object.d_t_d_u_star_ref()
scaling_parameters_object.deep_copy()
scaling_parameters_object.k_overall_to_ref()
scaling_parameters_object.k_part_to_ref()
scaling_parameters_object.k_sol_to_ref()
scaling_parameters_object.ref_to_k_overall()
scaling_parameters_object.ref_to_k_part()
scaling_parameters_object.ref_to_k_sol()
scaling_parameters_object.ref_to_u_part()
scaling_parameters_object.ref_to_u_sol()
scaling_parameters_object.ref_to_u_star()
scaling_parameters_object.show()
scaling_parameters_object.u_part_to_ref()
scaling_parameters_object.u_sol_to_ref()
scaling_parameters_object.u_star_to_ref()
target_attributes
target_functor
target_result
twin_fraction_object
twin_model_manager
twin_model_manager.alpha_beta()
twin_model_manager.alpha_beta_f()
twin_model_manager.alpha_beta_w()
twin_model_manager.anomalous_map()
twin_model_manager.apply_back_b_iso()
twin_model_manager.b_cart()
twin_model_manager.b_iso()
twin_model_manager.b_part()
twin_model_manager.b_sol()
twin_model_manager.bulk_solvent_mask()
twin_model_manager.compute_f_atoms()
twin_model_manager.compute_map_coefficients()
twin_model_manager.construct_miller_set()
twin_model_manager.data_type()
twin_model_manager.deep_copy()
twin_model_manager.determine_n_bins()
twin_model_manager.detwin_data()
twin_model_manager.electron_density_map()
twin_model_manager.explain_members()
twin_model_manager.export()
twin_model_manager.export_f_obs_flags_as_mtz()
twin_model_manager.f_bulk()
twin_model_manager.f_bulk_t()
twin_model_manager.f_bulk_w()
twin_model_manager.f_calc()
twin_model_manager.f_calc_t()
twin_model_manager.f_calc_w()
twin_model_manager.f_mask()
twin_model_manager.f_mask_t()
twin_model_manager.f_mask_w()
twin_model_manager.f_model()
twin_model_manager.f_model_scaled_with_k1_composite_work_free()
twin_model_manager.f_model_t()
twin_model_manager.f_model_w()
twin_model_manager.f_obs()
twin_model_manager.f_obs_work()
twin_model_manager.f_part1()
twin_model_manager.fb_bulk()
twin_model_manager.fb_bulk_t()
twin_model_manager.fb_bulk_w()
twin_model_manager.fft_vs_direct()
twin_model_manager.figures_of_merit()
twin_model_manager.figures_of_merit_t()
twin_model_manager.figures_of_merit_work()
twin_model_manager.fofc_map()
twin_model_manager.hl_coeffs()
twin_model_manager.info()
twin_model_manager.is_twin_fmodel_manager()
twin_model_manager.k_part()
twin_model_manager.k_sol()
twin_model_manager.k_sol_b_sol()
twin_model_manager.k_sol_u_sol()
twin_model_manager.k_sols()
twin_model_manager.map_coefficients()
twin_model_manager.model_error_ml()
twin_model_manager.origin()
twin_model_manager.outlier_selection()
twin_model_manager.phase_errors()
twin_model_manager.phase_errors_test()
twin_model_manager.phase_errors_work()
twin_model_manager.print_diffs()
twin_model_manager.r_all()
twin_model_manager.r_factors_in_resolution_bins()
twin_model_manager.r_free()
twin_model_manager.r_free_flags()
twin_model_manager.r_overall_low_high()
twin_model_manager.r_values()
twin_model_manager.r_work()
twin_model_manager.r_work_in_lowest_resolution_bin()
twin_model_manager.r_work_scale_k1_completeness_in_bins()
twin_model_manager.remove_outliers()
twin_model_manager.resolution_filter()
twin_model_manager.scale_k1()
twin_model_manager.scale_k1_t()
twin_model_manager.scale_k1_w()
twin_model_manager.scale_k3_t()
twin_model_manager.scale_k3_w()
twin_model_manager.select()
twin_model_manager.set_pseudo_ml_weights()
twin_model_manager.show()
twin_model_manager.show_comprehensive()
twin_model_manager.show_essential()
twin_model_manager.show_fom_phase_error_alpha_beta_in_bins()
twin_model_manager.show_k_sol_b_sol_b_cart_target()
twin_model_manager.show_parameter_summary()
twin_model_manager.show_targets()
twin_model_manager.sigmaa_object()
twin_model_manager.statistics_in_resolution_bins()
twin_model_manager.target()
twin_model_manager.target_attributes()
twin_model_manager.target_f()
twin_model_manager.target_functor()
twin_model_manager.twin_fraction_scan()
twin_model_manager.twin_test()
twin_model_manager.two_fofc_map()
twin_model_manager.u_cart()
twin_model_manager.u_iso()
twin_model_manager.u_iso_as_u_cart()
twin_model_manager.u_sol()
twin_model_manager.u_star()
twin_model_manager.update()
twin_model_manager.update_all_scales()
twin_model_manager.update_core()
twin_model_manager.update_f_hydrogens()
twin_model_manager.update_f_mask()
twin_model_manager.update_solvent_and_scale()
twin_model_manager.update_xray_structure()
twin_model_manager.w_star()
twin_model_manager.wilson_b()
- mmtbx.twinning.twin_map_utils module
- Module contents
- mmtbx.utils package
- Module contents
assert_model_is_consistent()
assert_water_is_consistent()
assert_xray_structures_equal()
atom_selection()
check_and_set_crystal_symmetry()
compare_hierarchy()
detect_hydrogen_nomenclature_problem
equivalent_sigma_from_cumulative_histogram_match()
experimental_data_target_and_gradients
experimental_data_target_and_gradients.grad_occ()
experimental_data_target_and_gradients.grad_sites_cart()
experimental_data_target_and_gradients.group_occupancy_grads()
experimental_data_target_and_gradients.show()
experimental_data_target_and_gradients.target()
experimental_data_target_and_gradients.update_xray_structure()
extract_box_around_model_and_map
extract_box_around_model_and_map.apply_mask_inplace()
extract_box_around_model_and_map.box_map_coefficients()
extract_box_around_model_and_map.box_map_coefficients_as_fft_map()
extract_box_around_model_and_map.cut_and_copy_map()
extract_box_around_model_and_map.get_original_cs()
extract_box_around_model_and_map.get_shifted_cs()
extract_box_around_model_and_map.get_solvent_content()
extract_box_around_model_and_map.map_coefficients()
extract_box_around_model_and_map.origin_shift_grid_units()
extract_box_around_model_and_map.shift_back()
extract_box_around_model_and_map.shift_map_back()
extract_box_around_model_and_map.shift_map_coeffs_back()
extract_box_around_model_and_map.shift_sites_cart_back()
extract_box_around_model_and_map.write_xplor_map()
extract_tls_and_u_total_from_pdb()
f_000
find_overlapping_selections()
fmodel_from_xray_structure
fmodel_manager()
fmodel_manager2()
fmodel_simple()
get_atom_selection()
get_atom_selections()
guess_observation_type
limit_frac_min_frac_max()
model_from_sites_cart()
optimize_h()
pdb_inp_from_multiple_files()
print_header()
print_programs_start_header()
process_command_line_args
process_pdb_file_srv
remove_selections()
run_reduce_with_timeout
set_log()
set_map_to_value
setup_scattering_dictionaries()
shift_origin
states
switch_rotamers()
xray_structures_from_processed_pdb_file
- Submodules
- mmtbx.utils.fab_elbow_angle module
- mmtbx.utils.ncs_utils module
- mmtbx.utils.rotatable_bonds module
- Module contents
- mmtbx.validation package
- Base classes
atom
atom_base
atom_info
atoms
dummy_validation
entity
entity.as_JSON()
entity.as_kinemage()
entity.as_list()
entity.as_selection_string()
entity.as_string()
entity.as_table_row_molprobity()
entity.as_table_row_phenix()
entity.atom_selection
entity.format_old()
entity.format_score()
entity.header()
entity.id_str()
entity.is_outlier()
entity.is_single_residue_object()
entity.molprobity_table_labels
entity.outlier
entity.score
entity.score_format
entity.xyz
entity.zoom_info()
get_atoms_info()
residue
residue.altloc
residue.assert_all_attributes_defined()
residue.atom_group_id_str()
residue.atom_selection
residue.atom_selection_string()
residue.chain_id
residue.icode
residue.id_str()
residue.is_same_residue()
residue.is_same_residue_group()
residue.is_single_residue_object()
residue.nest_dict()
residue.occupancy
residue.outlier
residue.resid
residue.residue_group_id_str()
residue.residue_id()
residue.resname
residue.resseq
residue.resseq_as_int()
residue.score
residue.segid
residue.set_coordinates_from_hierarchy()
residue.simple_id()
residue.xyz
rna_geometry
test_utils
validation
validation.as_coot_data()
validation.as_gui_table_data()
validation.as_kinemage()
validation.coot_todo()
validation.find_atom_group()
validation.find_residue()
validation.get_outliers_count_and_fraction()
validation.get_outliers_fraction_for_model()
validation.get_outliers_goal()
validation.get_result_class()
validation.gui_formats
validation.gui_list_headers
validation.iter_results()
validation.merge_dict()
validation.n_outliers
validation.n_outliers_by_model
validation.n_total
validation.n_total_by_model
validation.outlier_selection()
validation.output_header
validation.percent_outliers
validation.program_description
validation.results
validation.save_table_data()
validation.show()
validation.show_old_output()
validation.show_summary()
validation.wx_column_widths
- Subpackages
- mmtbx.validation.molprobity package
- Submodules
- mmtbx.validation.molprobity.mp_geo module
- mmtbx.validation.molprobity.nqh_minimize module
- Module contents
MolProbityParser
MolProbityTemplate
molprobity
molprobity.adp_stats
molprobity.as_mmcif_records()
molprobity.as_multi_criterion_view()
molprobity.atoms_to_observations_ratio()
molprobity.b_iso_mean()
molprobity.cbeta_outliers()
molprobity.cbetadev
molprobity.clashes
molprobity.clashscore()
molprobity.crystal_symmetry
molprobity.d_max_min()
molprobity.d_min()
molprobity.data_stats
molprobity.display_wx_plots()
molprobity.file_name
molprobity.find_missing_atoms()
molprobity.fmodel_statistics_by_resolution()
molprobity.fmodel_statistics_graph_data()
molprobity.get_polygon_statistics()
molprobity.get_statistics_for_phenix_gui()
molprobity.header_info
molprobity.hydrogens
molprobity.kinemage_file
molprobity.merging
molprobity.missing_atoms
molprobity.model
molprobity.model_statistics_geometry
molprobity.model_statistics_geometry_result
molprobity.model_stats
molprobity.model_stats_new
molprobity.molprobity_score()
molprobity.molprobity_version_number
molprobity.neutron_stats
molprobity.nqh_flips
molprobity.omegalyze
molprobity.pdb_hierarchy
molprobity.polygon_stats
molprobity.r_free()
molprobity.r_work()
molprobity.rama_allowed()
molprobity.rama_favored()
molprobity.rama_outliers()
molprobity.ramalyze
molprobity.real_space
molprobity.restraints
molprobity.rms_angles()
molprobity.rms_bonds()
molprobity.rna
molprobity.rota_outliers()
molprobity.rotalyze
molprobity.sequence
molprobity.show()
molprobity.show_summary()
molprobity.space_group()
molprobity.space_group_info()
molprobity.summarize()
molprobity.twin_law()
molprobity.unit_cell()
molprobity.waters
molprobity.wilson_b
molprobity.write_coot_script()
molprobity.xtriage
molprobity_flags()
multi_criterion_view
pdb_header_info
residue_multi_criterion
residue_multi_criterion.add_outlier()
residue_multi_criterion.altloc
residue_multi_criterion.atom_selection
residue_multi_criterion.chain_id
residue_multi_criterion.get_outlier_plot_values()
residue_multi_criterion.get_real_space_plot_values()
residue_multi_criterion.i_seq
residue_multi_criterion.icode
residue_multi_criterion.is_cbeta_outlier()
residue_multi_criterion.is_clash_outlier()
residue_multi_criterion.is_geometry_outlier()
residue_multi_criterion.is_map_outlier()
residue_multi_criterion.is_ramachandran_outlier()
residue_multi_criterion.is_rotamer_outlier()
residue_multi_criterion.n_confs
residue_multi_criterion.occupancy
residue_multi_criterion.outlier
residue_multi_criterion.outliers
residue_multi_criterion.resname
residue_multi_criterion.resseq
residue_multi_criterion.score
residue_multi_criterion.segid
residue_multi_criterion.xyz
run_molprobity_program()
summary
summary.angle_rmsd
summary.bond_rmsd
summary.c_beta_deviations
summary.clashscore
summary.d_min
summary.formats
summary.iter_molprobity_gui_fields()
summary.labels
summary.mpscore
summary.program
summary.r_free
summary.r_work
summary.rama_favored
summary.rama_outliers
summary.rotamer_outliers
summary.show()
- mmtbx.validation.molprobity package
- Submodules
- Rotalyze - protein sidechain rotamer analysis
construct_complete_sidechain()
draw_rotamer_plot()
evaluate_residue()
evaluate_rotamer()
get_center()
get_occupancy()
get_residue_key()
has_heavy_atoms()
residue_evaluator
rotalyze
rotalyze.as_JSON()
rotalyze.as_coot_data()
rotalyze.coot_todo()
rotalyze.data_version
rotalyze.display_wx_plots()
rotalyze.evaluateScore()
rotalyze.get_favored_goal()
rotalyze.get_outliers_goal()
rotalyze.get_plot_data()
rotalyze.get_result_class()
rotalyze.gui_formats
rotalyze.gui_list_headers
rotalyze.n_allowed
rotalyze.n_allowed_by_model
rotalyze.n_favored
rotalyze.n_favored_by_model
rotalyze.n_outliers
rotalyze.n_outliers_by_model
rotalyze.n_total
rotalyze.n_total_by_model
rotalyze.out_percent
rotalyze.outlier_threshold
rotalyze.output_header
rotalyze.percent_allowed
rotalyze.percent_favored
rotalyze.program_description
rotalyze.results
rotalyze.show_summary()
rotalyze.wx_column_widths
rotamer
rotamer.altloc
rotamer.as_JSON()
rotamer.as_hierarchical_JSON()
rotamer.as_string()
rotamer.as_table_row_phenix()
rotamer.atom_selection
rotamer.chain_id
rotamer.chi_angles
rotamer.evaluation
rotamer.format_chi_angles()
rotamer.format_old()
rotamer.get_chi1_chi2()
rotamer.header()
rotamer.icode
rotamer.id_str_old()
rotamer.incomplete
rotamer.model_id
rotamer.occupancy
rotamer.outlier
rotamer.resname
rotamer.resseq
rotamer.rotamer_name
rotamer.score
rotamer.segid
rotamer.xyz
rotamer_ensemble
rotamer_ensemble.altloc
rotamer_ensemble.as_string()
rotamer_ensemble.atom_selection
rotamer_ensemble.chain_id
rotamer_ensemble.chi_angles
rotamer_ensemble.evaluation
rotamer_ensemble.icode
rotamer_ensemble.incomplete
rotamer_ensemble.model_id
rotamer_ensemble.occupancy
rotamer_ensemble.outlier
rotamer_ensemble.resname
rotamer_ensemble.resseq
rotamer_ensemble.rotamer_frequencies()
rotamer_ensemble.rotamer_name
rotamer_ensemble.score
rotamer_ensemble.segid
rotamer_ensemble.xyz
rotamer_plot
rotamer_plot_mixin
split_rotamer_names()
- Ramalyze - Ramachandran plot analysis
c_alpha
construct_complete_residues()
draw_ramachandran_plot()
find_region_max_value()
format_ramachandran_plot_title()
get_altloc_from_id_str()
get_altloc_from_three()
get_cas_from_three()
get_contours()
get_dihedral()
get_favored_peaks()
get_favored_regions()
get_matching_atom_group()
get_omega_atoms()
get_phi()
get_psi()
isPrePro()
is_cis_peptide()
ramachandran
ramachandran.altloc
ramachandran.as_JSON()
ramachandran.as_csv()
ramachandran.as_hierarchical_JSON()
ramachandran.as_kinemage()
ramachandran.as_string()
ramachandran.as_table_row_phenix()
ramachandran.atom_selection
ramachandran.chain_id
ramachandran.format_old()
ramachandran.header()
ramachandran.icode
ramachandran.id_str_old()
ramachandran.markup
ramachandran.model_id
ramachandran.occupancy
ramachandran.outlier
ramachandran.phi
ramachandran.psi
ramachandran.rama_type
ramachandran.ramalyze_type()
ramachandran.res_type
ramachandran.residue_type()
ramachandran.resname
ramachandran.resseq
ramachandran.score
ramachandran.segid
ramachandran.xyz
ramachandran_ensemble
ramachandran_ensemble.altloc
ramachandran_ensemble.atom_selection
ramachandran_ensemble.chain_id
ramachandran_ensemble.icode
ramachandran_ensemble.markup
ramachandran_ensemble.model_id
ramachandran_ensemble.occupancy
ramachandran_ensemble.outlier
ramachandran_ensemble.phi
ramachandran_ensemble.phi_min_max_mean()
ramachandran_ensemble.phi_range()
ramachandran_ensemble.psi
ramachandran_ensemble.psi_min_max_mean()
ramachandran_ensemble.rama_type
ramachandran_ensemble.res_type
ramachandran_ensemble.resname
ramachandran_ensemble.resseq
ramachandran_ensemble.score
ramachandran_ensemble.score_statistics()
ramachandran_ensemble.segid
ramachandran_ensemble.xyz
ramachandran_plot
ramachandran_plot_mixin
ramalyze
ramalyze.add_to_validation_counts()
ramalyze.as_JSON()
ramalyze.as_coot_data()
ramalyze.as_kinemage()
ramalyze.as_markup_for_kinemage()
ramalyze.display_wx_plots()
ramalyze.evalScore()
ramalyze.evaluateScore()
ramalyze.fav_percent
ramalyze.get_allowed_count_and_fraction()
ramalyze.get_allowed_goal()
ramalyze.get_cis_pro_count_and_fraction()
ramalyze.get_favored_count_and_fraction()
ramalyze.get_favored_goal()
ramalyze.get_general_count_and_fraction()
ramalyze.get_gly_count_and_fraction()
ramalyze.get_ileval_count_and_fraction()
ramalyze.get_outliers_goal()
ramalyze.get_phi_psi_residues_count()
ramalyze.get_plot_data()
ramalyze.get_plots()
ramalyze.get_prepro_count_and_fraction()
ramalyze.get_result_class()
ramalyze.get_trans_pro_count_and_fraction()
ramalyze.gui_formats
ramalyze.gui_list_headers
ramalyze.n_allowed
ramalyze.n_allowed_by_model
ramalyze.n_favored
ramalyze.n_favored_by_model
ramalyze.n_outliers
ramalyze.n_outliers_by_model
ramalyze.n_total
ramalyze.n_total_by_model
ramalyze.n_type
ramalyze.out_percent
ramalyze.output_header
ramalyze.percent_allowed
ramalyze.percent_favored
ramalyze.program_description
ramalyze.results
ramalyze.show_summary()
ramalyze.write_plots()
ramalyze.wx_column_widths
- Clashscore - all-atom contacts using Reduce and Probe
check_and_add_hydrogen()
check_and_report_reduce_failure()
clash
clash.as_JSON()
clash.as_hierarchical_JSON()
clash.as_string()
clash.as_table_row_phenix()
clash.atom_selection
clash.atoms_info
clash.format_old()
clash.header()
clash.id_str()
clash.id_str_no_atom_name()
clash.id_str_src_atom_no_atom_name()
clash.max_b_factor
clash.outlier
clash.overlap
clash.probe_type
clash.score
clash.xyz
clashscore
clashscore.as_JSON()
clashscore.as_coot_data()
clashscore.b_factor_cutoff
clashscore.clash_dict
clashscore.clash_dict_b_cutoff
clashscore.clashscore
clashscore.clashscore_b_cutoff
clashscore.condensed_probe
clashscore.fast
clashscore.get_clashscore()
clashscore.get_clashscore_b_cutoff()
clashscore.get_result_class()
clashscore.gui_formats
clashscore.gui_list_headers
clashscore.list_dict
clashscore.n_outliers
clashscore.n_outliers_by_model
clashscore.n_total
clashscore.n_total_by_model
clashscore.print_clashlist_old()
clashscore.probe_clashscore_manager
clashscore.probe_file
clashscore.program_description
clashscore.results
clashscore.show()
clashscore.show_old_output()
clashscore.show_summary()
clashscore.wx_column_widths
condensed_probe_line_info
decode_atom_string()
nqh_flip
nqh_flips
probe_clashscore_manager
probe_line_info
raw_probe_line_info
- C-beta deviations
calculate_ideal_and_deviation
cbeta
cbeta.altloc
cbeta.as_JSON()
cbeta.as_bullseye_label()
cbeta.as_bullseye_point()
cbeta.as_hierarchical_JSON()
cbeta.as_kinemage()
cbeta.as_string()
cbeta.as_table_row_phenix()
cbeta.atom_selection
cbeta.chain_id
cbeta.deviation
cbeta.dihedral_NABB
cbeta.format_old()
cbeta.header()
cbeta.icode
cbeta.ideal_xyz
cbeta.model_id
cbeta.occupancy
cbeta.outlier
cbeta.resname
cbeta.resseq
cbeta.score
cbeta.segid
cbeta.xyz
cbetadev
cbetadev.as_JSON()
cbetadev.as_bullseye_kinemage()
cbetadev.as_coot_data()
cbetadev.as_kinemage()
cbetadev.beta_ideal
cbetadev.get_beta_ideal()
cbetadev.get_expected_count()
cbetadev.get_outlier_count()
cbetadev.get_outlier_percent()
cbetadev.get_result_class()
cbetadev.get_result_count()
cbetadev.get_weighted_outlier_count()
cbetadev.get_weighted_outlier_percent()
cbetadev.get_weighted_result_count()
cbetadev.gui_formats
cbetadev.gui_list_headers
cbetadev.n_outliers
cbetadev.n_outliers_by_model
cbetadev.n_total
cbetadev.n_total_by_model
cbetadev.new_outliers
cbetadev.outliers_removed
cbetadev.output_header
cbetadev.percent_outliers
cbetadev.program_description
cbetadev.results
cbetadev.show_old_output()
cbetadev.show_summary()
cbetadev.stats
cbetadev.wx_column_widths
construct_fourth()
extract_atoms_from_residue_group()
get_phi_psi_dict()
idealized_calpha_angles()
- mmtbx.validation.restraints module
angle
angles
angles.get_outliers()
angles.get_result_class()
angles.kinemage_header
angles.max
angles.mean
angles.min
angles.n_outliers
angles.n_outliers_by_model
angles.n_total
angles.n_total_by_model
angles.restraint_label
angles.restraint_type
angles.results
angles.target
angles.z_max
angles.z_mean
angles.z_min
bond
bonds
bonds.get_n_total_by_model()
bonds.get_outliers()
bonds.get_result_class()
bonds.gui_formats
bonds.gui_list_headers
bonds.kinemage_header
bonds.max
bonds.mean
bonds.min
bonds.n_outliers
bonds.n_outliers_by_model
bonds.n_total
bonds.n_total_by_model
bonds.restraint_label
bonds.restraint_type
bonds.results
bonds.target
bonds.wx_column_widths
bonds.z_max
bonds.z_mean
bonds.z_min
chiralities
chiralities.as_JSON()
chiralities.get_outliers()
chiralities.get_result_class()
chiralities.gui_formats
chiralities.gui_list_headers
chiralities.increment_category_counts()
chiralities.kinemage_header
chiralities.max
chiralities.mean
chiralities.min
chiralities.n_chiral_by_model
chiralities.n_handedness_by_model
chiralities.n_outliers
chiralities.n_outliers_by_model
chiralities.n_pseudochiral_by_model
chiralities.n_tetrahedral_by_model
chiralities.n_total
chiralities.n_total_by_model
chiralities.restraint_label
chiralities.restraint_type
chiralities.results
chiralities.target
chiralities.wx_column_widths
chiralities.z_max
chiralities.z_mean
chiralities.z_min
chirality
chirality.as_kinemage()
chirality.as_table_row_phenix()
chirality.atom_selection
chirality.atoms_info
chirality.delta
chirality.is_handedness_swap()
chirality.is_pseudochiral()
chirality.model
chirality.outlier
chirality.outlier_type()
chirality.residual
chirality.score
chirality.sigma
chirality.target
chirality.xyz
combined
dihedral
dihedrals
dihedrals.get_outliers()
dihedrals.get_result_class()
dihedrals.max
dihedrals.mean
dihedrals.min
dihedrals.n_outliers
dihedrals.n_outliers_by_model
dihedrals.n_total
dihedrals.n_total_by_model
dihedrals.restraint_label
dihedrals.restraint_type
dihedrals.results
dihedrals.target
dihedrals.z_max
dihedrals.z_mean
dihedrals.z_min
get_mean_xyz()
planarities
planarities.get_n_total_by_model()
planarities.get_outliers()
planarities.get_result_class()
planarities.gui_formats
planarities.gui_list_headers
planarities.max
planarities.mean
planarities.min
planarities.n_outliers
planarities.n_outliers_by_model
planarities.n_total
planarities.n_total_by_model
planarities.restraint_label
planarities.restraint_type
planarities.results
planarities.target
planarities.wx_column_widths
planarities.z_max
planarities.z_mean
planarities.z_min
planarity
restraint
restraint.as_JSON()
restraint.as_hierarchical_JSON()
restraint.as_string()
restraint.as_table_row_phenix()
restraint.atom_selection
restraint.atoms_info
restraint.delta
restraint.format_values()
restraint.header()
restraint.id_str()
restraint.kinemage_key()
restraint.model
restraint.n_atoms
restraint.outlier
restraint.residual
restraint.score
restraint.sigma
restraint.target
restraint.xyz
restraint_validation
restraint_validation.as_JSON()
restraint_validation.as_kinemage()
restraint_validation.get_n_total_by_model()
restraint_validation.get_outliers()
restraint_validation.gui_formats
restraint_validation.gui_list_headers
restraint_validation.kinemage_header
restraint_validation.max
restraint_validation.mean
restraint_validation.min
restraint_validation.n_outliers
restraint_validation.n_outliers_by_model
restraint_validation.n_total
restraint_validation.n_total_by_model
restraint_validation.restraint_type
restraint_validation.results
restraint_validation.show()
restraint_validation.show_old_output()
restraint_validation.show_summary()
restraint_validation.target
restraint_validation.wx_column_widths
restraint_validation.z_max
restraint_validation.z_mean
restraint_validation.z_min
- mmtbx.validation.rna_validate module
rna_angle
rna_angles
rna_angles.as_JSON()
rna_angles.get_result_class()
rna_angles.gui_formats
rna_angles.gui_list_headers
rna_angles.label
rna_angles.n_outliers
rna_angles.n_outliers_by_model
rna_angles.n_total
rna_angles.n_total_by_model
rna_angles.output_header
rna_angles.results
rna_angles.show_summary()
rna_angles.wx_column_widths
rna_bond
rna_bonds
rna_bonds.as_JSON()
rna_bonds.get_result_class()
rna_bonds.gui_formats
rna_bonds.gui_list_headers
rna_bonds.label
rna_bonds.n_outliers
rna_bonds.n_outliers_by_model
rna_bonds.n_total
rna_bonds.n_total_by_model
rna_bonds.output_header
rna_bonds.results
rna_bonds.show_summary()
rna_bonds.wx_column_widths
rna_pucker
rna_pucker.Pperp_distance
rna_pucker.altloc
rna_pucker.as_JSON()
rna_pucker.as_hierarchical_JSON()
rna_pucker.as_string()
rna_pucker.as_table_row_phenix()
rna_pucker.atom_selection
rna_pucker.chain_id
rna_pucker.delta_angle
rna_pucker.epsilon_angle
rna_pucker.format_values()
rna_pucker.header()
rna_pucker.icode
rna_pucker.is_delta_outlier
rna_pucker.is_epsilon_outlier
rna_pucker.model_id
rna_pucker.occupancy
rna_pucker.outlier
rna_pucker.probable_pucker
rna_pucker.resname
rna_pucker.resseq
rna_pucker.score
rna_pucker.segid
rna_pucker.xyz
rna_pucker_ref
rna_puckers
rna_puckers.as_JSON()
rna_puckers.get_result_class()
rna_puckers.get_sugar_xyz_mean()
rna_puckers.gui_formats
rna_puckers.gui_list_headers
rna_puckers.label
rna_puckers.local_altloc_from_atoms()
rna_puckers.n_outliers
rna_puckers.n_outliers_by_model
rna_puckers.n_total
rna_puckers.n_total_by_model
rna_puckers.output_header
rna_puckers.pucker_dist
rna_puckers.pucker_perp_xyz
rna_puckers.pucker_states
rna_puckers.results
rna_puckers.show_summary()
rna_puckers.wx_column_widths
rna_validation
- mmtbx.validation.analyze_peptides module
- mmtbx.validation.experimental module
data_statistics
data_statistics.anomalous_flag
data_statistics.completeness
data_statistics.completeness_outer
data_statistics.d_max
data_statistics.d_max_outer
data_statistics.d_min
data_statistics.d_min_outer
data_statistics.info
data_statistics.n_free
data_statistics.n_free_outer
data_statistics.n_refl
data_statistics.n_refl_outer
data_statistics.n_refl_refine
data_statistics.n_refl_refine_outer
data_statistics.r_free
data_statistics.r_free_outer
data_statistics.r_work
data_statistics.r_work_outer
data_statistics.show()
data_statistics.show_summary()
data_statistics.twin_law
data_statistics.wavelength
data_statistics.wilson_b
merging_and_model_statistics()
real_space
real_space.add_water()
real_space.everything
real_space.fsc
real_space.get_result_class()
real_space.gui_formats
real_space.gui_list_headers
real_space.n_outliers
real_space.n_outliers_by_model
real_space.n_total
real_space.n_total_by_model
real_space.other
real_space.output_header
real_space.overall_rsc
real_space.program_description
real_space.protein
real_space.results
real_space.show()
real_space.show_summary()
real_space.water
real_space.wx_column_widths
residue_real_space
residue_real_space.altloc
residue_real_space.as_string()
residue_real_space.as_table_row_phenix()
residue_real_space.atom_selection
residue_real_space.b_iso
residue_real_space.cc
residue_real_space.chain_id
residue_real_space.fmodel
residue_real_space.fofc
residue_real_space.header()
residue_real_space.icode
residue_real_space.occupancy
residue_real_space.outlier
residue_real_space.resname
residue_real_space.resseq
residue_real_space.score
residue_real_space.segid
residue_real_space.two_fofc
residue_real_space.xyz
- mmtbx.validation.graphics module
- mmtbx.validation.ligands module
compare_ligands()
compare_ligands_impl()
extract_ligand_atom_group()
extract_ligand_residue()
ligand_validation
ligand_validation.atom_selection
ligand_validation.b_iso_mean
ligand_validation.cc
ligand_validation.fofc_max
ligand_validation.fofc_mean
ligand_validation.fofc_min
ligand_validation.id_str
ligand_validation.n_below_fofc_cutoff
ligand_validation.n_below_two_fofc_cutoff
ligand_validation.occupancy_mean
ligand_validation.pbss
ligand_validation.rmsds
ligand_validation.show()
ligand_validation.show_simple()
ligand_validation.two_fofc_max
ligand_validation.two_fofc_mean
ligand_validation.two_fofc_min
ligand_validation.xyz_center
show_validation_results()
validate_ligands()
- mmtbx.validation.model_properties module
atom_bfactor
atom_bfactor.altloc
atom_bfactor.atom_selection
atom_bfactor.b_iso
atom_bfactor.chain_id
atom_bfactor.element
atom_bfactor.icode
atom_bfactor.model_id
atom_bfactor.name
atom_bfactor.occupancy
atom_bfactor.outlier
atom_bfactor.resname
atom_bfactor.resseq
atom_bfactor.score
atom_bfactor.segid
atom_bfactor.symop
atom_bfactor.xyz
atom_occupancy
atom_occupancy.altloc
atom_occupancy.as_string()
atom_occupancy.as_table_row_phenix()
atom_occupancy.atom_selection
atom_occupancy.b_iso
atom_occupancy.chain_id
atom_occupancy.element
atom_occupancy.icode
atom_occupancy.id_str()
atom_occupancy.model_id
atom_occupancy.name
atom_occupancy.occupancy
atom_occupancy.outlier
atom_occupancy.resname
atom_occupancy.resseq
atom_occupancy.score
atom_occupancy.segid
atom_occupancy.symop
atom_occupancy.xyz
model_statistics
model_statistics.all
model_statistics.ignore_hd
model_statistics.ligands
model_statistics.macromolecules
model_statistics.n_atoms
model_statistics.n_hydrogens
model_statistics.n_models
model_statistics.n_nuc
model_statistics.n_polymer
model_statistics.n_protein
model_statistics.n_waters
model_statistics.show()
model_statistics.water
residue_bfactor
residue_bfactor.altloc
residue_bfactor.as_string()
residue_bfactor.atom_selection
residue_bfactor.b_iso
residue_bfactor.chain_id
residue_bfactor.chain_type
residue_bfactor.icode
residue_bfactor.occupancy
residue_bfactor.outlier
residue_bfactor.resname
residue_bfactor.resseq
residue_bfactor.score
residue_bfactor.segid
residue_bfactor.xyz
residue_occupancy
residue_occupancy.altloc
residue_occupancy.as_string()
residue_occupancy.as_table_row_phenix()
residue_occupancy.atom_selection
residue_occupancy.b_iso
residue_occupancy.chain_id
residue_occupancy.chain_type
residue_occupancy.icode
residue_occupancy.occupancy
residue_occupancy.outlier
residue_occupancy.resname
residue_occupancy.resseq
residue_occupancy.score
residue_occupancy.segid
residue_occupancy.xyz
xray_structure_statistics
xray_structure_statistics.as_gui_table_data()
xray_structure_statistics.b_histogram
xray_structure_statistics.b_max
xray_structure_statistics.b_mean
xray_structure_statistics.b_min
xray_structure_statistics.bad_adps
xray_structure_statistics.different_occ
xray_structure_statistics.gui_formats
xray_structure_statistics.gui_list_headers
xray_structure_statistics.iter_results()
xray_structure_statistics.n_all
xray_structure_statistics.n_aniso
xray_structure_statistics.n_aniso_h
xray_structure_statistics.n_atoms
xray_structure_statistics.n_hd
xray_structure_statistics.n_non_hd
xray_structure_statistics.n_npd
xray_structure_statistics.n_outliers
xray_structure_statistics.n_outliers_by_model
xray_structure_statistics.n_total
xray_structure_statistics.n_total_by_model
xray_structure_statistics.n_zero_b
xray_structure_statistics.n_zero_occ
xray_structure_statistics.o_max
xray_structure_statistics.o_mean
xray_structure_statistics.o_min
xray_structure_statistics.partial_occ
xray_structure_statistics.results
xray_structure_statistics.show_bad_occupancy()
xray_structure_statistics.show_bfactors()
xray_structure_statistics.show_summary()
xray_structure_statistics.wx_column_widths
xray_structure_statistics.zero_occ
- mmtbx.validation.sequence module
chain
chain.extract_coordinates()
chain.extract_residue_groups()
chain.get_alignment()
chain.get_coordinates_for_alignment_range()
chain.get_coordinates_for_alignment_ranges()
chain.get_highlighted_residues()
chain.get_mean_coordinate_for_alignment_range()
chain.get_mean_coordinate_for_alignment_ranges()
chain.get_outliers_table()
chain.iter_residue_groups()
chain.set_alignment()
chain.show_summary()
get_mean_coordinate()
get_sequence_n_copies()
get_sequence_n_copies_from_files()
group_chains_and_sequences()
validation
- mmtbx.validation.utils module
build_name_hash()
decode_atom_str()
exercise()
export_ramachandran_distribution()
export_rotamer_distribution()
find_sequence_mismatches()
get_inverted_atoms()
get_mmtype_from_resname()
get_rna_backbone_dihedrals()
get_rotarama_data()
get_segid_as_chainid()
match_dihedral_to_name()
molprobity_score()
use_segids_in_place_of_chainids()
- mmtbx.validation.waters module
water
water.altloc
water.anom
water.as_string()
water.as_table_row_phenix()
water.atom_selection
water.b_iso
water.cc
water.chain_id
water.element
water.fmodel
water.fofc
water.header()
water.icode
water.id_str()
water.is_bad_water()
water.is_heavy_atom()
water.model_id
water.n_hbonds
water.name
water.nearest_atom
water.nearest_contact
water.occupancy
water.outlier
water.resname
water.resseq
water.score
water.segid
water.symop
water.two_fofc
water.xyz
waters
- Base classes
- mmtbx.wwpdb package
- Submodules
- mmtbx.wwpdb.rcsb_web_services module
add_nodes_to_query_if_needed_in_place()
chemical_id_search()
get_high_resolution_and_residue_count_for_structures()
get_high_resolution_for_structures()
get_ligand_info_for_structures()
get_r_work_rfree_for_structures()
polymeric_type_filter()
post_query()
post_report_query_with_pdb_list()
resolution_filter()
sequence_search()
- mmtbx.wwpdb.standard_geometry_cif module
chem_comp_atom
chem_comp_atom.alt_atom_id
chem_comp_atom.atom_id
chem_comp_atom.ccp4_partial_charge
chem_comp_atom.ccp4_type_energy
chem_comp_atom.charge
chem_comp_atom.descriptor
chem_comp_atom.pdbx_align
chem_comp_atom.pdbx_aromatic_flag
chem_comp_atom.pdbx_leaving_atom_flag
chem_comp_atom.pdbx_model_cartn_x_ideal
chem_comp_atom.pdbx_model_cartn_y_ideal
chem_comp_atom.pdbx_model_cartn_z_ideal
chem_comp_atom.pdbx_ordinal
chem_comp_atom.pdbx_stereo_config
chem_comp_atom.ref_radii_asa_probe
chem_comp_atom.site_ideal()
chem_comp_atom.type_symbol
get_cif_float()
get_cif_int()
get_cif_number()
process_chem_comp_atom_buffer
process_chem_comps()
- mmtbx.wwpdb.utils module
- Module contents
- mmtbx.disorder package
- Submodules
- mmtbx.disorder.analyze_model module
atom_group_proxy
atoms_proxy
carbonyl_oxygen_angle()
disordered_segment
disordered_segment.append_residue_group()
disordered_segment.detect_sequence_disorder()
disordered_segment.extract_validation_results()
disordered_segment.find_peptide_flips()
disordered_segment.get_all_conformer_distances()
disordered_segment.get_conformer_distances()
disordered_segment.get_previous_conformer()
disordered_segment.is_part_of_segment()
disordered_segment.max_distance_between_conformers()
disordered_segment.max_rmsd_between_conformers()
disordered_segment.minimum_atom_group_occupancy()
disordered_segment.n_cbeta_outliers()
disordered_segment.n_confs()
disordered_segment.n_confs_max()
disordered_segment.n_outliers_of_type()
disordered_segment.n_partial_splits()
disordered_segment.n_residues()
disordered_segment.n_rotamer_changes()
disordered_segment.show()
get_nconfs()
is_joined_at_calpha()
only_amide_hydrogen_split()
process_pdb_hierarchy
process_residue_groups
residue_group_proxy
- mmtbx.disorder.backbone module
- Module contents
Submodules¶
Module contents¶
- class mmtbx.fmodels(fmodel_xray=None, fmodel_neutron=None, xray_scattering_dict=None, neutron_scattering_dict=None, neutron_refinement=None, log=None)¶
Bases:
object
Container object for F_model values used during refinement.
- fmodel_xray¶
- fmodel_neutron¶
- xray_scattering_dict¶
- neutron_scattering_dict¶
- neutron_refinement¶
- create_target_functors(alpha_beta=None)¶
…
- fmodel_neutron(xray_structure=None)¶
…
- fmodel_xray(xray_structure=None)¶
…
- prepare_target_functors_for_minimization()¶
…
- pseudo_deep_copy()¶
Makes a deep copy of self.
- Return type:
- resolution_filter(d_min)¶
Returns a copy of self with a resolution filter applied to the x-ray and neutron maps above a given resolution.
- Parameters:
d_min (float) – Reflections with resolutions <= d_min are removed.
- Return type:
See also
mmtbx.f_model.manager.resolution_filter
- show_comprehensive(message='')¶
…
- show_short(log=None)¶
…
- show_targets(log, text='')¶
…
- target_and_gradients(compute_gradients, weights=None, u_iso_refinable_params=None, occupancy=False)¶
…
- target_functions_are_invariant_under_allowed_origin_shifts()¶
…
- target_functor_result_neutron(compute_gradients)¶
…
- target_functor_result_xray(compute_gradients)¶
…
- update(target_name=None)¶
…
- update_all_scales(update_f_part1, remove_outliers=True, params=None, optimize_mask=False, force_update_f_mask=False, nproc=1, log=None, apply_back_trace=False, refine_hd_scattering=None)¶
…
- update_xray_structure(xray_structure=None, update_f_calc=None, update_f_mask=None, force_update_f_mask=False)¶
…
- class mmtbx.map_names(map_name_string)¶
Bases:
object
Class used for parsing and external display of map’s name.
- DFC = ['dfcalc', 'dfcal', 'dfc', 'dfmodel', 'dfmod', 'dfm']¶
- FC = ['fcalc', 'fcal', 'fc', 'fmodel', 'fmod', 'fm']¶
- FILLED = ['+filled', '-filled', 'filled', '+fill', '-fill', 'fill']¶
- FO = ['fobs', 'fob', 'fo']¶
- MFO = ['mfobs', 'mfob', 'mfo']¶
- error(s)¶
Raises an exception for bad map names.
- format()¶
Formats a map name for external display.
Examples
>>> r = mmtbx.map_names(map_name_string="mFo-DFc ") >>> print r.format() mFobs-DFmodel