schrodinger.application.desmond.fep_edge_data module

schrodinger.application.desmond.fep_edge_data.water_mol(respdb: str) → schrodinger.structure.Structure

Return a water molecule CT.

schrodinger.application.desmond.fep_edge_data.tag_protein(proteinA, proteinB)
This is function was adopted from:
scisol.leadoptmap.protein_fep_mapper.tag_protein

This proceeds in several steps for mutation of protein A -> protein B Loop over all other atoms in the two full length proteins and assign 1:1 atom mapping. For the mutated residue, it might put some wrong numbers in, but it is fine as the correct value will later overwrite them.

:param proteinA : protein A :type proteinA : structure :param proteinB : protein B :type proteinB : structure

class schrodinger.application.desmond.fep_edge_data.ResData

Bases: schrodinger.application.desmond.fep_edge_data.ResData

A class to store the molecule number, chain, name, and number of a residue

fullName()

Return a string of the residue data formatted as chain:resname_resnum

Returns:The formatted residue data
Return type:str
nameNum()

Return the residue name and number formatted as resname_resnum

Returns:The formatted residue data
Return type:str
__add__

Return self+value.

__class__

alias of builtins.type

__contains__

Return key in self.

__delattr__

Implement delattr(self, name).

__dict__ = mappingproxy({'__module__': 'schrodinger.application.desmond.fep_edge_data', '__doc__': '\n A class to store the molecule number, chain, name, and number of a residue\n ', '_get_common_name': <staticmethod object>, 'fullName': <function ResData.fullName>, 'nameNum': <function ResData.nameNum>, '__dict__': <attribute '__dict__' of 'ResData' objects>})
__dir__() → list

default dir() implementation

__eq__

Return self==value.

__format__()

default object formatter

__ge__

Return self>=value.

__getattribute__

Return getattr(self, name).

__getitem__

Return self[key].

__getnewargs__()

Return self as a plain tuple. Used by copy and pickle.

__gt__

Return self>value.

__hash__

Return hash(self).

__init__

Initialize self. See help(type(self)) for accurate signature.

__init_subclass__()

This method is called when a class is subclassed.

The default implementation does nothing. It may be overridden to extend subclasses.

__iter__

Implement iter(self).

__le__

Return self<=value.

__len__

Return len(self).

__lt__

Return self<value.

__module__ = 'schrodinger.application.desmond.fep_edge_data'
__mul__

Return self*value.n

__ne__

Return self!=value.

static __new__(_cls, molnum, chain, name, number)

Create new instance of ResData(molnum, chain, name, number)

__reduce__()

helper for pickle

__reduce_ex__()

helper for pickle

__repr__()

Return a nicely formatted representation string

__rmul__

Return self*value.

__setattr__

Implement setattr(self, name, value).

__sizeof__() → int

size of object in memory, in bytes

__slots__ = ()
__str__

Return str(self).

__subclasshook__()

Abstract classes can override this to customize issubclass().

This is invoked early on by abc.ABCMeta.__subclasscheck__(). It should return True, False or NotImplemented. If it returns NotImplemented, the normal algorithm is used. Otherwise, it overrides the normal algorithm (and the outcome is cached).

chain

Alias for field number 1

count(value) → integer -- return number of occurrences of value
index(value[, start[, stop]]) → integer -- return first index of value.

Raises ValueError if the value is not present.

molnum

Alias for field number 0

name

Alias for field number 2

number

Alias for field number 3

class schrodinger.application.desmond.fep_edge_data.FEPTorsions(ark_sol=None, ark_cpx=None, sol_idx_offset=0, cpx_idx_offset=0)

Bases: object

__init__(ark_sol=None, ark_cpx=None, sol_idx_offset=0, cpx_idx_offset=0)

Initialize self. See help(type(self)) for accurate signature.

sol_result
cpx_result
max_potential_energy
potential_energy

Returns potential energy that’s offset to zero

__repr__()

Print Torsion atoms used in the torsion scan.

plot(ax, color='gray', for_print=False, pot_tick_pos='right', hist_tick_pos='Bottom')
__class__

alias of builtins.type

__delattr__

Implement delattr(self, name).

__dict__ = mappingproxy({'__module__': 'schrodinger.application.desmond.fep_edge_data', '_pot_nticks': 3, '__init__': <function FEPTorsions.__init__>, 'sol_result': <property object>, 'cpx_result': <property object>, 'max_potential_energy': <property object>, 'potential_energy': <property object>, '_sol_atoms': <property object>, '_cpx_atoms': <property object>, '__repr__': <function FEPTorsions.__repr__>, '_prepare_plot': <function FEPTorsions._prepare_plot>, 'plot': <function FEPTorsions.plot>, '__dict__': <attribute '__dict__' of 'FEPTorsions' objects>, '__weakref__': <attribute '__weakref__' of 'FEPTorsions' objects>, '__doc__': None})
__dir__() → list

default dir() implementation

__eq__

Return self==value.

__format__()

default object formatter

__ge__

Return self>=value.

__getattribute__

Return getattr(self, name).

__gt__

Return self>value.

__hash__

Return hash(self).

__init_subclass__()

This method is called when a class is subclassed.

The default implementation does nothing. It may be overridden to extend subclasses.

__le__

Return self<=value.

__lt__

Return self<value.

__module__ = 'schrodinger.application.desmond.fep_edge_data'
__ne__

Return self!=value.

__new__()

Create and return a new object. See help(type) for accurate signature.

__reduce__()

helper for pickle

__reduce_ex__()

helper for pickle

__setattr__

Implement setattr(self, name, value).

__sizeof__() → int

size of object in memory, in bytes

__str__

Return str(self).

__subclasshook__()

Abstract classes can override this to customize issubclass().

This is invoked early on by abc.ABCMeta.__subclasscheck__(). It should return True, False or NotImplemented. If it returns NotImplemented, the normal algorithm is used. Otherwise, it overrides the normal algorithm (and the outcome is cached).

__weakref__

list of weak references to the object (if defined)

class schrodinger.application.desmond.fep_edge_data.FEPTorsionsContainer(sol_torsions_sea_list, cpx_torsions_sea_list, sol_idx_offset=0, cpx_idx_offset=0, perturbation_type='small_molecule')

Bases: object

Class that stores torsions for a single ligand. These torsions are from both solvent and complex legs of the simulations, corresponding to a single lambda value.

__init__(sol_torsions_sea_list, cpx_torsions_sea_list, sol_idx_offset=0, cpx_idx_offset=0, perturbation_type='small_molecule')

Initialize self. See help(type(self)) for accurate signature.

matched_tors
unmatched_tors
all_tors
matched_total
unmatched_total
tors_total
__class__

alias of builtins.type

__delattr__

Implement delattr(self, name).

__dict__ = mappingproxy({'__module__': 'schrodinger.application.desmond.fep_edge_data', '__doc__': '\n Class that stores torsions for a single ligand. These torsions are\n from both solvent and complex legs of the simulations, corresponding\n to a single lambda value.\n ', '__init__': <function FEPTorsionsContainer.__init__>, '_check_tors': <function FEPTorsionsContainer._check_tors>, '_process_tors': <function FEPTorsionsContainer._process_tors>, 'matched_tors': <property object>, 'unmatched_tors': <property object>, 'all_tors': <property object>, 'matched_total': <property object>, 'unmatched_total': <property object>, 'tors_total': <property object>, '__dict__': <attribute '__dict__' of 'FEPTorsionsContainer' objects>, '__weakref__': <attribute '__weakref__' of 'FEPTorsionsContainer' objects>})
__dir__() → list

default dir() implementation

__eq__

Return self==value.

__format__()

default object formatter

__ge__

Return self>=value.

__getattribute__

Return getattr(self, name).

__gt__

Return self>value.

__hash__

Return hash(self).

__init_subclass__()

This method is called when a class is subclassed.

The default implementation does nothing. It may be overridden to extend subclasses.

__le__

Return self<=value.

__lt__

Return self<value.

__module__ = 'schrodinger.application.desmond.fep_edge_data'
__ne__

Return self!=value.

__new__()

Create and return a new object. See help(type) for accurate signature.

__reduce__()

helper for pickle

__reduce_ex__()

helper for pickle

__repr__

Return repr(self).

__setattr__

Implement setattr(self, name, value).

__sizeof__() → int

size of object in memory, in bytes

__str__

Return str(self).

__subclasshook__()

Abstract classes can override this to customize issubclass().

This is invoked early on by abc.ABCMeta.__subclasscheck__(). It should return True, False or NotImplemented. If it returns NotImplemented, the normal algorithm is used. Otherwise, it overrides the normal algorithm (and the outcome is cached).

