(Deprecated) Analysing pore dimensions with HOLE

Here we use HOLE to analyse pore dimensions in a membrane.

Warning

The MDAnalysis.analysis.hole is now deprecated in favor of MDAnalysis.analysis.hole2, and will be removed in 2.0.0. Please see the updated notebook for the updated tutorial.

Last executed: May 18, 2021 with MDAnalysis 1.1.1

Last updated: January 2020

Minimum version of MDAnalysis: 0.18.0

Packages required:

Note

The classes in MDAnalysis.analysis.hole are wrappers around the HOLE program. Please cite ([SGW93], [SNW+96]) when using this module in published work.

[1]:
import MDAnalysis as mda
from MDAnalysis.tests.datafiles import PDB_HOLE
from MDAnalysis.analysis import hole
import matplotlib.pyplot as plt
%matplotlib inline

Using HOLE with a PDB file

MDAnalysis.analysis.hole.HOLE is a wrapper class (API docs) that calls the HOLE program. This means you must have installed the program yourself before you can use the class. You then need to pass the path to your hole executable to the class; in this example, hole is installed at ~/hole2/exe/hole.

HOLE defines a series of points throughout the pore from which a sphere can be generated that does not overlap any atom (as defined by its van der Waals radius). (Please see ([SGW93], [SNW+96]) for a complete explanation). By default, it ignores residues with the following names: “SOL”, “WAT”, “TIP”, “HOH”, “K”, “NA”, “CL”. You can change these with the ignore_residues keyword. Note that the residue names must have 3 characters. Wildcards do not work.

The PDB file here is the experimental structure of the Gramicidin A channel. Note that we pass HOLE a PDB file directly, without creating a MDAnalysis.Universe.

[2]:
h = hole.HOLE(PDB_HOLE, executable='~/hole2/exe/hole',
              logfile='hole1.out',
              sphpdb='hole1.sph',
              raseed=31415)
h.run()
h.collect()

This will create several outputs in your directory:

  • hole1.out: the log file for HOLE.

  • hole1.sph: a PDB-like file containing the coordinates of the pore centers.

  • simple2.rad: file of Van der Waals’ radii

  • run_n/radii_n_m.dat.gz: the profile for each frame

  • tmp/pdb_name.pdb: the short name of a PDB file with your structure. As hole is a FORTRAN77 program, it is limited in how long of a filename that it can read.

The pore profile itself is in a dictionary at h.profiles. There is only one frame in this PDB file, so it is at h.profiles[0].

[3]:
len(h.profiles[0])
[3]:
425

Each profile is a numpy.recarray with the fields below as an entry for each rxncoord:

  • frame: the integer frame number

  • rxncoord: the distance along the pore axis in angstrom

  • radius: the pore radius in angstrom

[4]:
h.profiles[0].dtype.names
[4]:
('frame', 'rxncoord', 'radius')

You can then proceed with your own analysis of the profiles.

[5]:
rxncoords = h.profiles[0].rxncoord
pore_length = rxncoords[-1] - rxncoords[0]
print('The pore is {} angstroms long'.format(pore_length))
The pore is 42.4 angstroms long

