smc_lammps.generate.structures package¶
Subpackages¶
- smc_lammps.generate.structures.dna package
- Submodules
- smc_lammps.generate.structures.dna.dna module
AdvancedObstacleSafetyAdvancedObstacleSafety.__init__()AdvancedObstacleSafety.add_interactions()AdvancedObstacleSafety.get_all_groups()AdvancedObstacleSafety.get_angles()AdvancedObstacleSafety.get_bonds()AdvancedObstacleSafety.get_dna_config()AdvancedObstacleSafety.get_post_process_parameters()AdvancedObstacleSafety.get_stopper_ids()
DnaConfigurationDnaConfiguration.PostProcessParametersDnaConfiguration.__init__()DnaConfiguration.add_bead_to_dna()DnaConfiguration.add_interactions()DnaConfiguration.all_dna_groupsDnaConfiguration.change_dna_stiffness()DnaConfiguration.dna_indices_list_get_all_dna()DnaConfiguration.dna_indices_list_get_dna_from_to()DnaConfiguration.dna_indices_list_get_dna_to()DnaConfiguration.get_all_groups()DnaConfiguration.get_angles()DnaConfiguration.get_bonds()DnaConfiguration.get_dna_config()DnaConfiguration.get_post_process_parameters()DnaConfiguration.get_stopper_ids()DnaConfiguration.map_to_atom_id()DnaConfiguration.set_parameters()DnaConfiguration.set_smc()DnaConfiguration.str_to_config()DnaConfiguration.strand_concat()DnaConfiguration.update_tether_bond()
DnaParametersDoubledFoldedInteractionParametersInteractionParameters.__init__()InteractionParameters.epsilon_DNA_DNAInteractionParameters.epsilon_SMC_DNAInteractionParameters.epsilon_upper_site_DNAInteractionParameters.k_bond_DNA_DNAInteractionParameters.rcut_DNA_DNAInteractionParameters.rcut_SMC_DNAInteractionParameters.rcut_lower_site_DNAInteractionParameters.sigma_DNA_DNAInteractionParameters.sigma_SMC_DNAInteractionParameters.sigma_upper_site_DNA
LineObstacleObstacleSafetyRightAngleSafetyStrandIdTetherTether.GoldTether.ObstacleTether.WallTether.__init__()Tether.add_interactions()Tether.add_tether_interactions()Tether.anglesTether.bondsTether.create_tether()Tether.dna_tether_idTether.get_all_groups()Tether.get_angles()Tether.get_bonds()Tether.get_gold_mass()Tether.get_obstacle()Tether.handle_end_points()Tether.move()Tether.obstacleTether.polymer
class_decorator_factory()with_tether()
- smc_lammps.generate.structures.dna.dna_creator module
- smc_lammps.generate.structures.smc package
- Submodules
- smc_lammps.generate.structures.smc.smc module
SMCSMC.__init__()SMC.add_repel_interactions()SMC.arm_lengthSMC.arms_angle_ATPSMC.bridge_widthSMC.elbow_attractionSMC.elbow_spacingSMC.folding_angle_APOSMC.folding_angle_ATPSMC.get_angles()SMC.get_bonds()SMC.get_groups()SMC.get_impropers()SMC.get_molecule_ids()SMC.get_repulsive_groups()SMC.has_side_site()SMC.has_toroidal_hinge()SMC.hinge_radiusSMC.k_align_siteSMC.k_armSMC.k_asymmetrySMC.k_bondSMC.k_elbowSMC.k_foldSMC.k_hingeSMC.max_bond_lengthSMC.posSMC.t_arms_headsSMC.t_atpSMC.t_hingeSMC.t_kleisinSMC.t_lower_siteSMC.t_middle_siteSMC.t_ref_siteSMC.t_shieldSMC.t_side_siteSMC.t_upper_siteSMC.use_rigid_hinge
- smc_lammps.generate.structures.smc.smc_creator module
SMC_CreatorSMC_Creator.SMC_spacingSMC_Creator.__init__()SMC_Creator.add_side_siteSMC_Creator.arm_lengthSMC_Creator.bridge_widthSMC_Creator.folding_angle_APOSMC_Creator.get_arms()SMC_Creator.get_bridge()SMC_Creator.get_heads_kleisin()SMC_Creator.get_interaction_sites()SMC_Creator.get_mass_per_atom()SMC_Creator.get_smc()SMC_Creator.get_toroidal_hinge()SMC_Creator.hinge_openingSMC_Creator.hinge_radiusSMC_Creator.kleisin_radiusSMC_Creator.lower_site_hSMC_Creator.lower_site_vSMC_Creator.middle_site_hSMC_Creator.middle_site_vSMC_Creator.seedSMC_Creator.shielded_site_template()SMC_Creator.small_noiseSMC_Creator.transpose_rotate_transpose()SMC_Creator.upper_site_hSMC_Creator.upper_site_vSMC_Creator.use_toroidal_hinge
SMC_Pos
Submodules¶
smc_lammps.generate.structures.polymer module¶
- class smc_lammps.generate.structures.polymer.Polymer(*atom_groups: AtomGroup)¶
Bases:
objectOne connected polymer / strand, comprised of any number of atom groups
- convert_ratio(ratio: float) int¶
- full_list() ndarray[tuple[Any, ...], dtype[float32]]¶
- full_list_length() int¶
- handle_negative_index(index: int) int¶
- indices_list_from_to(from_index: int, to_index: int) list[tuple[tuple[AtomGroup, int], tuple[AtomGroup, int]]]¶
smc_lammps.generate.structures.structure_creator module¶
- smc_lammps.generate.structures.structure_creator.attach(reference_segment: ndarray[tuple[Any, ...], dtype[float32]], other_segment: ndarray[tuple[Any, ...], dtype[float32]], delete_overlap: bool, extra_distance: float = 0.0) ndarray[tuple[Any, ...], dtype[float32]]¶
attaches the other_segment by moving its beginning to the end of the reference_segment
- smc_lammps.generate.structures.structure_creator.attach_chain(reference_segment: ndarray[tuple[Any, ...], dtype[float32]], list_of_args) list[ndarray[tuple[Any, ...], dtype[float32]]]¶
returns a list of the updated segments
- smc_lammps.generate.structures.structure_creator.get_circle_segment(n: int, end_inclusive: bool, theta_start: float = 0, theta_end: float = 6.283185307179586, normal_direction=(0, 0, 1)) ndarray[tuple[Any, ...], dtype[float32]]¶
returns a segment of a circle of n beads with unit spacing centered at the origin within the plane perpendical to the given normal_direction (in the x-y plane by default)
- smc_lammps.generate.structures.structure_creator.get_circle_segment_unit_radius(n: int, end_inclusive: bool, theta_start: float = 0, theta_end: float = 6.283185307179586, normal_direction=(0, 0, 1)) ndarray[tuple[Any, ...], dtype[float32]]¶
- smc_lammps.generate.structures.structure_creator.get_interpolated(spacing: float, values) ndarray[tuple[Any, ...], dtype[float32]]¶
spacing: distance between points along curve values: list of 3d points to use in the interpolation returns n equidistant points on an interpolated curve
- smc_lammps.generate.structures.structure_creator.get_straight_segment(n: int, direction=(1, 0, 0)) ndarray[tuple[Any, ...], dtype[float32]]¶
returns a straight segment of n beads with unit spacing starting at the origin and going the in provided direction (positive x-axis by default)