__weakref__

list of weak references to the object (if defined)

class schrodinger.application.desmond.fep_edge_data.FEPEdgeData(complex_sea, solvent_sea, pv_st=None, atom_mapping=None, perturbation_type='small_molecule')

Bases: object

FEPEdgeData contains all the data related to an FEP perturbation. This includes both solvent and complex legs of the simulations as well as analysis results produced by SID.

__init__(complex_sea, solvent_sea, pv_st=None, atom_mapping=None, perturbation_type='small_molecule')
Parameters:
  • complex_sea (sea) – SEA object with results pertaining to the complex leg of the FEP calculation
  • solvent_sea (sea) – SEA object with results pertaining to the solvent leg of the FEP calculation
  • pv_st (schrodinger.Structure) – PoseViewer file must contain 3 structures.. [receptor, lig1, lig2]; otherwise it’s None
  • atom_mapping (tuple(int, int)) – mapping of ligand2 to ligand1 atoms
static get_smiles(st)

rtype: str return: Generate SMILES from a given ligand structure.

atom_mapping
ligand1_fragments(offset_by_receptor_natoms=True)
ligand2_fragments(offset_by_receptor_natoms=True)
ligand1_sol_sid_rb_strain(stats=True)
ligand2_sol_sid_rb_strain(stats=True)
ligand1_cpx_sid_rb_strain(stats=True)
ligand2_cpx_sid_rb_strain(stats=True)
ligand_torsions
Return type:(FEPTorsionsContainer object, FEPTorsionsContainer object)
Returns:FEPTorsionsContainer objects for lambda0 and lambda1.
ligand1_cpx_sid_waters(stats=True)
ligand2_cpx_sid_waters(stats=True)
ligand1_sol_sid_lighb(stats=True)
ligand2_sol_sid_lighb(stats=True)
ligand1_cpx_sid_lighb(stats=True)
ligand2_cpx_sid_lighb(stats=True)
ligand1_sol_sid_sasa(stats=True)
ligand2_sol_sid_sasa(stats=True)
ligand1_cpx_sid_sasa(stats=True)
ligand2_cpx_sid_sasa(stats=True)
ligand1_sol_sid_molsa(stats=True)
ligand2_sol_sid_molsa(stats=True)
ligand1_cpx_sid_molsa(stats=True)
ligand2_cpx_sid_molsa(stats=True)
ligand1_sol_sid_psa(stats=True)
ligand2_sol_sid_psa(stats=True)
ligand1_cpx_sid_psa(stats=True)
ligand2_cpx_sid_psa(stats=True)
ligand1_sol_sid_rgyr(stats=True)
ligand2_sol_sid_rgyr(stats=True)
ligand1_cpx_sid_rgyr(stats=True)
ligand2_cpx_sid_rgyr(stats=True)
ligand1_sol_sid_rmsd(stats=True)
ligand2_sol_sid_rmsd(stats=True)
ligand1_cpx_sid_rmsd(stats=True)
ligand2_cpx_sid_rmsd(stats=True)
get_ligand1_atom_dict()
get_ligand2_atom_dict()
sse_limits_lambda0
sse_limits_lambda1
receptor_sid_rmsd_ligand_lambda0

ligand1 RMSD wrt the protein

receptor_sid_rmsd_ligand_lambda1

ligand2 RMSD wrt the protein

static protein_residue(res)

Get data about the specified residue

Parameters:res (schrodinger.structure._Residue) – The residue object to get data from
Returns:A namedtuple containing the molecule number, chain, residue name,

and residue number :rtype: ResData

receptor_residue_sequence_list

Return a list of residue objects (ResData) in amino-to-carboxy order. :return: a list of residue objects, ordered N->C (amino to carboxy

tails).
Return type:ResData
receptor_residue_sequence_tags

A residue tag looks like this: A:THR_124 (Chain:resname_resnum) if chain is not defined, use ‘_’ (underscore) :return: a list of residue tags :rtype: residue_tag

receptor_b_factor

Return B factors grouped by residues using PDB tfactor values stored in the structure. If the PDB tfactor values are not present, return zeros.

receptor_sid_rmsd_backbone_lambda0
receptor_sid_rmsd_backbone_lambda1
receptor_sid_rmsf_backbone_lambda0
receptor_sid_rmsf_backbone_lambda1
cpx_sid_lp_results
pl_contact_data0

A dictionary containing PL interactions for lambda=0

pl_contact_data1

A dictionary containing PL interactions for lambda=1

get_protein_residues_sequence_tags()
pl_interaction_similarity_matrix0

Protein-ligand interactions similarity matrix for lambda=0 sys for all available frames.

pl_interaction_similarity_matrix1

Protein-ligand interactions similarity matrix for lambda=1 sys for all available frames.

fullsystem_ct
cpx_sid_pl_results
cpx_sid_protein_residues

A list of protein residues that interact with both ligand1 and ligand2 throughout the simulation :rtype: str :return: a list of protein tags that interact with both ligand1 and

ligand2
receptor_residues_interaction_ligand1

A list of preotein residues that interact just with ligand1 :rtype: list :return: list of protein residue tags

receptor_residues_interaction_ligand2

A list of preotein residues that interact just with ligand2 :rtype: list :return: list of protein residue tags

cpx_sid_trajectory_interval_ns
sol_sid_trajectory_interval_ns
cpx_sid_snashot_times_ps
cpx_sid_snapshot_times_ps
sol_sid_snapshot_times_ps
cpx_sid_number_of_frames
sol_sid_number_of_frames
leg1_name
leg2_name
sol_timestep_list
cpx_timestep_list
sol_timestep_interval
cpx_timestep_interval
sol_delta_g_sliding_err
cpx_delta_g_sliding_err
sol_delta_g_sliding
cpx_delta_g_sliding
sol_delta_g_reverse_err
cpx_delta_g_reverse_err
sol_delta_g_reverse
cpx_delta_g_reverse
sol_delta_g_forward_err
cpx_delta_g_forward_err
sol_delta_g_forward_dg
cpx_delta_g_forward_dg
sol_delta_g_forward_bootstrap_std
cpx_delta_g_forward_bootstrap_std
sol_delta_g_forward_analytical_std
cpx_delta_g_forward_analytical_std
sol_delta_g_forward_df_per_replica
cpx_delta_g_forward_df_per_replica
sol_delta_g_forward
cpx_delta_g_forward
sol_end_time_ns
cpx_end_time_ns
sol_start_time_ns
cpx_start_time_ns
receptor_charge
receptor_total_heavy
receptor_total_atom
receptor_title
receptor_total_residues_in_chains
receptor_chain_names
receptor_total_residues
ligand1_total_rot_bonds
ligand2_total_rot_bonds
ligand1_total_fragments
ligand2_total_fragments
ligand1_mol_formula
ligand2_mol_formula
ligand1_charge
ligand2_charge
ligand1_alchemical_mols
ligand2_alchemical_mols
ligand1_alchemical_atom_total
ligand2_alchemical_atom_total
ligand1_atomic_mass
ligand2_atomic_mass
ligand1_rot_bonds
ligand2_rot_bonds
ligand1_total_hot
ligand2_total_hot
ligand1_total_heavy
ligand2_total_heavy
ligand1_total_atoms
ligand2_total_atoms
ligand1_cpx_asl
ligand2_cpx_asl
ligand1_sol_asl
ligand2_sol_asl
ligand1_pdb_name
ligand2_pdb_name
ligand1_smiles
ligand2_smiles
static ligand_name(st)
ligand1_name
ligand2_name
short_hash
ligand1_hash
ligand2_hash
jobname
delta_delta_g
sol_delta_g
Returns:dG and its standard deviation
Return type:float, float
cpx_delta_g
Returns:dG and its standard deviation
Return type:float, float
sol_total_replicas
cpx_total_replicas
sol_total_waters
cpx_total_waters
sol_total_atoms
cpx_total_atoms
sol_sim_time

Values returned in Ns (nanoseconds)

cpx_sim_time

Values returned in Ns (nanoseconds)

sol_temperature
cpx_temperature
sol_ff
cpx_ff
sol_ensemble
cpx_ensemble
sol_charge
cpx_charge
sol_salt_molecules
cpx_salt_molecules
sol_salt_info
cpx_salt_info
receptor_st

Returns receptor structure

ligand1_st

Returns ligand_1 structure

ligand2_st

Returns ligand_2 structure

sol_rest_exchanges
cpx_rest_exchanges
__class__

alias of builtins.type

__delattr__

Implement delattr(self, name).

