molsysmt.native package#
Submodules#
molsysmt.native.cif_file_handler module#
molsysmt.native.file_tng module#
molsysmt.native.file_xtc module#
molsysmt.native.gro_file_handler module#
molsysmt.native.h5msm_file_handler module#
- class molsysmt.native.h5msm_file_handler.H5MSMFileHandler(filename, io_mode='r', creator='MolSysMT', compression='gzip', compression_opts=4, int_precision='single', float_precision='single', length_unit=None, time_unit=None, energy_unit=None, temperature_unit=None, charge_unit=None, mass_unit=None, closed=False, skip_digestion=False)[source]#
Bases:
object
molsysmt.native.molecular_mechanics module#
- class molsysmt.native.molecular_mechanics.MolecularMechanics(forcefield=None, water_model=None, implicit_solvent=None, non_bonded_method=None, cutoff_distance=None, switch_distance=None, dispersion_correction=None, ewald_error_tolerance=None, constraints=None, flexible_constraints=None, rigid_water=None, hydrogen_mass=None, salt_concentration=None, kappa=None, solute_dielectric=None, solvent_dielectric=None, formal_charge=None, partial_charge=None)[source]#
Bases:
object
molsysmt.native.molecular_mechanics_dict module#
molsysmt.native.molsys module#
- class molsysmt.native.molsys.MolSys(n_atoms=0, n_groups=0, n_components=0, n_molecules=0, n_entities=0, n_chains=0, n_bonds=0, skip_digestion=False)[source]#
Bases:
object
- add(item, atom_indices='all', structure_indices='all', keep_ids=True, skip_digestion=False)[source]#
- add_missing_bonds(threshold='2 angstroms', selection='all', structure_indices=0, syntax='MolSysMT', engine='MolSysMT', with_templates=True, with_distances=True, skip_digestion=False)[source]#
molsysmt.native.pdb_atomic_coordinate_entry module#
- class molsysmt.native.pdb_atomic_coordinate_entry.ConnectivityAnnotationSection[source]#
Bases:
object
- class molsysmt.native.pdb_atomic_coordinate_entry.CrystallographicAndCoordinateTransformationSection[source]#
Bases:
object
- class molsysmt.native.pdb_atomic_coordinate_entry.HetatmRecord[source]#
Bases:
AtomRecord
molsysmt.native.pdb_file_handler module#
molsysmt.native.simulation module#
- class molsysmt.native.simulation.Simulation(molecular_system=None, remove_cm_motion=True, integrator=None, temperature=None, collisions_rate=None, integration_timestep=None, initial_velocities_to_temperature=True, constraint_tolerance=1e-05, platform='CUDA', cuda_precision='mixed')[source]#
Bases:
object
molsysmt.native.simulation_dict module#
molsysmt.native.structures module#
- class molsysmt.native.structures.Structures(constant_time_step=False, time_step=None, constant_id_step=False, id_step=None, constant_box=False, structure_id=None, time=None, coordinates=None, velocities=None, box=None, b_factor=None, alternate_location=None, bioassembly=None, temperature=None, potential_energy=None, kinetic_energy=None, skip_digestion=False)[source]#
Bases:
object
Class to store the trajectory data of a molecular system
- box#
The box of the molecular system in nanometers.
- Type:
pint.Quantity of shape (n_structures, 3, 3)
- coordinates#
The coordinates of the trajectory for each frame.
- Type:
pint.Quantity of shape (n_structures, n_atoms, 3)
- velocities#
The velocities of the trajectory for each frame.
- Type:
pint.Quantity of shape (n_structures, n_atoms, 3)
- n_atoms#
Number of atoms in the trajectory.
- Type:
int
- n_structures#
Number of structures or frames in the trajectory.
- Type:
int
- time#
The times of the trajectory in picoseconds.
- Type:
pint.Quantity of shape (n_structures, )
- id#
- append(structure_id=None, time=None, coordinates=None, velocities=None, box=None, temperature=None, potential_energy=None, kinetic_energy=None, b_factor=None, alternate_location=None, atom_indices='all', structure_indices='all', skip_digestion=False)[source]#
Append structures or frames to this object.
- boxpint.Quantity of shape (n_structures, 3, 3)
The box of the structures
- coordinatespint.Quantity of shape (n_structures, n_atoms, 3)
The coordinates of the trajectory for each frame of it in nanometers.
- timepint.Quantity of shape (n_structures, )
The times of the trajectory in picoseconds
- extract(atom_indices='all', structure_indices='all', copy_if_all=False, skip_digestion=False)[source]#
Returns a new Structures object with the specified atoms and/or structures.
- Parameters:
atom_indices (str or arraylike of int, default='all') – The indices of the extracted atoms.
structure_indices (str or arraylike of int, default='all') – The indices of the extracted structures or frames.
- Returns:
The new structures object with the extracted atoms and frames.
- Return type:
molsysmt.native.structures_dict module#
molsysmt.native.topology module#
- class molsysmt.native.topology.Topology(n_atoms=0, n_groups=0, n_components=0, n_molecules=0, n_entities=0, n_chains=0, n_bonds=0, skip_digestion=False)[source]#
Bases:
object
- rebuild_chains(redefine_indices=True, redefine_ids=True, redefine_types=True, redefine_names=True)[source]#
- rebuild_components(redefine_indices=True, redefine_ids=True, redefine_names=True, redefine_types=True)[source]#
- rebuild_entities(redefine_indices=True, redefine_ids=True, redefine_names=True, redefine_types=True)[source]#