Loading [MathJax]/extensions/tex2jax.js
IMP logo
IMP Reference Guide  develop.ae08f42f4a,2025/04/02
The Integrative Modeling Platform
stereochemistry.py
1 """@namespace IMP.pmi.restraints.stereochemistry
2 Restraints for keeping correct stereochemistry.
3 """
4 
5 import IMP
6 import IMP.core
7 import IMP.atom
8 import IMP.container
9 import IMP.isd
10 import IMP.pmi.tools
11 from operator import itemgetter
12 import math
13 
14 
15 class ConnectivityRestraint(IMP.pmi.restraints.RestraintBase):
16  """Create a restraint between consecutive TempResidue objects
17  or an entire PMI Molecule object."""
18 
19  def __init__(self,
20  objects,
21  scale=1.0,
22  disorderedlength=False,
23  upperharmonic=True,
24  resolution=1,
25  label=None):
26  """
27  @param objects - a list of hierarchies, PMI TempResidues OR a
28  single Molecule
29  @param scale Scale the maximal distance between the beads by this
30  factor when disorderedlength is False. The maximal distance
31  is calculated as ((float(residuegap) + 1.0) * 3.6) * scale.
32  @param disorderedlength - This flag uses either disordered length
33  calculated for random coil peptides (True) or zero
34  surface-to-surface distance between beads (False)
35  as optimal distance for the sequence connectivity restraint.
36  @param upperharmonic - This flag uses either harmonic (False)
37  or upperharmonic (True) in the intra-pair
38  connectivity restraint.
39  @param resolution - The resolution to connect things at - only used
40  if you pass PMI objects
41  @param label - A string to identify this restraint in the
42  output/stat file
43  """
44 
45  hiers = IMP.pmi.tools.input_adaptor(objects, resolution)
46  if len(hiers) > 1:
47  raise Exception("ConnectivityRestraint: only pass stuff from "
48  "one Molecule, please")
49  hiers = hiers[0]
50  m = list(hiers)[0].get_model()
51  super().__init__(m, label=label)
52 
53  self.kappa = 10 # spring constant used for the harmonic restraints
54  SortedSegments = []
55  for h in hiers:
56  try:
57  start = IMP.atom.Hierarchy(h).get_children()[0]
58  except: # noqa: E722
59  start = IMP.atom.Hierarchy(h)
60 
61  try:
62  end = IMP.atom.Hierarchy(h).get_children()[-1]
63  except: # noqa: E722
64  end = IMP.atom.Hierarchy(h)
65 
66  startres = IMP.pmi.tools.get_residue_indexes(start)[0]
67  SortedSegments.append((start, end, startres))
68  SortedSegments = sorted(SortedSegments, key=itemgetter(2))
69 
70  # connect the particles
71  self.particle_pairs = []
72  for x in range(len(SortedSegments) - 1):
73 
74  last = SortedSegments[x][1]
75  first = SortedSegments[x + 1][0]
76 
77  apply_restraint = True
78 
79  # Apply connectivity runless ALL of the following are true:
80  # - first and last both have RigidBodyMember decorators
81  # - first and last are both RigidMembers
82  # - first and last are part of the same RigidBody object
83 
84  # Check for both in a rigid body
89  # Check if the rigid body objects for each particle are
90  # the same object.
91  # if so, skip connectivity restraint
92  if IMP.core.RigidBodyMember(first).get_rigid_body() \
93  == IMP.core.RigidBodyMember(last).get_rigid_body():
94  apply_restraint = False
95 
96  if apply_restraint:
97 
98  nreslast = len(IMP.pmi.tools.get_residue_indexes(last))
99  lastresn = IMP.pmi.tools.get_residue_indexes(last)[-1]
100  nresfirst = len(IMP.pmi.tools.get_residue_indexes(first))
101  firstresn = IMP.pmi.tools.get_residue_indexes(first)[0]
102 
103  residuegap = firstresn - lastresn - 1
104  if disorderedlength and (nreslast / 2 + nresfirst / 2
105  + residuegap) > 20.0:
106  # calculate the distance between the sphere centers
107  # using Kohn PNAS 2004
108  optdist = math.sqrt(5 / 3) * 1.93 * \
109  (nreslast / 2 + nresfirst / 2 + residuegap) ** 0.6
110  if upperharmonic:
111  hu = IMP.core.HarmonicUpperBound(optdist, self.kappa)
112  else:
113  hu = IMP.core.Harmonic(optdist, self.kappa)
115  else: # default
116  optdist = (0.0 + (float(residuegap) + 1.0) * 3.6) * scale
117  if upperharmonic: # default
118  hu = IMP.core.HarmonicUpperBound(optdist, self.kappa)
119  else:
120  hu = IMP.core.Harmonic(optdist, self.kappa)
122 
123  pt0 = last.get_particle()
124  pt1 = first.get_particle()
125  self.particle_pairs.append((pt0, pt1))
127  self.model, dps, (pt0.get_index(), pt1.get_index()))
128 
129  print("Adding sequence connectivity restraint between",
130  pt0.get_name(), " and ", pt1.get_name(), 'of distance',
131  optdist)
132  self.rs.add_restraint(r)
133 
135  """ Returns number of connectivity restraints """
136  return len(self.rs.get_restraints())
137 
139  """ Returns the list of connected particles pairs """
140  return self.particle_pairs
141 
142 
143 class ExcludedVolumeSphere(IMP.pmi.restraints.RestraintBase):
144  """A class to create an excluded volume restraint for a set of particles
145  at a given resolution.
146  Can be initialized as a bipartite restraint between two sets of particles.
147  # Potential additional function: Variable resolution for each PMI object.
148  Perhaps passing selection_tuples with (PMI_object, resolution)
149  """
150  _include_in_rmf = True
151 
152  def __init__(self,
153  included_objects,
154  other_objects=None,
155  resolution=1000,
156  kappa=1.0,
157  label=None):
158  """Constructor.
159  @param included_objects Can be one of the following inputs:
160  IMP Hierarchy, PMI System/State/Molecule/TempResidue,
161  or a list/set of them
162  @param other_objects Initializes a bipartite restraint between
163  included_objects and other_objects
164  Same format as included_objects
165  @param resolution The resolution particles at which to impose the
166  restraint. By default, the coarsest particles will be chosen.
167  If a number is chosen, for each particle, the closest
168  resolution will be used (see IMP.atom.Selection).
169  @param kappa Restraint strength
170  """
171 
172  self.kappa = kappa
173  self.cpc = None
174  bipartite = False
175 
176  # gather IMP hierarchies from input objects
177  hierarchies = IMP.pmi.tools.input_adaptor(included_objects,
178  resolution,
179  flatten=True)
180  included_ps = []
181  if other_objects is not None:
182  bipartite = True
183  other_hierarchies = IMP.pmi.tools.input_adaptor(other_objects,
184  resolution,
185  flatten=True)
186  other_ps = []
187 
188  # perform selection
189  if hierarchies is None:
190  raise Exception("Must at least pass included objects")
191  mdl = hierarchies[0].get_model()
192  super().__init__(mdl, label=label)
193 
194  included_ps = [h.get_particle() for h in hierarchies]
195  if bipartite:
196  other_ps = [h.get_particle() for h in other_hierarchies]
197 
198  # setup score
199  ssps = IMP.core.SoftSpherePairScore(self.kappa)
200  lsa = IMP.container.ListSingletonContainer(self.model)
201  lsa.add(IMP.get_indexes(included_ps))
202 
203  # setup close pair container
204  if not bipartite:
206  self.cpc = IMP.container.ClosePairContainer(lsa, 0.0, rbcpf, 10.0)
207  evr = IMP.container.PairsRestraint(ssps, self.cpc)
208  else:
209  other_lsa = IMP.container.ListSingletonContainer(self.model)
210  other_lsa.add(IMP.get_indexes(other_ps))
212  lsa,
213  other_lsa,
214  0.0,
215  10.0)
216  evr = IMP.container.PairsRestraint(ssps, self.cpc)
217 
218  self.rs.add_restraint(evr)
219 
220  def add_excluded_particle_pairs(self, excluded_particle_pairs):
221  # add pairs to be filtered when calculating the score
222  inverted = [(p1, p0) for p0, p1 in excluded_particle_pairs]
223  lpc = IMP.container.ListPairContainer(self.model)
224  lpc.add(IMP.get_indexes(excluded_particle_pairs))
225  lpc.add(IMP.get_indexes(inverted))
227  self.cpc.add_pair_filter(icpf)
228 
229 
230 class HelixRestraint(IMP.pmi.restraints.RestraintBase):
231  """Enforce ideal Helix dihedrals and bonds for a selection
232  at resolution 0"""
233  def __init__(self,
234  hierarchy,
235  selection_tuple,
236  weight=1.0,
237  label=None):
238  """Constructor
239  @param hierarchy the root node
240  @param selection_tuple (start, stop, molname, copynum=0)
241  @param weight
242  """
243  m = hierarchy.get_model()
244  super().__init__(m, weight=weight)
245  start = selection_tuple[0]
246  stop = selection_tuple[1]
247  mol = selection_tuple[2]
248  copy_index = 0
249  if len(selection_tuple) > 3:
250  copy_index = selection_tuple[3]
251 
252  sel = IMP.atom.Selection(
253  hierarchy, molecule=mol, copy_index=copy_index,
254  residue_indexes=range(start, stop+1))
255  ps = sel.get_selected_particles(with_representation=False)
256  res = [IMP.atom.Residue(p) for p in ps]
257  self.r = IMP.atom.HelixRestraint(res)
258  self.rs.add_restraint(self.r)
259  print('Created helix %s.%i.%i-%i with %i dihedrals and %i bonds'
260  % (mol, copy_index, start, stop, self.get_number_of_bonds(),
261  self.get_number_of_dihedrals()))
262 
263  def get_number_of_bonds(self):
264  return self.r.get_number_of_bonds()
265 
266  def get_number_of_dihedrals(self):
267  return self.r.get_number_of_dihedrals()
268 
269 
270 class ResidueBondRestraint(IMP.pmi.restraints.RestraintBase):
271  """ Add bond restraint between pair of consecutive
272  residues/beads to enforce the stereochemistry.
273  """
274  def __init__(self, objects, distance=3.78, strength=10.0, jitter=None):
275  """Constructor
276  @param objects Objects to restrain
277  @param distance Resting distance for restraint
278  @param strength Bond constant
279  @param jitter Defines the +- added to the optimal distance in
280  the harmonic well restraint used to increase the tolerance
281  """
282 
283  particles = IMP.pmi.tools.input_adaptor(objects, 1, flatten=True)
284  m = particles[0].get_model()
285  super().__init__(m)
286 
287  self.pairslist = []
288 
289  if not jitter:
290  ts = IMP.core.Harmonic(distance, strength)
291  else:
293  (distance - jitter, distance + jitter), strength)
294 
295  for ps in IMP.pmi.tools.sublist_iterator(particles, 2, 2):
296  pair = []
297  if len(ps) != 2:
298  raise ValueError("wrong length of pair")
299  for p in ps:
301  raise TypeError("%s is not a residue" % p)
302  else:
303  pair.append(p)
304  print("ResidueBondRestraint: adding a restraint between %s %s"
305  % (pair[0].get_name(), pair[1].get_name()))
306  self.rs.add_restraint(
307  IMP.core.DistanceRestraint(self.model, ts, pair[0], pair[1]))
308  self.pairslist.append(IMP.ParticlePair(pair[0], pair[1]))
309  self.pairslist.append(IMP.ParticlePair(pair[1], pair[0]))
310 
311  def get_excluded_pairs(self):
312  return self.pairslist
313 
314 
315 class ResidueAngleRestraint(IMP.pmi.restraints.RestraintBase):
316  """Add angular restraint between triplets of consecutive
317  residues/beads to enforce the stereochemistry.
318  """
319  def __init__(self, objects, anglemin=100.0, anglemax=140.0, strength=10.0):
320 
321  particles = IMP.pmi.tools.input_adaptor(objects, 1, flatten=True)
322  m = particles[0].get_model()
323  super().__init__(m)
324 
325  self.pairslist = []
326 
328  (math.pi * anglemin / 180.0,
329  math.pi * anglemax / 180.0),
330  strength)
331 
332  for ps in IMP.pmi.tools.sublist_iterator(particles, 3, 3):
333  triplet = []
334  if len(ps) != 3:
335  raise ValueError("wrong length of triplet")
336  for p in ps:
338  raise TypeError("%s is not a residue" % p)
339  else:
340  triplet.append(p)
341  print("ResidueAngleRestraint: adding a restraint between %s %s %s"
342  % (triplet[0].get_name(), triplet[1].get_name(),
343  triplet[2].get_name()))
344  self.rs.add_restraint(
345  IMP.core.AngleRestraint(triplet[0].get_model(), ts,
346  triplet[0],
347  triplet[1],
348  triplet[2]))
349  self.pairslist.append(IMP.ParticlePair(triplet[0], triplet[2]))
350  self.pairslist.append(IMP.ParticlePair(triplet[2], triplet[0]))
351 
352  def get_excluded_pairs(self):
353  return self.pairslist
354 
355 
356 class ResidueDihedralRestraint(IMP.pmi.restraints.RestraintBase):
357  """Add dihedral restraints between quadruplet of consecutive
358  residues/beads to enforce the stereochemistry.
359  Give as input a string of "C" and "T", meaning cys (0+-40)
360  or trans (180+-40) dihedral. The length of the string must be #residue-3.
361  Without the string, the dihedral will be assumed trans.
362  """
363  def __init__(self, objects, stringsequence=None, strength=10.0):
364 
365  particles = IMP.pmi.tools.input_adaptor(objects, 1, flatten=True)
366  m = particles[0].get_model()
367  super().__init__(m)
368 
369  self.pairslist = []
370 
371  if stringsequence is None:
372  stringsequence = "T" * (len(particles) - 3)
373 
374  for n, ps in enumerate(
375  IMP.pmi.tools.sublist_iterator(particles, 4, 4)):
376  quadruplet = []
377  if len(ps) != 4:
378  raise ValueError("wrong length of quadruplet")
379  for p in ps:
381  raise TypeError("%s is not a residue" % p)
382  else:
383  quadruplet.append(p)
384  dihedraltype = stringsequence[n]
385  if dihedraltype == "C":
386  anglemin = -20.0
387  anglemax = 20.0
389  (math.pi * anglemin / 180.0,
390  math.pi * anglemax / 180.0),
391  strength)
392  print("ResidueDihedralRestraint: adding a CYS restraint "
393  "between %s %s %s %s"
394  % (quadruplet[0].get_name(), quadruplet[1].get_name(),
395  quadruplet[2].get_name(), quadruplet[3].get_name()))
396  if dihedraltype == "T":
397  anglemin = 180 - 70.0
398  anglemax = 180 + 70.0
400  (math.pi * anglemin / 180.0,
401  math.pi * anglemax / 180.0),
402  strength)
403  print("ResidueDihedralRestraint: adding a TRANS restraint "
404  "between %s %s %s %s"
405  % (quadruplet[0].get_name(),
406  quadruplet[1].get_name(), quadruplet[2].get_name(),
407  quadruplet[3].get_name()))
408  self.rs.add_restraint(
409  IMP.core.DihedralRestraint(self.model, ts,
410  quadruplet[0],
411  quadruplet[1],
412  quadruplet[2],
413  quadruplet[3]))
414  self.pairslist.append(
415  IMP.ParticlePair(quadruplet[0], quadruplet[3]))
416  self.pairslist.append(
417  IMP.ParticlePair(quadruplet[3], quadruplet[0]))
418 
419 
421  """Add harmonic restraints between all pairs
422  """
423  def __init__(self, hierarchy, selection_tuples=None, resolution=1,
424  strength=0.01, dist_cutoff=10.0, ca_only=True):
425  """Constructor
426  @param hierarchy Root hierarchy to select from
427  @param selection_tuples Selecting regions for the restraint
428  [[start,stop,molname,copy_index=0],...]
429  @param resolution Resolution for applying restraint
430  @param strength Bond strength
431  @param dist_cutoff Cutoff for making restraints
432  @param ca_only Selects only CAlphas. Only matters if resolution=0.
433  """
434 
435  particles = []
436  self.m = hierarchy.get_model()
437  for st in selection_tuples:
438  copy_index = 0
439  if len(st) > 3:
440  copy_index = st[3]
441  if not ca_only:
442  sel = IMP.atom.Selection(
443  hierarchy, molecule=st[2],
444  residue_indexes=range(st[0], st[1]+1),
445  copy_index=copy_index)
446  else:
447  sel = IMP.atom.Selection(
448  hierarchy, molecule=st[2],
449  residue_indexes=range(st[0], st[1]+1),
450  copy_index=copy_index,
451  atom_type=IMP.atom.AtomType("CA"))
452  particles += sel.get_selected_particles()
453 
454  self.weight = 1
455  self.label = "None"
456  self.pairslist = []
457 
458  # create score
460  particles, dist_cutoff, strength)
461  for r in self.rs.get_restraints():
462  a1, a2 = r.get_inputs()
463  self.pairslist.append(IMP.ParticlePair(a1, a2))
464  self.pairslist.append(IMP.ParticlePair(a2, a1))
465  print('ElasticNetwork: created', self.rs.get_number_of_restraints(),
466  'restraints')
467 
468  def set_label(self, label):
469  self.label = label
470  self.rs.set_name(label)
471  for r in self.rs.get_restraints():
472  r.set_name(label)
473 
474  def add_to_model(self):
475  IMP.pmi.tools.add_restraint_to_model(self.m, self.rs)
476 
477  def get_restraint(self):
478  return self.rs
479 
480  def set_weight(self, weight):
481  self.weight = weight
482  self.rs.set_weight(weight)
483 
484  def get_excluded_pairs(self):
485  return self.pairslist
486 
487  def get_output(self):
488  output = {}
489  score = self.weight * self.rs.unprotected_evaluate(None)
490  output["_TotalScore"] = str(score)
491  output["ElasticNetworkRestraint_" + self.label] = str(score)
492  return output
493 
494 
496  """ Enable CHARMM force field """
497  def __init__(self, root, ff_temp=300.0, zone_ps=None, zone_size=10.0,
498  enable_nonbonded=True, enable_bonded=True,
499  zone_nonbonded=False):
500  """Setup the CHARMM restraint on a selection. Expecting atoms.
501  @param root The node at which to apply the restraint
502  @param ff_temp The temperature of the force field
503  @param zone_ps Create a zone around this set of particles
504  Automatically includes the entire residue (incl. backbone)
505  @param zone_size The size for looking for neighbor residues
506  @param enable_nonbonded Allow the repulsive restraint
507  @param enable_bonded Allow the bonded restraint
508  @param zone_nonbonded EXPERIMENTAL: exclude from nonbonded all
509  sidechains that aren't in zone!
510  """
511 
512  kB = (1.381 * 6.02214) / 4184.0
513 
514  self.mdl = root.get_model()
515  self.bonds_rs = IMP.RestraintSet(self.mdl, 1.0 / (kB * ff_temp),
516  'BONDED')
517  self.nonbonded_rs = IMP.RestraintSet(self.mdl, 1.0 / (kB * ff_temp),
518  'NONBONDED')
519  self.weight = 1.0
520  self.label = ""
521 
522  # setup topology and bonds etc
523  if enable_bonded:
525  topology = ff.create_topology(root)
526  topology.apply_default_patches()
527  topology.setup_hierarchy(root)
528  if zone_ps is not None:
529  limit_to_ps = IMP.pmi.topology.get_particles_within_zone(
530  root, zone_ps, zone_size, entire_residues=True,
531  exclude_backbone=False)
533  topology,
534  limit_to_ps)
535  self.ps = limit_to_ps
536  else:
537  r = IMP.atom.CHARMMStereochemistryRestraint(root, topology)
538  self.ps = IMP.core.get_leaves(root)
539  print('init bonds score', r.unprotected_evaluate(None))
540  self.bonds_rs.add_restraint(r)
541  ff.add_radii(root)
542 
543  atoms = IMP.atom.get_by_type(root, IMP.atom.ATOM_TYPE)
544  # non-bonded forces
545  if enable_nonbonded:
546  if (zone_ps is not None) and zone_nonbonded:
547  print('stereochemistry: zone_nonbonded is True')
548  # atoms list should only include backbone plus zone_ps!
549  backbone_types = ['C', 'N', 'CB', 'O']
550  sel = IMP.atom.Selection(
551  root, atom_types=[IMP.atom.AtomType(n)
552  for n in backbone_types])
553  backbone_atoms = sel.get_selected_particles()
554  sel_ps = IMP.pmi.topology.get_particles_within_zone(
555  root, zone_ps, zone_size, entire_residues=True,
556  exclude_backbone=True)
557 
559  IMP.container.ListSingletonContainer(backbone_atoms),
561  4.0)
562  else:
563  cont = IMP.container.ListSingletonContainer(self.mdl, atoms)
564  self.nbl = IMP.container.ClosePairContainer(cont, 4.0)
565  if enable_bonded:
566  self.nbl.add_pair_filter(r.get_full_pair_filter())
567  pairscore = IMP.isd.RepulsiveDistancePairScore(0, 1)
568  pr = IMP.container.PairsRestraint(pairscore, self.nbl)
569  self.nonbonded_rs.add_restraint(pr)
570  print('CHARMM is set up')
571 
572  def set_label(self, label):
573  self.label = label
574  self.rs.set_name(label)
575  for r in self.rs.get_restraints():
576  r.set_name(label)
577 
578  def add_to_model(self):
579  IMP.pmi.tools.add_restraint_to_model(self.mdl, self.bonds_rs)
580  IMP.pmi.tools.add_restraint_to_model(self.mdl, self.nonbonded_rs)
581 
582  def get_restraint(self):
583  return self.rs
584 
585  def get_close_pair_container(self):
586  return self.nbl
587 
588  def set_weight(self, weight):
589  self.weight = weight
590  self.rs.set_weight(weight)
591 
592  def get_output(self):
593  output = {}
594  bonds_score = self.weight * self.bonds_rs.unprotected_evaluate(None)
595  nonbonded_score = \
596  self.weight * self.nonbonded_rs.unprotected_evaluate(None)
597  score = bonds_score+nonbonded_score
598  output["_TotalScore"] = str(score)
599  output["CHARMM_BONDS"] = str(bonds_score)
600  output["CHARMM_NONBONDED"] = str(nonbonded_score)
601  return output
602 
603 
605  """Add bonds and improper dihedral restraints for the CBs
606  """
607  def __init__(
608  self, rnums, representation, selection_tuple, strength=10.0, kappa=1.0,
609  jitter_angle=0.0, jitter_improper=0.0):
610  '''
611  need to add:
612  ca-ca bond
613  ca-cb is a constraint, no restraint needed
614  ca-ca-ca
615  cb-ca-ca-cb
616  '''
617 
618  self.m = representation.prot.get_model()
619  self.rs = IMP.RestraintSet(self.m, "PseudoAtomic")
620  self.rset_angles = IMP.RestraintSet(self.m, "PseudoAtomic_Angles")
621  self.rset_bonds = IMP.RestraintSet(self.m, "PseudoAtomic_Bonds")
622  self.weight = 1
623  self.label = "None"
624  self.pairslist = []
625 
626  for rnum in rnums:
627  ca, cb = self.get_ca_cb(
628  IMP.pmi.tools.select_by_tuple(representation,
629  (rnum, rnum, 'chainA'),
630  resolution=0))
631  if cb is not None:
632  nter = False
633  cter = False
634  ca_prev, cb_prev = self.get_ca_cb(
635  IMP.pmi.tools.select_by_tuple(representation,
636  (rnum - 1, rnum - 1,
637  'chainA'), resolution=0))
638  ca_next, cb_next = self.get_ca_cb(
639  IMP.pmi.tools.select_by_tuple(representation,
640  (rnum + 1, rnum + 1,
641  'chainA'), resolution=0))
642  if ca_prev is None:
643  nter = True
644  else:
645  if ca_next is None:
646  cter = True
647  else:
648  if (nter and cter):
649  continue
650 
651  # adding a bond restraint between CA and CB
652  # h=IMP.core.Harmonic(6.0,kappa)
653  # dps=IMP.core.DistancePairScore(h)
654  # pr=IMP.core.PairRestraint(dps,IMP.ParticlePair(ca,cb))
655  # self.pairslist.append((ca,cb))
656  # self.rset_bonds.add_restraint(pr)
657 
658  # creating improper dihedral restraint
659  # hus=IMP.core.Harmonic(2.09,kappa)
661  2.09 +
662  jitter_angle /
663  0.5,
664  kappa)
666  2.09 -
667  jitter_angle /
668  0.5,
669  kappa)
670  if not nter:
671  # ar13=IMP.core.AngleRestraint(hus,ca_prev,ca,cb)
672  # self.rset_angles.add_restraint(ar13)
673  ar13u = IMP.core.AngleRestraint(hupp, ca_prev, ca, cb)
674  ar13l = IMP.core.AngleRestraint(hlow, ca_prev, ca, cb)
675  self.rset_angles.add_restraint(ar13u)
676  self.rset_angles.add_restraint(ar13l)
677  if not cter:
678  # ar23=IMP.core.AngleRestraint(hus,ca_next,ca,cb)
679  # self.rset_angles.add_restraint(ar23)
680  ar23u = IMP.core.AngleRestraint(hupp, ca_next, ca, cb)
681  ar23l = IMP.core.AngleRestraint(hlow, ca_next, ca, cb)
682  self.rset_angles.add_restraint(ar23u)
683  self.rset_angles.add_restraint(ar23l)
684  if not nter and not cter:
685  # hus2=IMP.core.Harmonic(0,kappa)
686  # idr=IMP.core.DihedralRestraint(hus2,ca,ca_prev,ca_next,cb)
687  # self.rset_angles.add_restraint(idr)
688 
689  hus2upp = IMP.core.HarmonicUpperBound(
690  jitter_improper,
691  kappa)
692  hus2low = IMP.core.HarmonicLowerBound(
693  -
694  jitter_improper,
695  kappa)
697  hus2upp,
698  ca,
699  ca_prev,
700  ca_next,
701  cb)
703  hus2low,
704  ca,
705  ca_prev,
706  ca_next,
707  cb)
708  self.rset_angles.add_restraint(idru)
709  self.rset_angles.add_restraint(idrl)
710  self.rs.add_restraint(self.rset_bonds)
711  self.rs.add_restraint(self.rset_angles)
712 
713  def get_ca_cb(self, atoms):
714  ca = None
715  cb = None
716  for a in atoms:
717  if IMP.atom.Atom(a).get_atom_type() == IMP.atom.AtomType("CA"):
718  ca = a.get_particle()
719  elif IMP.atom.Atom(a).get_atom_type() == IMP.atom.AtomType("CB"):
720  cb = a.get_particle()
721  return ca, cb
722 
723  def set_label(self, label):
724  self.label = label
725  self.rs.set_name(label)
726  for r in self.rs.get_restraints():
727  r.set_name(label)
728 
729  def add_to_model(self):
730  IMP.pmi.tools.add_restraint_to_model(self.m, self.rs)
731 
732  def get_restraint(self):
733  return self.rs
734 
735  def set_weight(self, weight):
736  self.weight = weight
737  self.rs.set_weight(weight)
738 
739  def get_excluded_pairs(self):
740  return self.pairslist
741 
742  def get_output(self):
743  output = {}
744  score = self.weight * self.rs.unprotected_evaluate(None)
745  output["_TotalScore"] = str(score)
746  output["PseudoAtomicRestraint_" + self.label] = str(score)
747  return output
748 
749 
751  """Create harmonic restraints between the reference and (transformed)
752  clones.
753 
754  @note Wraps IMP::core::TransformedDistancePairScore with an
755  IMP::core::Harmonic
756  """
757  def __init__(self, references, clones_list, transforms,
758  label='', strength=10.0, ca_only=False):
759  """Constructor
760  @param references Can be one of the following inputs:
761  IMP Hierarchy, PMI System/State/Molecule/TempResidue,
762  or a list/set of them
763  @param clones_list List of lists of the above
764  @param transforms Transforms moving each selection to the first
765  selection
766  @param label Label for output
767  @param strength The elastic bond strength
768  @param ca_only Optionally select so only CAlpha particles are used
769  """
770 
771  refs = IMP.pmi.tools.input_adaptor(references, flatten=True)
772  self.mdl = refs[0].get_model()
773  self.rs = IMP.RestraintSet(self.mdl, "Symmetry")
774  self.weight = 1
775  self.label = label
776  if len(clones_list) != len(transforms):
777  raise Exception(
778  'Error: There should be as many clones as transforms')
779 
780  harmonic = IMP.core.Harmonic(0., strength)
781  for tmp_clones, trans in zip(clones_list, transforms):
782  clones = IMP.pmi.tools.input_adaptor(tmp_clones, flatten=True)
783  if len(clones) != len(refs):
784  raise Exception("Error: len(references)!=len(clones)")
785  pair_score = IMP.core.TransformedDistancePairScore(harmonic, trans)
786  for p0, p1 in zip(refs, clones):
787  if not ca_only or (
788  IMP.atom.Atom(p0).get_atom_type()
789  == IMP.atom.AtomType("CA") and
790  IMP.atom.Atom(p1).get_atom_type()
791  == IMP.atom.AtomType("CA")):
793  self.mdl, pair_score, [p0.get_particle_index(),
794  p1.get_particle_index()])
795  self.rs.add_restraint(r)
796  print('created symmetry network with',
797  self.rs.get_number_of_restraints(), 'restraints')
798 
799  def set_label(self, label):
800  self.label = label
801  self.rs.set_name(label)
802  for r in self.rs.get_restraints():
803  r.set_name(label)
804 
805  def add_to_model(self):
806  IMP.pmi.tools.add_restraint_to_model(self.mdl, self.rs)
807 
808  def get_restraint(self):
809  return self.rs
810 
811  def set_weight(self, weight):
812  self.weight = weight
813  self.rs.set_weight(weight)
814 
815  def get_excluded_pairs(self):
816  return self.pairslist
817 
818  def get_output(self):
819  output = {}
820  score = self.weight * self.rs.unprotected_evaluate(None)
821  output["SymmetryRestraint_" + self.label] = str(score)
822  output["_TotalScore"] = str(score)
823  return output
824 
825 
827  """Creates a restraint between the termini two polypeptides, to simulate
828  the sequence connectivity."""
829  def __init__(self, nterminal, cterminal, scale=1.0, disorderedlength=False,
830  upperharmonic=True, resolution=1, label="None"):
831  """
832  @param nterminal - single PMI2 Hierarchy/molecule at the nterminal
833  @param cterminal - single PMI2 Hierarchy/molecule at the cterminal
834  @param scale Scale the maximal distance between the beads by this
835  factor when disorderedlength is False.
836  The maximal distance is calculated as
837  ((float(residuegap) + 1.0) * 3.6) * scale.
838  @param disorderedlength - This flag uses either disordered length
839  calculated for random coil peptides (True) or zero
840  surface-to-surface distance between beads (False)
841  as optimal distance for the sequence connectivity
842  restraint.
843  @param upperharmonic - This flag uses either harmonic (False)
844  or upperharmonic (True) in the intra-pair
845  connectivity restraint.
846  @param resolution - The resolution to connect things at - only used
847  if you pass PMI objects
848  @param label - A string to identify this restraint in the
849  output/stat file
850  """
851  self.label = label
852  self.weight = 1.0
853  ssn = IMP.pmi.tools.get_sorted_segments(nterminal)
854  ssc = IMP.pmi.tools.get_sorted_segments(cterminal)
855  nter_lastres = ssn[-1][1]
856  cter_firstres = ssc[0][0]
857  self.m = nter_lastres.get_model()
858 
859  self.kappa = 10 # spring constant used for the harmonic restraints
860 
861  optdist = (3.6) * scale
862  if upperharmonic: # default
863  hu = IMP.core.HarmonicUpperBound(optdist, self.kappa)
864  else:
865  hu = IMP.core.Harmonic(optdist, self.kappa)
867 
868  pt0 = nter_lastres.get_particle()
869  pt1 = cter_firstres.get_particle()
870  r = IMP.core.PairRestraint(self.m, dps,
871  (pt0.get_index(), pt1.get_index()))
872  self.rs = IMP.RestraintSet(self.m, "fusion_restraint")
873  print("Adding fusion connectivity restraint between", pt0.get_name(),
874  " and ", pt1.get_name(), 'of distance', optdist)
875  self.rs.add_restraint(r)
876 
877  def set_label(self, label):
878  self.label = label
879 
880  def get_weight(self):
881  return self.weight
882 
883  def add_to_model(self):
884  IMP.pmi.tools.add_restraint_to_model(self.m, self.rs)
885 
886  def get_restraint(self):
887  return self.rs
888 
889  def set_weight(self, weight):
890  self.weight = weight
891  self.rs.set_weight(weight)
892 
893  def get_output(self):
894  output = {}
895  score = self.weight * self.rs.unprotected_evaluate(None)
896  output["_TotalScore"] = str(score)
897  output["FusionRestraint_" + self.label] = str(score)
898  return output
899 
900  def evaluate(self):
901  return self.weight * self.rs.unprotected_evaluate(None)
902 
903 
904 class PlaneDihedralRestraint(IMP.pmi.restraints.RestraintBase):
905 
906  """Restrain the dihedral between planes defined by three particles.
907 
908  This restraint is useful for restraining the twist of a string of
909  more or less identical rigid bodies, so long as the curvature is mild.
910  """
911 
912  def __init__(self, particle_triplets, angle=0., k=1., label=None,
913  weight=1.):
914  """Constructor
915  @param particle_triplets List of lists of 3 particles. Each triplet
916  defines a plane. Dihedrals of adjacent planes
917  in list are scored.
918  @param angle Angle of plane dihedral in degrees
919  @param k Strength of restraint
920  @param label Label for output
921  @param weight Weight of restraint
922  @note Particles defining planes should be rigid and more or less
923  parallel for proper behavior
924  """
925  model = particle_triplets[0][0].get_model()
926  super().__init__(model, label=label, weight=weight)
927 
928  angle = math.pi * angle / 180.
929  ds = IMP.core.Cosine(.5 * k, 1, -angle)
930  for i, t1 in enumerate(particle_triplets[:-1]):
931  t2 = particle_triplets[i + 1]
932  q1 = [t1[1], t1[0], t2[0], t2[1]]
933  q2 = [t1[2], t1[0], t2[0], t2[2]]
934  self.rs.add_restraint(
935  IMP.core.DihedralRestraint(self.model, ds, *q1))
936  self.rs.add_restraint(
937  IMP.core.DihedralRestraint(self.model, ds, *q2))
A filter which returns true if a container contains the Pair.
Add dihedral restraints between quadruplet of consecutive residues/beads to enforce the stereochemist...
CHARMMParameters * get_heavy_atom_CHARMM_parameters()
Lower bound harmonic function (non-zero when feature < mean)
static bool get_is_setup(const IMP::ParticleAdaptor &p)
Definition: Residue.h:158
Enforce CHARMM stereochemistry on the given Hierarchy.
A member of a rigid body, it has internal (local) coordinates.
Definition: rigid_bodies.h:634
static bool get_is_setup(const IMP::ParticleAdaptor &p)
Definition: rigid_bodies.h:635
Various classes to hold sets of particles.
Upper bound harmonic function (non-zero when feature > mean)
A class to store a fixed array of same-typed values.
Definition: Array.h:40
Enforce ideal Helix dihedrals and bonds for a selection at resolution 0.
Miscellaneous utilities.
Definition: tools.py:1
Cosine function.
Definition: Cosine.h:25
Creates a restraint between the termini two polypeptides, to simulate the sequence connectivity...
Add harmonic restraints between all pairs.
Apply a function to the distance between two particles after transforming the second.
Restrain the dihedral between planes defined by three particles.
Dihedral restraint between four particles.
The type of an atom.
A score on the distance between the surfaces of two spheres.
Return all close unordered pairs of particles taken from the SingletonContainer.
static bool get_is_setup(const IMP::ParticleAdaptor &p)
Definition: rigid_bodies.h:749
Return all spatially-proximal pairs of particles (a,b) from the two SingletonContainers A and B...
GenericHierarchies get_leaves(Hierarchy mhd)
Get all the leaves of the bit of hierarchy.
Distance restraint between two particles.
Object used to hold a set of restraints.
Definition: RestraintSet.h:41
def input_adaptor
Adapt things for PMI (degrees of freedom, restraints, ...) Returns list of list of hierarchies...
Definition: tools.py:872
Store a list of ParticleIndexPairs.
A well with harmonic barriers.
Definition: HarmonicWell.h:25
Angle restraint between three particles.
ParticleIndexPairs get_indexes(const ParticlePairsTemp &ps)
Get the indexes from a list of particle pairs.
Add bond restraint between pair of consecutive residues/beads to enforce the stereochemistry.
The standard decorator for manipulating molecular structures.
RestraintSet * create_elastic_network(const Particles &ps, Float dist_cutoff, Float strength)
Create an elastic network restraint set.
Definition: pmi/utilities.h:26
Add bonds and improper dihedral restraints for the CBs.
Store a list of ParticleIndexes.
A decorator for a particle representing an atom.
Definition: atom/Atom.h:238
def get_particle_pairs
Returns the list of connected particles pairs.
def add_restraint_to_model
Add a PMI restraint to the model.
Definition: tools.py:84
def __init__
Setup the CHARMM restraint on a selection.
Create harmonic restraints between the reference and (transformed) clones.
Add angular restraint between triplets of consecutive residues/beads to enforce the stereochemistry...
def get_num_restraints
Returns number of connectivity restraints.
Score a pair of particles based on the distance between their centers.
A decorator for a residue.
Definition: Residue.h:137
Basic functionality that is expected to be used by a wide variety of IMP users.
Create a restraint between consecutive TempResidue objects or an entire PMI Molecule object...
A class to create an excluded volume restraint for a set of particles at a given resolution.
The general base class for IMP exceptions.
Definition: exception.h:48
def __init__
need to add: ca-ca bond ca-cb is a constraint, no restraint needed ca-ca-ca cb-ca-ca-cb ...
Applies a PairScore to a Pair.
Definition: PairRestraint.h:31
def get_sorted_segments
Returns sequence-sorted segments array, each containing the first particle the last particle and the ...
Definition: tools.py:1007
Functionality for loading, creating, manipulating and scoring atomic structures.
Select hierarchy particles identified by the biological name.
Definition: Selection.h:70
Applies a PairScore to each Pair in a list.
def get_residue_indexes
Retrieve the residue indexes for the given particle.
Definition: tools.py:499
A repulsive potential on the distance between two atoms.
Perform more efficient close pair finding when rigid bodies are involved.
Inferential scoring building on methods developed as part of the Inferential Structure Determination ...
def sublist_iterator
Yield all sublists of length >= lmin and <= lmax.
Definition: tools.py:574
Harmonic function (symmetric about the mean)
Definition: core/Harmonic.h:27
Restraint a set of residues to use ideal helix dihedrals and bonds.