__dict__ = mappingproxy({'__module__': 'schrodinger.application.desmond.fep_edge_data', '__doc__': '\n FEPEdgeData contains all the data related to an FEP perturbation. This\n includes both solvent and complex legs of the simulations as well as\n analysis results produced by SID.\n ', '_SSE_CUTOFF': 0.7, '_pl_inter_names': ['H-bonds', 'Hydrophobic', 'Ionic', 'Water bridges'], '_pl_type': {'hb': [0, 1, 9, 10], 'hphb': [2, 3, 4], 'ion': [5, 6, 11, 12], 'wb': [7, 8]}, '_pl_code': {'hb': 0, 'hphb': 1, 'ion': 2, 'wb': 3}, '_pl_detail_inter_type': {0: [0, '#762A83', 'Backbone donor'], 1: [0, '#AF8DC3', 'Backbone acceptor'], 9: [0, '#D9F0D3', 'Side-chain donor'], 10: [0, '#7FBF7B', 'Side-chain acceptor'], 2: [1, '#FB9A99', 'Other'], 3: [1, '#33A02C', 'Pi-Pi stacking'], 4: [1, '#B2DF8A', 'Pi-cation'], 5: [2, '#2C7BB6', 'Side chains'], 6: [2, '#A6BDDB', 'Backbone'], 11: [2, '#99D8C9', 'Side chain metal-mediated'], 12: [2, '#E5F5F9', 'Backbone metal-mediated'], 7: [3, '#D01C8B', 'Donor'], 8: [3, '#4DAC26', 'Acceptor']}, '_pl_contact_types': ['hbonds', 'hydrophobic', 'pi_pi', 'pi_cat', 'polar', 'water_br', 'metal'], '__init__': <function FEPEdgeData.__init__>, '_init_protein_st': <function FEPEdgeData._init_protein_st>, 'get_smiles': <staticmethod object>, 'atom_mapping': <property object>, 'ligand1_fragments': <function FEPEdgeData.ligand1_fragments>, 'ligand2_fragments': <function FEPEdgeData.ligand2_fragments>, '_ligand_fragments': <function FEPEdgeData._ligand_fragments>, '_parse_sol_sid': <function FEPEdgeData._parse_sol_sid>, 'ligand1_sol_sid_rb_strain': <function FEPEdgeData.ligand1_sol_sid_rb_strain>, 'ligand2_sol_sid_rb_strain': <function FEPEdgeData.ligand2_sol_sid_rb_strain>, 'ligand1_cpx_sid_rb_strain': <function FEPEdgeData.ligand1_cpx_sid_rb_strain>, 'ligand2_cpx_sid_rb_strain': <function FEPEdgeData.ligand2_cpx_sid_rb_strain>, '_get_ligand_strain': <function FEPEdgeData._get_ligand_strain>, '_get_rb_potential': <function FEPEdgeData._get_rb_potential>, '_get_ligand_torsions': <function FEPEdgeData._get_ligand_torsions>, 'ligand_torsions': <property object>, '_lig_props': <staticmethod object>, 'ligand1_cpx_sid_waters': <function FEPEdgeData.ligand1_cpx_sid_waters>, 'ligand2_cpx_sid_waters': <function FEPEdgeData.ligand2_cpx_sid_waters>, 'ligand1_sol_sid_lighb': <function FEPEdgeData.ligand1_sol_sid_lighb>, 'ligand2_sol_sid_lighb': <function FEPEdgeData.ligand2_sol_sid_lighb>, 'ligand1_cpx_sid_lighb': <function FEPEdgeData.ligand1_cpx_sid_lighb>, 'ligand2_cpx_sid_lighb': <function FEPEdgeData.ligand2_cpx_sid_lighb>, 'ligand1_sol_sid_sasa': <function FEPEdgeData.ligand1_sol_sid_sasa>, 'ligand2_sol_sid_sasa': <function FEPEdgeData.ligand2_sol_sid_sasa>, 'ligand1_cpx_sid_sasa': <function FEPEdgeData.ligand1_cpx_sid_sasa>, 'ligand2_cpx_sid_sasa': <function FEPEdgeData.ligand2_cpx_sid_sasa>, 'ligand1_sol_sid_molsa': <function FEPEdgeData.ligand1_sol_sid_molsa>, 'ligand2_sol_sid_molsa': <function FEPEdgeData.ligand2_sol_sid_molsa>, 'ligand1_cpx_sid_molsa': <function FEPEdgeData.ligand1_cpx_sid_molsa>, 'ligand2_cpx_sid_molsa': <function FEPEdgeData.ligand2_cpx_sid_molsa>, 'ligand1_sol_sid_psa': <function FEPEdgeData.ligand1_sol_sid_psa>, 'ligand2_sol_sid_psa': <function FEPEdgeData.ligand2_sol_sid_psa>, 'ligand1_cpx_sid_psa': <function FEPEdgeData.ligand1_cpx_sid_psa>, 'ligand2_cpx_sid_psa': <function FEPEdgeData.ligand2_cpx_sid_psa>, 'ligand1_sol_sid_rgyr': <function FEPEdgeData.ligand1_sol_sid_rgyr>, 'ligand2_sol_sid_rgyr': <function FEPEdgeData.ligand2_sol_sid_rgyr>, 'ligand1_cpx_sid_rgyr': <function FEPEdgeData.ligand1_cpx_sid_rgyr>, 'ligand2_cpx_sid_rgyr': <function FEPEdgeData.ligand2_cpx_sid_rgyr>, 'ligand1_sol_sid_rmsd': <function FEPEdgeData.ligand1_sol_sid_rmsd>, 'ligand2_sol_sid_rmsd': <function FEPEdgeData.ligand2_sol_sid_rmsd>, 'ligand1_cpx_sid_rmsd': <function FEPEdgeData.ligand1_cpx_sid_rmsd>, 'ligand2_cpx_sid_rmsd': <function FEPEdgeData.ligand2_cpx_sid_rmsd>, 'get_ligand1_atom_dict': <function FEPEdgeData.get_ligand1_atom_dict>, 'get_ligand2_atom_dict': <function FEPEdgeData.get_ligand2_atom_dict>, '_process_sse_data': <function FEPEdgeData._process_sse_data>, '_receptor_sid_sse_lambda0': <function FEPEdgeData._receptor_sid_sse_lambda0>, '_receptor_sid_sse_lambda1': <function FEPEdgeData._receptor_sid_sse_lambda1>, '_calculate_sse_limits': <function FEPEdgeData._calculate_sse_limits>, '_smooth_sse_limits': <function FEPEdgeData._smooth_sse_limits>, '_sse_limits': <function FEPEdgeData._sse_limits>, 'sse_limits_lambda0': <property object>, 'sse_limits_lambda1': <property object>, 'receptor_sid_rmsd_ligand_lambda0': <property object>, 'receptor_sid_rmsd_ligand_lambda1': <property object>, '_get_receptor_backbone_atoms': <function FEPEdgeData._get_receptor_backbone_atoms>, 'protein_residue': <staticmethod object>, 'receptor_residue_sequence_list': <property object>, 'receptor_residue_sequence_tags': <property object>, '_assemble_protein_b_factor': <function FEPEdgeData._assemble_protein_b_factor>, 'receptor_b_factor': <property object>, 'receptor_sid_rmsd_backbone_lambda0': <property object>, 'receptor_sid_rmsd_backbone_lambda1': <property object>, 'receptor_sid_rmsf_backbone_lambda0': <property object>, 'receptor_sid_rmsf_backbone_lambda1': <property object>, '_protein_sid_rmsf_backbone': <function FEPEdgeData._protein_sid_rmsf_backbone>, '_parse_cpx_sid': <function FEPEdgeData._parse_cpx_sid>, 'cpx_sid_lp_results': <property object>, 'pl_contact_data0': <property object>, 'pl_contact_data1': <property object>, 'get_protein_residues_sequence_tags': <function FEPEdgeData.get_protein_residues_sequence_tags>, '_pl_interaction_similarity_matrix': <staticmethod object>, 'pl_interaction_similarity_matrix0': <property object>, 'pl_interaction_similarity_matrix1': <property object>, '_cpx_sid_lp_stats': <function FEPEdgeData._cpx_sid_lp_stats>, '_get_ligand_water_stats': <function FEPEdgeData._get_ligand_water_stats>, '_get_ionic_stats': <function FEPEdgeData._get_ionic_stats>, '_get_picat_stats': <function FEPEdgeData._get_picat_stats>, '_get_pipi_stats': <function FEPEdgeData._get_pipi_stats>, '_get_hydrophobic_stats': <function FEPEdgeData._get_hydrophobic_stats>, '_get_metal_stats': <function FEPEdgeData._get_metal_stats>, '_get_water_bridge_stats': <function FEPEdgeData._get_water_bridge_stats>, '_get_lig_intra_hbond_stats': <function FEPEdgeData._get_lig_intra_hbond_stats>, '_get_lp_hbond_stats': <function FEPEdgeData._get_lp_hbond_stats>, '_filter_degen_res_atoms': <staticmethod object>, '_get_ligand_atom_dict': <staticmethod object>, '_add_alchem_mols': <staticmethod object>, 'fullsystem_ct': <property object>, 'cpx_sid_pl_results': <property object>, '_cpx_sid_pl_contacts': <function FEPEdgeData._cpx_sid_pl_contacts>, '_get_pli_residue_profile': <function FEPEdgeData._get_pli_residue_profile>, '_parse_pl_contact_data': <function FEPEdgeData._parse_pl_contact_data>, '_FEPEdgeData__get_resname': <function FEPEdgeData.__get_resname>, '_parse_pl_hydrophobic_data': <function FEPEdgeData._parse_pl_hydrophobic_data>, '_parse_pl_metal_data': <function FEPEdgeData._parse_pl_metal_data>, '_parse_pl_hbond_data': <function FEPEdgeData._parse_pl_hbond_data>, '_parse_pl_polar_data': <function FEPEdgeData._parse_pl_polar_data>, '_parse_pl_waterbr_data': <function FEPEdgeData._parse_pl_waterbr_data>, '_parse_pl_general_data': <function FEPEdgeData._parse_pl_general_data>, '_parse_residue_tags': <staticmethod object>, 'cpx_sid_protein_residues': <property object>, '_set_cpx_sid_protein_residues': <staticmethod object>, 'receptor_residues_interaction_ligand1': <property object>, 'receptor_residues_interaction_ligand2': <property object>, '_pl_contact_data': <staticmethod object>, '_cpx_sid_pli_lambda0_dict': <property object>, '_cpx_sid_pli_lambda1_dict': <property object>, '_cpx_sid_pli_dict': <staticmethod object>, 'cpx_sid_trajectory_interval_ns': <property object>, 'sol_sid_trajectory_interval_ns': <property object>, 'cpx_sid_snashot_times_ps': <property object>, 'cpx_sid_snapshot_times_ps': <property object>, 'sol_sid_snapshot_times_ps': <property object>, 'cpx_sid_number_of_frames': <property object>, 'sol_sid_number_of_frames': <property object>, '_parse_sid_rms': <function FEPEdgeData._parse_sid_rms>, '_parse_sid': <staticmethod object>, 'leg1_name': <property object>, 'leg2_name': <property object>, 'sol_timestep_list': <property object>, 'cpx_timestep_list': <property object>, 'sol_timestep_interval': <property object>, 'cpx_timestep_interval': <property object>, 'sol_delta_g_sliding_err': <property object>, 'cpx_delta_g_sliding_err': <property object>, 'sol_delta_g_sliding': <property object>, 'cpx_delta_g_sliding': <property object>, 'sol_delta_g_reverse_err': <property object>, 'cpx_delta_g_reverse_err': <property object>, 'sol_delta_g_reverse': <property object>, 'cpx_delta_g_reverse': <property object>, 'sol_delta_g_forward_err': <property object>, 'cpx_delta_g_forward_err': <property object>, 'sol_delta_g_forward_dg': <property object>, 'cpx_delta_g_forward_dg': <property object>, 'sol_delta_g_forward_bootstrap_std': <property object>, 'cpx_delta_g_forward_bootstrap_std': <property object>, 'sol_delta_g_forward_analytical_std': <property object>, 'cpx_delta_g_forward_analytical_std': <property object>, 'sol_delta_g_forward_df_per_replica': <property object>, 'cpx_delta_g_forward_df_per_replica': <property object>, 'sol_delta_g_forward': <property object>, 'cpx_delta_g_forward': <property object>, 'sol_end_time_ns': <property object>, 'cpx_end_time_ns': <property object>, 'sol_start_time_ns': <property object>, 'cpx_start_time_ns': <property object>, '_get_values': <staticmethod object>, 'receptor_charge': <property object>, 'receptor_total_heavy': <property object>, 'receptor_total_atom': <property object>, 'receptor_title': <property object>, 'receptor_total_residues_in_chains': <property object>, 'receptor_chain_names': <property object>, 'receptor_total_residues': <property object>, 'ligand1_total_rot_bonds': <property object>, 'ligand2_total_rot_bonds': <property object>, 'ligand1_total_fragments': <property object>, 'ligand2_total_fragments': <property object>, 'ligand1_mol_formula': <property object>, 'ligand2_mol_formula': <property object>, 'ligand1_charge': <property object>, 'ligand2_charge': <property object>, 'ligand1_alchemical_mols': <property object>, 'ligand2_alchemical_mols': <property object>, 'ligand1_alchemical_atom_total': <property object>, 'ligand2_alchemical_atom_total': <property object>, 'ligand1_atomic_mass': <property object>, 'ligand2_atomic_mass': <property object>, 'ligand1_rot_bonds': <property object>, 'ligand2_rot_bonds': <property object>, 'ligand1_total_hot': <property object>, 'ligand2_total_hot': <property object>, 'ligand1_total_heavy': <property object>, 'ligand2_total_heavy': <property object>, 'ligand1_total_atoms': <property object>, 'ligand2_total_atoms': <property object>, 'ligand1_cpx_asl': <property object>, 'ligand2_cpx_asl': <property object>, 'ligand1_sol_asl': <property object>, 'ligand2_sol_asl': <property object>, 'ligand1_pdb_name': <property object>, 'ligand2_pdb_name': <property object>, 'ligand1_smiles': <property object>, 'ligand2_smiles': <property object>, 'ligand_name': <staticmethod object>, 'ligand1_name': <property object>, 'ligand2_name': <property object>, 'short_hash': <property object>, 'ligand1_hash': <property object>, 'ligand2_hash': <property object>, 'jobname': <property object>, 'delta_delta_g': <property object>, 'sol_delta_g': <property object>, 'cpx_delta_g': <property object>, '_delta_g': <staticmethod object>, 'sol_total_replicas': <property object>, 'cpx_total_replicas': <property object>, 'sol_total_waters': <property object>, 'cpx_total_waters': <property object>, 'sol_total_atoms': <property object>, 'cpx_total_atoms': <property object>, 'sol_sim_time': <property object>, 'cpx_sim_time': <property object>, 'sol_temperature': <property object>, 'cpx_temperature': <property object>, 'sol_ff': <property object>, 'cpx_ff': <property object>, 'sol_ensemble': <property object>, 'cpx_ensemble': <property object>, 'sol_charge': <property object>, 'cpx_charge': <property object>, 'sol_salt_molecules': <property object>, 'cpx_salt_molecules': <property object>, 'sol_salt_info': <property object>, 'cpx_salt_info': <property object>, 'receptor_st': <property object>, 'ligand1_st': <property object>, 'ligand2_st': <property object>, '_write_error': <staticmethod object>, 'sol_rest_exchanges': <property object>, 'cpx_rest_exchanges': <property object>, '_rest_exchanges': <staticmethod object>, '_parse_cpx_sea': <function FEPEdgeData._parse_cpx_sea>, '_parse_sol_sea': <function FEPEdgeData._parse_sol_sea>, '_parse_sea': <function FEPEdgeData._parse_sea>, '__dict__': <attribute '__dict__' of 'FEPEdgeData' objects>, '__weakref__': <attribute '__weakref__' of 'FEPEdgeData' objects>})
__dir__() → list

