pinder.core package#
Subpackages#
- pinder.core.index package
- Submodules
- pinder.core.index.id module
- pinder.core.index.system module
FolderNames
unbound_rmsd_with_mask_fallback()
PinderSystem
PinderSystem.entry
PinderSystem.pdbs_path
PinderSystem.mappings_path
PinderSystem.native
PinderSystem.holo_receptor
PinderSystem.holo_ligand
PinderSystem.aligned_holo_R
PinderSystem.aligned_holo_L
PinderSystem.apo_receptor
PinderSystem.apo_ligand
PinderSystem.pred_receptor
PinderSystem.pred_ligand
PinderSystem.filter_common_uniprot_res()
PinderSystem.create_masked_bound_unbound_complexes()
PinderSystem.create_complex()
PinderSystem.create_apo_complex()
PinderSystem.create_pred_complex()
PinderSystem.unbound_rmsd()
PinderSystem.unbound_difficulty()
PinderSystem.apo_monomer_difficulty()
PinderSystem.download_entry()
PinderSystem.filepaths
PinderSystem.metadata
PinderSystem.pymol_script
PinderSystem.load_alt_apo_structure()
PinderSystem.load_structure()
- pinder.core.index.utils module
get_pinder_location()
get_pinder_bucket_root()
get_index_location()
get_index()
get_metadata()
get_extra_metadata()
SupplementaryData
SupplementaryData.sequence_database
SupplementaryData.supplementary_metadata
SupplementaryData.entity_metadata
SupplementaryData.chain_metadata
SupplementaryData.ecod_metadata
SupplementaryData.enzyme_classification_metadata
SupplementaryData.interface_annotations
SupplementaryData.sabdab_metadata
SupplementaryData.monomer_neff
SupplementaryData.paired_neff
SupplementaryData.transient_interface_metadata
SupplementaryData.ialign_split_similarity_labels
get_supplementary_data()
get_sequence_database()
download_dataset()
get_arg_parser_args()
download_pinder_cmd()
update_index_cmd()
get_missing_blobs()
sync_pinder_structure_data()
IndexEntry
IndexEntry.model_config
IndexEntry.split
IndexEntry.id
IndexEntry.pdb_id
IndexEntry.cluster_id
IndexEntry.cluster_id_R
IndexEntry.cluster_id_L
IndexEntry.pinder_s
IndexEntry.pinder_xl
IndexEntry.pinder_af2
IndexEntry.uniprot_R
IndexEntry.uniprot_L
IndexEntry.holo_R_pdb
IndexEntry.holo_L_pdb
IndexEntry.predicted_R_pdb
IndexEntry.predicted_L_pdb
IndexEntry.apo_R_pdb
IndexEntry.apo_L_pdb
IndexEntry.apo_R_pdbs
IndexEntry.apo_L_pdbs
IndexEntry.holo_R
IndexEntry.holo_L
IndexEntry.predicted_R
IndexEntry.predicted_L
IndexEntry.apo_R
IndexEntry.apo_L
IndexEntry.apo_R_quality
IndexEntry.apo_L_quality
IndexEntry.chain1_neff
IndexEntry.chain2_neff
IndexEntry.chain_R
IndexEntry.chain_L
IndexEntry.contains_antibody
IndexEntry.contains_antigen
IndexEntry.contains_enzyme
IndexEntry.pdb_path()
IndexEntry.mapping_path()
IndexEntry.pdb_paths
IndexEntry.mapping_paths
IndexEntry.pinder_id
IndexEntry.pinder_pdb
IndexEntry.apo_R_alt
IndexEntry.apo_L_alt
IndexEntry.homodimer
IndexEntry.test_system
IndexEntry.model_computed_fields
IndexEntry.model_fields
MetadataEntry
MetadataEntry.model_config
MetadataEntry.id
MetadataEntry.entry_id
MetadataEntry.method
MetadataEntry.date
MetadataEntry.release_date
MetadataEntry.resolution
MetadataEntry.label
MetadataEntry.probability
MetadataEntry.chain1_id
MetadataEntry.chain2_id
MetadataEntry.assembly
MetadataEntry.assembly_details
MetadataEntry.oligomeric_details
MetadataEntry.oligomeric_count
MetadataEntry.biol_details
MetadataEntry.complex_type
MetadataEntry.chain_1
MetadataEntry.asym_id_1
MetadataEntry.chain_2
MetadataEntry.asym_id_2
MetadataEntry.length1
MetadataEntry.length2
MetadataEntry.length_resolved_1
MetadataEntry.length_resolved_2
MetadataEntry.number_of_components_1
MetadataEntry.number_of_components_2
MetadataEntry.link_density
MetadataEntry.planarity
MetadataEntry.max_var_1
MetadataEntry.max_var_2
MetadataEntry.num_atom_types
MetadataEntry.n_residue_pairs
MetadataEntry.n_residues
MetadataEntry.buried_sasa
MetadataEntry.intermolecular_contacts
MetadataEntry.charged_charged_contacts
MetadataEntry.charged_polar_contacts
MetadataEntry.charged_apolar_contacts
MetadataEntry.polar_polar_contacts
MetadataEntry.apolar_polar_contacts
MetadataEntry.apolar_apolar_contacts
MetadataEntry.interface_atom_gaps_4A
MetadataEntry.missing_interface_residues_4A
MetadataEntry.interface_atom_gaps_8A
MetadataEntry.missing_interface_residues_8A
MetadataEntry.entity_id_R
MetadataEntry.entity_id_L
MetadataEntry.pdb_strand_id_R
MetadataEntry.pdb_strand_id_L
MetadataEntry.ECOD_names_R
MetadataEntry.ECOD_names_L
MetadataEntry.pinder_id
MetadataEntry.model_computed_fields
MetadataEntry.model_fields
fix_index()
fix_metadata()
downcast_dtypes()
set_mapping_column_types()
- Module contents
- pinder.core.loader package
- Submodules
- pinder.core.loader.dataset module
structure2tensor_transform()
pad_to_max_length()
pad_and_stack()
collate_complex()
collate_batch()
PinderDataset
PPIDataset
PPIDataset.raw_file_names
PPIDataset.processed_file_names
PPIDataset.process_single_file()
PPIDataset.process_single_file_parallel()
PPIDataset.process_parallel()
PPIDataset.process()
PPIDataset.len()
PPIDataset.get()
PPIDataset.get_filename()
PPIDataset.get_filename_idx()
PPIDataset.load_filename()
get_geo_loader()
get_torch_loader()
- pinder.core.loader.filters module
PinderFilterBase
StructureFilter
MinAtomTypesFilter
FilterMetadataFields
ChainQuery
DualChainQuery
ResidueCount
AtomTypeCount
CompleteBackBone
CheckChainElongation
DetachedChainQuery
CheckContacts
FilterByResidueCount
FilterByMissingHolo
FilterSubByContacts
FilterByHoloElongation
FilterDetachedHolo
PinderFilterSubBase
FilterSubLengths
FilterSubRmsds
FilterByHoloOverlap
FilterByHoloSeqIdentity
FilterSubByAtomTypes
FilterSubByChainQuery
FilterByElongation
FilterDetachedSub
- pinder.core.loader.geodata module
- pinder.core.loader.loader module
- pinder.core.loader.structure module
reverse_dict()
Structure
Structure.filepath
Structure.uniprot_map
Structure.pinder_id
Structure.atom_array
Structure.pdb_engine
Structure.read_pdb()
Structure.to_pdb()
Structure.filter()
Structure.set_chain()
Structure.get_per_chain_seq_alignments()
Structure.align_common_sequence()
Structure.get_contacts()
Structure.get_interface_mask()
Structure.get_interface_residues()
Structure.superimpose()
Structure.uniprot_mapping
Structure.resolved_mapping
Structure.resolved_pdb2uniprot
Structure.resolved_uniprot2pdb
Structure.coords
Structure.dataframe
Structure.backbone_mask
Structure.calpha_mask
Structure.n_atoms
Structure.chains
Structure.chain_sequence
Structure.sequence
Structure.fasta
Structure.tokenized_sequence
Structure.residue_names
Structure.residues
Structure.atom_names
Structure.b_factor
find_potential_interchain_bonded_atoms()
mask_common_uniprot()
canonical_atom_type_mask()
backbone_atom_tensor()
- pinder.core.loader.transforms module
- pinder.core.loader.utils module
- pinder.core.loader.writer module
- Module contents
- pinder.core.structure package
- Submodules
- pinder.core.structure.atoms module
biotite_pdbxfile()
biotite_pdbfile()
rust_pdbfile()
atom_array_from_pdb_file()
atom_vdw_radius()
backbone_mask()
mask_from_res_list()
apply_mask()
filter_atoms()
get_backbone_atom_masks()
assign_receptor_ligand()
renumber_res_ids()
standardize_atom_array()
stack_filter_intersect()
get_seq_alignments()
get_seq_identity()
calc_num_mismatches()
align_sequences()
resn2seq()
get_seq_aligned_structures()
get_per_chain_seq_alignments()
invert_chain_seq_map()
get_buried_sasa()
get_resolved_resi_from_atom_array()
get_resolved_resi()
write_pdb()
rename_chains()
cif_to_pdb()
normalize_orientation()
- pinder.core.structure.contacts module
- pinder.core.structure.models module
- pinder.core.structure.superimpose module
- pinder.core.structure.surgery module
- Module contents
- pinder.core.submit package
- pinder.core.utils package
- Submodules
- pinder.core.utils.cloud module
- pinder.core.utils.constants module
- pinder.core.utils.dataclass module
- pinder.core.utils.log module
- pinder.core.utils.paths module
- pinder.core.utils.pdb_utils module
- pinder.core.utils.process module
- pinder.core.utils.retry module
- pinder.core.utils.string module
- pinder.core.utils.timer module
- pinder.core.utils.unbound module
- Module contents
Module contents#
Namespace package for pinder-core.