Both HOLE and HOLEtraj (below) have the min_radius() function, which will return the minimum radius in angstrom for each frame. The resulting array has the shape (#n_frames, 2).

[6]:
h.min_radius()
[6]:
array([[0.     , 1.19707]])

The class has a convenience plot() method to plot the coordinates of your pore.

[7]:
h.plot();
[7]:
<matplotlib.axes._subplots.AxesSubplot at 0x7fd3d17e2d90>
../../../_images/examples_analysis_polymers_and_membranes_hole_14_1.png

You can also create a VMD surface from the hole1.sph output file, using the create_vmd_surface function.

[8]:
h.create_vmd_surface(filename='hole1.vmd')
[8]:
'hole1.vmd'

To view this, open your PDB file in VMD.

vmd tmp*/*.pdb

Load the output file in Extensions > Tk Console:

source hole1.vmd

Your pore surface will be drawn as below.

sphpdb.png

MDAnalysis supports many of the options that can be customised in HOLE. For example, you can specify a starting point for the pore search within the pore with cpoint, and a sample distance (default: 0.2 angstrom) for the distance between the planes used in HOLE. Please see the MDAnalysis.analysis.hole for more information.

Using HOLE with a trajectory

One of the limitations of the hole program is that it can only accept PDB files. In order to use other formats with hole, or to run hole on trajectories, we can use the hole.HOLEtraj class with an MDAnalysis.Universe. While the example file below is a PDB, you can use any files to create your Universe.

[9]:
from MDAnalysis.tests.datafiles import MULTIPDB_HOLE

u = mda.Universe(MULTIPDB_HOLE)

ht = hole.HOLEtraj(u, executable='~/hole2/exe/hole',
                   logfile='hole2.out',
                   sphpdb='hole2.sph')
ht.run()
/Users/lily/anaconda3/envs/mda-user-guide/lib/python3.7/site-packages/MDAnalysis/coordinates/PDB.py:864: DeprecationWarning: Using the last letter of the segid for the chainID is now deprecated and will be changed in 2.0. In 2.0, the chainID attribute will be used if it exists, or a placeholder value.
  "exists, or a placeholder value.", DeprecationWarning)

Note that you do not need call collect() after calling run() with HOLEtraj. Again, the data is stored in ht.profiles as a dictionary of numpy.recarrays. The dictionary is indexed by frame; we can see the HOLE profile for the fourth frame below (truncated to 19.1126 angstrom from the pore axis). In this case, the frame field of each recarray is always 0.

[10]:
ht.profiles[3][:10]
[10]:
rec.array([(0, -18.6126, 16.58975), (0, -18.5126, 13.39834),
           (0, -18.4126, 10.82539), (0, -18.3126,  8.86034),
           (0, -18.2126,  7.28037), (0, -18.1126,  6.4542 ),
           (0, -18.0126,  6.48675), (0, -17.9126,  6.39647),
           (0, -17.8126,  6.30656), (0, -17.7126,  6.21605)],
          dtype=[('frame', '<i4'), ('rxncoord', '<f8'), ('radius', '<f8')])

Again, plot() can plot the HOLE radius over each pore coordinate, differentiating each frame with colour.

[11]:
ht.plot();
[11]:
<matplotlib.axes._subplots.AxesSubplot at 0x7fd3d257be90>
../../../_images/examples_analysis_polymers_and_membranes_hole_24_1.png

The plot3D() function separates each frame onto its own axis in a 3D plot.

[12]:
ht.plot3D();
[12]:
<matplotlib.axes._subplots.Axes3DSubplot at 0x7fd3d26da990>
../../../_images/examples_analysis_polymers_and_membranes_hole_26_1.png

Ordering HOLE profiles with an order parameter

If you are interested in the HOLE profiles over an order parameter, you can directly pass that into the analysis. Below, we use an order parameter of RMSD from a reference structure.

Note

Please cite ([SFSB14]) when using the orderparameter functionality.

[13]:
from MDAnalysis.analysis import rms

ref = mda.Universe(PDB_HOLE)
rmsd = rms.RMSD(u, ref, select='protein', weights='mass').run()
rmsd_values = rmsd.rmsd[:, 2]
rmsd_values
[13]:
array([6.10501252e+00, 4.88398472e+00, 3.66303524e+00, 2.44202454e+00,
       1.22100521e+00, 2.36577481e-07, 1.22100162e+00, 2.44202456e+00,
       3.66303410e+00, 4.88398478e+00, 6.10502262e+00])

You can pass this in as orderparameter. The result profiles dictionary will have your order parameters as keys. You should be careful with this if your order parameter has repeated values, as duplicate keys are not possible; each duplicate key just overwrites the previous value.

[14]:
ht2 = hole.HOLEtraj(u, executable='~/hole2/exe/hole',
                    logfile='hole3.out',
                    sphpdb='hole3.sph',
                    orderparameters=rmsd_values)
ht2.run()
ht2.profiles.keys()
/Users/lily/anaconda3/envs/mda-user-guide/lib/python3.7/site-packages/MDAnalysis/coordinates/PDB.py:864: DeprecationWarning: Using the last letter of the segid for the chainID is now deprecated and will be changed in 2.0. In 2.0, the chainID attribute will be used if it exists, or a placeholder value.
  "exists, or a placeholder value.", DeprecationWarning)
[14]:
odict_keys([6.1050125197092, 4.883984723991119, 3.663035235691455, 2.442024543243412, 1.2210052104208522, 2.3657748143998805e-07, 1.2210016190719406, 2.4420245634673843, 3.663034099295049, 4.883984778674987, 6.105022620520385])

You can see here that the dictionary does not order the entries by the order parameter. If you iterate over the class, it will return each (key, value) pair in sorted key order.

[15]:
for order_parameter, profile in ht2:
    print(order_parameter, len(profile))
2.3657748143998805e-07 413
1.2210016190719406 443
1.2210052104208522 517
2.442024543243412 435
2.4420245634673843 345
3.663034099295049 397
3.663035235691455 421
4.883984723991119 433
4.883984778674987 393
6.1050125197092 467
6.105022620520385 403

We can use this to plot the minimum radius as a function of RMSD from the reference structure.

[16]:
import numpy as np
import matplotlib.pyplot as plt

min_radius = [[rmsd_i, p.radius.min()] for rmsd_i, p in ht2]
arr = np.array(min_radius)

plt.plot(arr[:, 0], arr[:, 1])
plt.xlabel(r"order parameter RMSD $\rho$ ($\AA$)")
plt.ylabel(r"minimum HOLE pore radius $r$ ($\AA$)");
[16]:
Text(0, 0.5, 'minimum HOLE pore radius $r$ ($\\AA$)')
../../../_images/examples_analysis_polymers_and_membranes_hole_34_1.png

References

[1] Richard J. Gowers, Max Linke, Jonathan Barnoud, Tyler J. E. Reddy, Manuel N. Melo, Sean L. Seyler, Jan Domański, David L. Dotson, Sébastien Buchoux, Ian M. Kenney, and Oliver Beckstein. MDAnalysis: A Python Package for the Rapid Analysis of Molecular Dynamics Simulations. Proceedings of the 15th Python in Science Conference, pages 98–105, 2016. 00152. URL: https://conference.scipy.org/proceedings/scipy2016/oliver_beckstein.html, doi:10.25080/Majora-629e541a-00e.

[2] Naveen Michaud-Agrawal, Elizabeth J. Denning, Thomas B. Woolf, and Oliver Beckstein. MDAnalysis: A toolkit for the analysis of molecular dynamics simulations. Journal of Computational Chemistry, 32(10):2319–2327, July 2011. 00778. URL: http://doi.wiley.com/10.1002/jcc.21787, doi:10.1002/jcc.21787.

[3] O S Smart, J M Goodfellow, and B A Wallace. The pore dimensions of gramicidin A. Biophysical Journal, 65(6):2455–2460, December 1993. 00522. URL: https://www.ncbi.nlm.nih.gov/pmc/articles/PMC1225986/, doi:10.1016/S0006-3495(93)81293-1.

[4] O. S. Smart, J. G. Neduvelil, X. Wang, B. A. Wallace, and M. S. Sansom. HOLE: a program for the analysis of the pore dimensions of ion channel structural models. Journal of Molecular Graphics, 14(6):354–360, 376, December 1996. 00935. doi:10.1016/s0263-7855(97)00009-x.

[5] Lukas S. Stelzl, Philip W. Fowler, Mark S. P. Sansom, and Oliver Beckstein. Flexible gates generate occluded intermediates in the transport cycle of LacY. Journal of Molecular Biology, 426(3):735–751, February 2014. 00000. URL: https://asu.pure.elsevier.com/en/publications/flexible-gates-generate-occluded-intermediates-in-the-transport-c, doi:10.1016/j.jmb.2013.10.024.