default dir() implementation

__eq__

Return self==value.

__format__()

default object formatter

__ge__

Return self>=value.

__getattribute__

Return getattr(self, name).

__gt__

Return self>value.

__hash__

Return hash(self).

__init_subclass__()

This method is called when a class is subclassed.

The default implementation does nothing. It may be overridden to extend subclasses.

__le__

Return self<=value.

__lt__

Return self<value.

__module__ = 'schrodinger.application.desmond.fep_edge_data'
__ne__

Return self!=value.

__new__()

Create and return a new object. See help(type) for accurate signature.

__reduce__()

helper for pickle

__reduce_ex__()

helper for pickle

__repr__

Return repr(self).

__setattr__

Implement setattr(self, name, value).

__sizeof__() → int

size of object in memory, in bytes

__str__

Return str(self).

__subclasshook__()

Abstract classes can override this to customize issubclass().

This is invoked early on by abc.ABCMeta.__subclasscheck__(). It should return True, False or NotImplemented. If it returns NotImplemented, the normal algorithm is used. Otherwise, it overrides the normal algorithm (and the outcome is cached).

__weakref__

list of weak references to the object (if defined)

class schrodinger.application.desmond.fep_edge_data.PRMEdgeData(complex_sea, solvent_sea, pv_st=None, atom_mapping=None, perturbation_type='small_molecule', frag_atom_mapping=None)

Bases: schrodinger.application.desmond.fep_edge_data.FEPEdgeData

PRMEdgeData is an object that stores Protein Residue Mutation related data. And inherits from FEPEdgeData.

__init__(complex_sea, solvent_sea, pv_st=None, atom_mapping=None, perturbation_type='small_molecule', frag_atom_mapping=None)
Parameters:
  • complex_sea (sea) – SEA object with results pertaining to the complex leg of the FEP calculation
  • solvent_sea (sea) – SEA object with results pertaining to the solvent leg of the FEP calculation
  • pv_st (schrodinger.Structure) – PoseViewer file must contain 2 or 3 structures. [receptor, lig1, lig2]; otherwise it’s None
  • atom_mapping (int, int) – mapping of ligand2 to ligand1 atoms
  • frag_atom_mapping (int, int) – mapping of frag1 and frag2 atoms
wt_st

Returns full structure of a WT protein

mut_st

Returns full structure of a mutated protein

ligand1_st

Returns ligand_1 structure

ligand2_st

Returns ligand_2 structure

receptor_st

Returns receptor structure

wt_frag_st
mut_frag_st
solvent_fullsystem_ct
ligand_st_mol_formula
prm_name
receptor_sid_rmsf_backbone_lambda0
receptor_sid_rmsf_backbone_lambda1
ligand_torsions
Return type:(FEPTorsionsContainer object, FEPTorsionsContainer object)
Returns:FEPTorsionsContainer objects for lambda0 and lambda1.
static peptide_name(st)
wt_name
mut_name
wt_residue_sequence_list

Return a list of residue objects (ResData) in amino-to-carboxy order. :return: a list of residue objects, ordered N->C (amino to carboxy

tails).
Return type:ResData
wt_residue_sequence_tags

A residue tag looks like this: A:THR_124 (Chain:resname_resnum) if chain is not defined, use ‘_’ (underscore) :return: a list of residue tags :rtype: residue_tag

mut_residue_sequence_list

Return a list of residue objects (ResData) in amino-to-carboxy order. :return: a list of residue objects, ordered N->C (amino to carboxy

tails).
Return type:ResData
mut_residue_sequence_tags

A residue tag looks like this: A:THR_124 (Chain:resname_resnum) if chain is not defined, use ‘_’ (underscore) :return: a list of residue tags :rtype: residue_tag

get_protein_residues_sequence_tags()
cpx_sid_lp_results
atom_mapping
__class__

alias of builtins.type

__delattr__

Implement delattr(self, name).

__dict__ = mappingproxy({'__module__': 'schrodinger.application.desmond.fep_edge_data', '__doc__': '\n PRMEdgeData is an object that stores Protein Residue Mutation related data.\n And inherits from FEPEdgeData.\n ', '__init__': <function PRMEdgeData.__init__>, '_calc_lig_props': <function PRMEdgeData._calc_lig_props>, 'wt_st': <property object>, 'mut_st': <property object>, 'ligand1_st': <property object>, 'ligand2_st': <property object>, 'receptor_st': <property object>, 'wt_frag_st': <property object>, 'mut_frag_st': <property object>, 'solvent_fullsystem_ct': <property object>, 'ligand_st_mol_formula': <property object>, 'prm_name': <property object>, '_protein_sid_rmsf_backbone': <staticmethod object>, 'receptor_sid_rmsf_backbone_lambda0': <property object>, 'receptor_sid_rmsf_backbone_lambda1': <property object>, 'ligand_torsions': <property object>, 'peptide_name': <staticmethod object>, 'wt_name': <property object>, 'mut_name': <property object>, 'wt_residue_sequence_list': <property object>, 'wt_residue_sequence_tags': <property object>, 'mut_residue_sequence_list': <property object>, 'mut_residue_sequence_tags': <property object>, 'get_protein_residues_sequence_tags': <function PRMEdgeData.get_protein_residues_sequence_tags>, 'cpx_sid_lp_results': <property object>, 'atom_mapping': <property object>})
__dir__() → list

default dir() implementation

__eq__

Return self==value.

__format__()

default object formatter

__ge__

Return self>=value.

__getattribute__

Return getattr(self, name).

__gt__

Return self>value.

__hash__

Return hash(self).

__init_subclass__()

This method is called when a class is subclassed.

The default implementation does nothing. It may be overridden to extend subclasses.

__le__

Return self<=value.

__lt__

Return self<value.

__module__ = 'schrodinger.application.desmond.fep_edge_data'
__ne__

Return self!=value.

__new__()

Create and return a new object. See help(type) for accurate signature.

__reduce__()

helper for pickle

__reduce_ex__()

helper for pickle

__repr__

Return repr(self).

__setattr__

Implement setattr(self, name, value).

__sizeof__() → int

size of object in memory, in bytes

__str__

Return str(self).

__subclasshook__()

Abstract classes can override this to customize issubclass().

This is invoked early on by abc.ABCMeta.__subclasscheck__(). It should return True, False or NotImplemented. If it returns NotImplemented, the normal algorithm is used. Otherwise, it overrides the normal algorithm (and the outcome is cached).

__weakref__

list of weak references to the object (if defined)

cpx_charge
cpx_delta_g
Returns:dG and its standard deviation
Return type:float, float
cpx_delta_g_forward
cpx_delta_g_forward_analytical_std
cpx_delta_g_forward_bootstrap_std
cpx_delta_g_forward_df_per_replica
cpx_delta_g_forward_dg
cpx_delta_g_forward_err
cpx_delta_g_reverse
cpx_delta_g_reverse_err
cpx_delta_g_sliding
cpx_delta_g_sliding_err
cpx_end_time_ns
cpx_ensemble
cpx_ff
cpx_rest_exchanges
cpx_salt_info
cpx_salt_molecules
cpx_sid_number_of_frames
cpx_sid_pl_results
cpx_sid_protein_residues

A list of protein residues that interact with both ligand1 and ligand2 throughout the simulation :rtype: str :return: a list of protein tags that interact with both ligand1 and

ligand2
cpx_sid_snapshot_times_ps
cpx_sid_snashot_times_ps
cpx_sid_trajectory_interval_ns
cpx_sim_time

Values returned in Ns (nanoseconds)

cpx_start_time_ns
cpx_temperature
cpx_timestep_interval
cpx_timestep_list
cpx_total_atoms
cpx_total_replicas
cpx_total_waters
delta_delta_g
fullsystem_ct
get_ligand1_atom_dict()
get_ligand2_atom_dict()
static get_smiles(st)

rtype: str return: Generate SMILES from a given ligand structure.

jobname
leg1_name
leg2_name
ligand1_alchemical_atom_total
ligand1_alchemical_mols
ligand1_atomic_mass
ligand1_charge
ligand1_cpx_asl
ligand1_cpx_sid_lighb(stats=True)
ligand1_cpx_sid_molsa(stats=True)
ligand1_cpx_sid_psa(stats=True)
ligand1_cpx_sid_rb_strain(stats=True)
ligand1_cpx_sid_rgyr(stats=True)
ligand1_cpx_sid_rmsd(stats=True)
ligand1_cpx_sid_sasa(stats=True)
ligand1_cpx_sid_waters(stats=True)
ligand1_fragments(offset_by_receptor_natoms=True)
ligand1_hash
ligand1_mol_formula
ligand1_name
ligand1_pdb_name
ligand1_rot_bonds
ligand1_smiles
ligand1_sol_asl
ligand1_sol_sid_lighb(stats=True)
ligand1_sol_sid_molsa(stats=True)
ligand1_sol_sid_psa(stats=True)
ligand1_sol_sid_rb_strain(stats=True)
ligand1_sol_sid_rgyr(stats=True)
ligand1_sol_sid_rmsd(stats=True)
ligand1_sol_sid_sasa(stats=True)
ligand1_total_atoms
ligand1_total_fragments
ligand1_total_heavy
ligand1_total_hot
ligand1_total_rot_bonds
ligand2_alchemical_atom_total
ligand2_alchemical_mols
ligand2_atomic_mass
ligand2_charge
ligand2_cpx_asl
ligand2_cpx_sid_lighb(stats=True)
ligand2_cpx_sid_molsa(stats=True)
ligand2_cpx_sid_psa(stats=True)
ligand2_cpx_sid_rb_strain(stats=True)
ligand2_cpx_sid_rgyr(stats=True)
ligand2_cpx_sid_rmsd(stats=True)
ligand2_cpx_sid_sasa(stats=True)
ligand2_cpx_sid_waters(stats=True)
ligand2_fragments(offset_by_receptor_natoms=True)
ligand2_hash
ligand2_mol_formula
ligand2_name
ligand2_pdb_name
ligand2_rot_bonds
ligand2_smiles
ligand2_sol_asl
ligand2_sol_sid_lighb(stats=True)
ligand2_sol_sid_molsa(stats=True)
ligand2_sol_sid_psa(stats=True)
ligand2_sol_sid_rb_strain(stats=True)
ligand2_sol_sid_rgyr(stats=True)
ligand2_sol_sid_rmsd(stats=True)
ligand2_sol_sid_sasa(stats=True)
ligand2_total_atoms
ligand2_total_fragments
ligand2_total_heavy
ligand2_total_hot
ligand2_total_rot_bonds
static ligand_name(st)
pl_contact_data0

A dictionary containing PL interactions for lambda=0

pl_contact_data1

A dictionary containing PL interactions for lambda=1

pl_interaction_similarity_matrix0

Protein-ligand interactions similarity matrix for lambda=0 sys for all available frames.

pl_interaction_similarity_matrix1

Protein-ligand interactions similarity matrix for lambda=1 sys for all available frames.

static protein_residue(res)

Get data about the specified residue

Parameters:res (schrodinger.structure._Residue) – The residue object to get data from
Returns:A namedtuple containing the molecule number, chain, residue name,

and residue number :rtype: ResData

receptor_b_factor

Return B factors grouped by residues using PDB tfactor values stored in the structure. If the PDB tfactor values are not present, return zeros.

receptor_chain_names
receptor_charge
receptor_residue_sequence_list

Return a list of residue objects (ResData) in amino-to-carboxy order. :return: a list of residue objects, ordered N->C (amino to carboxy

tails).
Return type:ResData
receptor_residue_sequence_tags

A residue tag looks like this: A:THR_124 (Chain:resname_resnum) if chain is not defined, use ‘_’ (underscore) :return: a list of residue tags :rtype: residue_tag

receptor_residues_interaction_ligand1

A list of preotein residues that interact just with ligand1 :rtype: list :return: list of protein residue tags

receptor_residues_interaction_ligand2

A list of preotein residues that interact just with ligand2 :rtype: list :return: list of protein residue tags

receptor_sid_rmsd_backbone_lambda0
receptor_sid_rmsd_backbone_lambda1
receptor_sid_rmsd_ligand_lambda0

ligand1 RMSD wrt the protein

receptor_sid_rmsd_ligand_lambda1

ligand2 RMSD wrt the protein

receptor_title
receptor_total_atom
receptor_total_heavy
receptor_total_residues
receptor_total_residues_in_chains
short_hash
sol_charge
sol_delta_g
Returns:dG and its standard deviation
Return type:float, float
sol_delta_g_forward
sol_delta_g_forward_analytical_std
sol_delta_g_forward_bootstrap_std
sol_delta_g_forward_df_per_replica
sol_delta_g_forward_dg
sol_delta_g_forward_err
sol_delta_g_reverse
sol_delta_g_reverse_err
sol_delta_g_sliding
sol_delta_g_sliding_err
sol_end_time_ns
sol_ensemble
sol_ff
sol_rest_exchanges
sol_salt_info
sol_salt_molecules
sol_sid_number_of_frames
sol_sid_snapshot_times_ps
sol_sid_trajectory_interval_ns
sol_sim_time

Values returned in Ns (nanoseconds)

sol_start_time_ns
sol_temperature
sol_timestep_interval
sol_timestep_list
sol_total_atoms
sol_total_replicas
sol_total_waters
sse_limits_lambda0
sse_limits_lambda1
class schrodinger.application.desmond.fep_edge_data.CovalentFEPEdgeData(complex_sea, solvent_sea, pv_st=None, sol_st=None, atom_mapping=None, perturbation_type='small_molecule', frag_atom_mapping=None)

Bases: schrodinger.application.desmond.fep_edge_data.FEPEdgeData

This object stores covalent FEP related data.

__init__(complex_sea, solvent_sea, pv_st=None, sol_st=None, atom_mapping=None, perturbation_type='small_molecule', frag_atom_mapping=None)
Parameters:
  • complex_sea (sea) – SEA object with results pertaining to the complex leg of the FEP calculation
  • solvent_sea (sea) – SEA object with results pertaining to the solvent leg of the FEP calculation
  • pv_st (schrodinger.Structure) – PoseViewer file must contain 2 structures. [complex1, complex2]; otherwise it’s None
  • sol_st (solvent fragments tuple) – (schrodinger.Structure, schrodinger.Structure)
  • atom_mapping (int, int) – mapping of ligand2 to ligand1 atoms
  • frag_atom_mapping (int, int) – mapping of frag1 and frag2 atoms
wt_st

Returns full structure of a WT protein

mut_st

Returns full structure of a mutated protein

receptor_st

Returns receptor structure

ligand1_cpx_st
ligand2_cpx_st
ligand1_st

Returns ligand_1 structure

ligand2_st

Returns ligand_2 structure

solvent_fullsystem_ct
receptor_sid_rmsf_backbone_lambda0
receptor_sid_rmsf_backbone_lambda1
ligand_torsions
Return type:(FEPTorsionsContainer object, FEPTorsionsContainer object)
Returns:FEPTorsionsContainer objects for lambda0 and lambda1.
receptor_title
cpx_sid_lp_results
get_ligand1_atom_dict()
get_ligand2_atom_dict()
atom_mapping

Return atom mapping for both ligand fragment that is used in the SID calculation. Ligands used in the solvent leg are different than those used in the complex leg. The difference is:

Complex leg – we use the side chain of the attached residue plus
the ligand.

Solvent leg – we use the peptide plus the ligand.

Returns:atom mapping for ligand1 and ligand2. The values should
Return type:(list, list)
__class__

alias of builtins.type

__delattr__

Implement delattr(self, name).

__dict__ = mappingproxy({'__module__': 'schrodinger.application.desmond.fep_edge_data', '__doc__': '\n This object stores covalent FEP related data.\n ', '__init__': <function CovalentFEPEdgeData.__init__>, 'wt_st': <property object>, 'mut_st': <property object>, 'receptor_st': <property object>, 'ligand1_cpx_st': <property object>, 'ligand2_cpx_st': <property object>, 'ligand1_st': <property object>, 'ligand2_st': <property object>, 'solvent_fullsystem_ct': <property object>, '_protein_sid_rmsf_backbone': <staticmethod object>, 'receptor_sid_rmsf_backbone_lambda0': <property object>, 'receptor_sid_rmsf_backbone_lambda1': <property object>, 'ligand_torsions': <property object>, 'receptor_title': <property object>, 'cpx_sid_lp_results': <property object>, 'get_ligand1_atom_dict': <function CovalentFEPEdgeData.get_ligand1_atom_dict>, 'get_ligand2_atom_dict': <function CovalentFEPEdgeData.get_ligand2_atom_dict>, 'atom_mapping': <property object>})
__dir__() → list

default dir() implementation

__eq__

Return self==value.

__format__()

default object formatter

__ge__

Return self>=value.

__getattribute__

Return getattr(self, name).

__gt__

Return self>value.

__hash__

Return hash(self).

__init_subclass__()

This method is called when a class is subclassed.

The default implementation does nothing. It may be overridden to extend subclasses.

__le__

Return self<=value.

__lt__

Return self<value.

__module__ = 'schrodinger.application.desmond.fep_edge_data'
__ne__

Return self!=value.

__new__()

Create and return a new object. See help(type) for accurate signature.

__reduce__()

helper for pickle

__reduce_ex__()

helper for pickle

__repr__

Return repr(self).

__setattr__

Implement setattr(self, name, value).

__sizeof__() → int

size of object in memory, in bytes

__str__

Return str(self).

__subclasshook__()

Abstract classes can override this to customize issubclass().

This is invoked early on by abc.ABCMeta.__subclasscheck__(). It should return True, False or NotImplemented. If it returns NotImplemented, the normal algorithm is used. Otherwise, it overrides the normal algorithm (and the outcome is cached).

__weakref__

list of weak references to the object (if defined)

cpx_charge
cpx_delta_g
Returns:dG and its standard deviation
Return type:float, float
cpx_delta_g_forward
cpx_delta_g_forward_analytical_std
cpx_delta_g_forward_bootstrap_std
cpx_delta_g_forward_df_per_replica
cpx_delta_g_forward_dg
cpx_delta_g_forward_err
cpx_delta_g_reverse
cpx_delta_g_reverse_err
cpx_delta_g_sliding
cpx_delta_g_sliding_err
cpx_end_time_ns
cpx_ensemble
cpx_ff
cpx_rest_exchanges
cpx_salt_info
cpx_salt_molecules
cpx_sid_number_of_frames
cpx_sid_pl_results
cpx_sid_protein_residues

A list of protein residues that interact with both ligand1 and ligand2 throughout the simulation :rtype: str :return: a list of protein tags that interact with both ligand1 and

ligand2
cpx_sid_snapshot_times_ps
cpx_sid_snashot_times_ps
cpx_sid_trajectory_interval_ns
cpx_sim_time

Values returned in Ns (nanoseconds)

cpx_start_time_ns
cpx_temperature
cpx_timestep_interval
cpx_timestep_list
cpx_total_atoms
cpx_total_replicas
cpx_total_waters
delta_delta_g
fullsystem_ct
get_protein_residues_sequence_tags()
static get_smiles(st)

rtype: str return: Generate SMILES from a given ligand structure.

jobname
leg1_name
leg2_name
ligand1_alchemical_atom_total
ligand1_alchemical_mols
ligand1_atomic_mass
ligand1_charge
ligand1_cpx_asl
ligand1_cpx_sid_lighb(stats=True)
ligand1_cpx_sid_molsa(stats=True)
ligand1_cpx_sid_psa(stats=True)
ligand1_cpx_sid_rb_strain(stats=True)
ligand1_cpx_sid_rgyr(stats=True)
ligand1_cpx_sid_rmsd(stats=True)
ligand1_cpx_sid_sasa(stats=True)
ligand1_cpx_sid_waters(stats=True)
ligand1_fragments(offset_by_receptor_natoms=True)
ligand1_hash
ligand1_mol_formula
ligand1_name
ligand1_pdb_name
ligand1_rot_bonds
ligand1_smiles
ligand1_sol_asl
ligand1_sol_sid_lighb(stats=True)
ligand1_sol_sid_molsa(stats=True)
ligand1_sol_sid_psa(stats=True)
ligand1_sol_sid_rb_strain(stats=True)
ligand1_sol_sid_rgyr(stats=True)
ligand1_sol_sid_rmsd(stats=True)
ligand1_sol_sid_sasa(stats=True)
ligand1_total_atoms
ligand1_total_fragments
ligand1_total_heavy
ligand1_total_hot
ligand1_total_rot_bonds
ligand2_alchemical_atom_total
ligand2_alchemical_mols
ligand2_atomic_mass
ligand2_charge
ligand2_cpx_asl
ligand2_cpx_sid_lighb(stats=True)
ligand2_cpx_sid_molsa(stats=True)
ligand2_cpx_sid_psa(stats=True)
ligand2_cpx_sid_rb_strain(stats=True)
ligand2_cpx_sid_rgyr(stats=True)
ligand2_cpx_sid_rmsd(stats=True)
ligand2_cpx_sid_sasa(stats=True)
ligand2_cpx_sid_waters(stats=True)
ligand2_fragments(offset_by_receptor_natoms=True)
ligand2_hash
ligand2_mol_formula
ligand2_name
ligand2_pdb_name
ligand2_rot_bonds
ligand2_smiles
ligand2_sol_asl
ligand2_sol_sid_lighb(stats=True)
ligand2_sol_sid_molsa(stats=True)
ligand2_sol_sid_psa(stats=True)
ligand2_sol_sid_rb_strain(stats=True)
ligand2_sol_sid_rgyr(stats=True)
ligand2_sol_sid_rmsd(stats=True)
ligand2_sol_sid_sasa(stats=True)
ligand2_total_atoms
ligand2_total_fragments
ligand2_total_heavy
ligand2_total_hot
ligand2_total_rot_bonds
static ligand_name(st)
pl_contact_data0

A dictionary containing PL interactions for lambda=0

pl_contact_data1

A dictionary containing PL interactions for lambda=1

pl_interaction_similarity_matrix0

Protein-ligand interactions similarity matrix for lambda=0 sys for all available frames.

pl_interaction_similarity_matrix1

Protein-ligand interactions similarity matrix for lambda=1 sys for all available frames.

static protein_residue(res)

Get data about the specified residue

Parameters:res (schrodinger.structure._Residue) – The residue object to get data from
Returns:A namedtuple containing the molecule number, chain, residue name,

and residue number :rtype: ResData

receptor_b_factor

Return B factors grouped by residues using PDB tfactor values stored in the structure. If the PDB tfactor values are not present, return zeros.

receptor_chain_names
receptor_charge
receptor_residue_sequence_list

Return a list of residue objects (ResData) in amino-to-carboxy order. :return: a list of residue objects, ordered N->C (amino to carboxy

tails).
Return type:ResData
receptor_residue_sequence_tags

A residue tag looks like this: A:THR_124 (Chain:resname_resnum) if chain is not defined, use ‘_’ (underscore) :return: a list of residue tags :rtype: residue_tag

receptor_residues_interaction_ligand1

A list of preotein residues that interact just with ligand1 :rtype: list :return: list of protein residue tags

receptor_residues_interaction_ligand2

A list of preotein residues that interact just with ligand2 :rtype: list :return: list of protein residue tags

receptor_sid_rmsd_backbone_lambda0
receptor_sid_rmsd_backbone_lambda1
receptor_sid_rmsd_ligand_lambda0

ligand1 RMSD wrt the protein

receptor_sid_rmsd_ligand_lambda1

ligand2 RMSD wrt the protein

receptor_total_atom
receptor_total_heavy
receptor_total_residues
receptor_total_residues_in_chains
short_hash
sol_charge
sol_delta_g
Returns:dG and its standard deviation
Return type:float, float
sol_delta_g_forward
sol_delta_g_forward_analytical_std
sol_delta_g_forward_bootstrap_std
sol_delta_g_forward_df_per_replica
sol_delta_g_forward_dg
sol_delta_g_forward_err
sol_delta_g_reverse
sol_delta_g_reverse_err
sol_delta_g_sliding
sol_delta_g_sliding_err
sol_end_time_ns
sol_ensemble
sol_ff
sol_rest_exchanges
sol_salt_info
sol_salt_molecules
sol_sid_number_of_frames
sol_sid_snapshot_times_ps
sol_sid_trajectory_interval_ns
sol_sim_time

Values returned in Ns (nanoseconds)

sol_start_time_ns
sol_temperature
sol_timestep_interval
sol_timestep_list
sol_total_atoms
sol_total_replicas
sol_total_waters
sse_limits_lambda0
sse_limits_lambda1
class schrodinger.application.desmond.fep_edge_data.MetalloproteinEdgeData(complex_sea, solvent_sea, pv_st=None, atom_mapping=None, perturbation_type='metalloprotein')

Bases: schrodinger.application.desmond.fep_edge_data.FEPEdgeData

This object stores Metalloprotein FEP related data.

__init__(complex_sea, solvent_sea, pv_st=None, atom_mapping=None, perturbation_type='metalloprotein')
Parameters:
  • complex_sea (sea) – SEA object with results pertaining to the complex leg of the FEP calculation
  • solvent_sea (sea) – SEA object with results pertaining to the solvent leg of the FEP calculation
  • pv_st (schrodinger.Structure) – PoseViewer file must contain 3 structures.. [receptor, lig1, lig2]; otherwise it’s None
  • atom_mapping (Dict[int, int]) – mapping of ligand2 to ligand1 atoms
fullsystem_ct
Return type:schrodinger.structure.Structure
Returns:The full system structure.
receptor_st
Return type:schrodinger.structure.Structure
Returns:The receptor structure.
ligand1_st
Return type:schrodinger.structure.Structure
Returns:The ligand1 structure.
ligand2_st
Return type:schrodinger.structure.Structure
Returns:The ligand2 structure.
ligand_torsions
Return type:(FEPTorsionsContainer object, FEPTorsionsContainer object)
Returns:FEPTorsionsContainer objects for lambda0 and lambda1.
__class__

alias of builtins.type

__delattr__

Implement delattr(self, name).

__dict__ = mappingproxy({'__module__': 'schrodinger.application.desmond.fep_edge_data', '__doc__': '\n This object stores Metalloprotein FEP related data.\n ', '__init__': <function MetalloproteinEdgeData.__init__>, 'fullsystem_ct': <property object>, 'receptor_st': <property object>, 'ligand1_st': <property object>, 'ligand2_st': <property object>, 'ligand_torsions': <property object>, '_protein_sid_rmsf_backbone': <staticmethod object>, 'receptor_sid_rmsf_backbone_lambda0': <property object>, 'receptor_sid_rmsf_backbone_lambda1': <property object>})
__dir__() → list

default dir() implementation

__eq__

Return self==value.

__format__()

default object formatter

__ge__

Return self>=value.

__getattribute__

Return getattr(self, name).

__gt__

Return self>value.

__hash__

Return hash(self).

__init_subclass__()

This method is called when a class is subclassed.

The default implementation does nothing. It may be overridden to extend subclasses.

__le__

Return self<=value.

__lt__

Return self<value.

__module__ = 'schrodinger.application.desmond.fep_edge_data'
__ne__

Return self!=value.

__new__()

Create and return a new object. See help(type) for accurate signature.

__reduce__()

helper for pickle

__reduce_ex__()

helper for pickle

__repr__

Return repr(self).

__setattr__

Implement setattr(self, name, value).

__sizeof__() → int

size of object in memory, in bytes

__str__

Return str(self).

__subclasshook__()

Abstract classes can override this to customize issubclass().

This is invoked early on by abc.ABCMeta.__subclasscheck__(). It should return True, False or NotImplemented. If it returns NotImplemented, the normal algorithm is used. Otherwise, it overrides the normal algorithm (and the outcome is cached).

__weakref__

list of weak references to the object (if defined)

atom_mapping
cpx_charge
cpx_delta_g
Returns:dG and its standard deviation
Return type:float, float
cpx_delta_g_forward
cpx_delta_g_forward_analytical_std
cpx_delta_g_forward_bootstrap_std
cpx_delta_g_forward_df_per_replica
cpx_delta_g_forward_dg
cpx_delta_g_forward_err
cpx_delta_g_reverse
cpx_delta_g_reverse_err
cpx_delta_g_sliding
cpx_delta_g_sliding_err
cpx_end_time_ns
cpx_ensemble
cpx_ff
cpx_rest_exchanges
cpx_salt_info
cpx_salt_molecules
cpx_sid_lp_results
cpx_sid_number_of_frames
cpx_sid_pl_results
cpx_sid_protein_residues

A list of protein residues that interact with both ligand1 and ligand2 throughout the simulation :rtype: str :return: a list of protein tags that interact with both ligand1 and

ligand2
cpx_sid_snapshot_times_ps
cpx_sid_snashot_times_ps
cpx_sid_trajectory_interval_ns
cpx_sim_time

Values returned in Ns (nanoseconds)

cpx_start_time_ns
cpx_temperature
cpx_timestep_interval
cpx_timestep_list
cpx_total_atoms
cpx_total_replicas
cpx_total_waters
delta_delta_g
get_ligand1_atom_dict()
get_ligand2_atom_dict()
get_protein_residues_sequence_tags()
static get_smiles(st)

rtype: str return: Generate SMILES from a given ligand structure.

jobname
leg1_name
leg2_name
ligand1_alchemical_atom_total
ligand1_alchemical_mols
ligand1_atomic_mass
ligand1_charge
ligand1_cpx_asl
ligand1_cpx_sid_lighb(stats=True)
ligand1_cpx_sid_molsa(stats=True)
ligand1_cpx_sid_psa(stats=True)
ligand1_cpx_sid_rb_strain(stats=True)
ligand1_cpx_sid_rgyr(stats=True)
ligand1_cpx_sid_rmsd(stats=True)
ligand1_cpx_sid_sasa(stats=True)
ligand1_cpx_sid_waters(stats=True)
ligand1_fragments(offset_by_receptor_natoms=True)
ligand1_hash
ligand1_mol_formula
ligand1_name
ligand1_pdb_name
ligand1_rot_bonds
ligand1_smiles
ligand1_sol_asl
ligand1_sol_sid_lighb(stats=True)
ligand1_sol_sid_molsa(stats=True)
ligand1_sol_sid_psa(stats=True)
ligand1_sol_sid_rb_strain(stats=True)
ligand1_sol_sid_rgyr(stats=True)
ligand1_sol_sid_rmsd(stats=True)
ligand1_sol_sid_sasa(stats=True)
ligand1_total_atoms
ligand1_total_fragments
ligand1_total_heavy
ligand1_total_hot
ligand1_total_rot_bonds
ligand2_alchemical_atom_total
ligand2_alchemical_mols
ligand2_atomic_mass
ligand2_charge
ligand2_cpx_asl
ligand2_cpx_sid_lighb(stats=True)
ligand2_cpx_sid_molsa(stats=True)
ligand2_cpx_sid_psa(stats=True)
ligand2_cpx_sid_rb_strain(stats=True)
ligand2_cpx_sid_rgyr(stats=True)
ligand2_cpx_sid_rmsd(stats=True)
ligand2_cpx_sid_sasa(stats=True)
ligand2_cpx_sid_waters(stats=True)
ligand2_fragments(offset_by_receptor_natoms=True)
ligand2_hash
ligand2_mol_formula
ligand2_name
ligand2_pdb_name
ligand2_rot_bonds
ligand2_smiles
ligand2_sol_asl
ligand2_sol_sid_lighb(stats=True)
ligand2_sol_sid_molsa(stats=True)
ligand2_sol_sid_psa(stats=True)
ligand2_sol_sid_rb_strain(stats=True)
ligand2_sol_sid_rgyr(stats=True)
ligand2_sol_sid_rmsd(stats=True)
ligand2_sol_sid_sasa(stats=True)
ligand2_total_atoms
ligand2_total_fragments
ligand2_total_heavy
ligand2_total_hot
ligand2_total_rot_bonds
static ligand_name(st)
pl_contact_data0

A dictionary containing PL interactions for lambda=0

pl_contact_data1

A dictionary containing PL interactions for lambda=1

pl_interaction_similarity_matrix0

Protein-ligand interactions similarity matrix for lambda=0 sys for all available frames.

pl_interaction_similarity_matrix1

Protein-ligand interactions similarity matrix for lambda=1 sys for all available frames.

static protein_residue(res)

Get data about the specified residue

Parameters:res (schrodinger.structure._Residue) – The residue object to get data from
Returns:A namedtuple containing the molecule number, chain, residue name,

and residue number :rtype: ResData

receptor_b_factor

Return B factors grouped by residues using PDB tfactor values stored in the structure. If the PDB tfactor values are not present, return zeros.

receptor_chain_names
receptor_charge
receptor_residue_sequence_list

Return a list of residue objects (ResData) in amino-to-carboxy order. :return: a list of residue objects, ordered N->C (amino to carboxy

tails).
Return type:ResData
receptor_residue_sequence_tags

A residue tag looks like this: A:THR_124 (Chain:resname_resnum) if chain is not defined, use ‘_’ (underscore) :return: a list of residue tags :rtype: residue_tag

receptor_residues_interaction_ligand1

A list of preotein residues that interact just with ligand1 :rtype: list :return: list of protein residue tags

receptor_residues_interaction_ligand2

A list of preotein residues that interact just with ligand2 :rtype: list :return: list of protein residue tags

receptor_sid_rmsd_backbone_lambda0
receptor_sid_rmsd_backbone_lambda1
receptor_sid_rmsd_ligand_lambda0

ligand1 RMSD wrt the protein

receptor_sid_rmsd_ligand_lambda1

ligand2 RMSD wrt the protein

receptor_title
receptor_total_atom
receptor_total_heavy
receptor_total_residues
receptor_total_residues_in_chains
short_hash
sol_charge
sol_delta_g
Returns:dG and its standard deviation
Return type:float, float
sol_delta_g_forward
sol_delta_g_forward_analytical_std
sol_delta_g_forward_bootstrap_std
sol_delta_g_forward_df_per_replica
sol_delta_g_forward_dg
sol_delta_g_forward_err
sol_delta_g_reverse
sol_delta_g_reverse_err
sol_delta_g_sliding
sol_delta_g_sliding_err
sol_end_time_ns
sol_ensemble
sol_ff
sol_rest_exchanges
sol_salt_info
sol_salt_molecules
sol_sid_number_of_frames
sol_sid_snapshot_times_ps
sol_sid_trajectory_interval_ns
sol_sim_time

Values returned in Ns (nanoseconds)

sol_start_time_ns
sol_temperature
sol_timestep_interval
sol_timestep_list
sol_total_atoms
sol_total_replicas
sol_total_waters
sse_limits_lambda0
sse_limits_lambda1
receptor_sid_rmsf_backbone_lambda0
Return type:List[float]
Returns:The RMSF for each receptor residue in lambda0.
receptor_sid_rmsf_backbone_lambda1
Return type:List[float]
Returns:The RMSF for each receptor residue in lambda1.