Bio. PDB.ResidueDepth模块

使用命令行工具MSMS计算残留物深度。

该模块使用Michel Sanner的MSMS程序进行表面计算。请参阅:http://mgltools.scripps.edu/packages/MSMS

残留物深度是残留物原子与溶剂可及表面的平均距离。

残留深度::

from Bio.PDB.ResidueDepth import ResidueDepth
from Bio.PDB.PDBParser import PDBParser
parser = PDBParser()
structure = parser.get_structure("1a8o", "Tests/PDB/1A8O.pdb")
model = structure[0]
rd = ResidueDepth(model)
print(rd['A',(' ', 152, ' ')])

直接MSMS接口,典型用途::

from Bio.PDB.ResidueDepth import get_surface
surface = get_surface(model)

该表面是一个包含所有表面点的NumPy数组。

到表面的距离::

from Bio.PDB.ResidueDepth import min_dist
coord = (1.113, 35.393,  9.268)
dist = min_dist(coord, surface)

其中coord是表面束缚的体积内原子的coord(即原子深度)。

要计算残基深度(残基中原子的平均原子深度)::

from Bio.PDB.ResidueDepth import residue_depth
chain = model['A']
res152 = chain[152]
rd = residue_depth(res152, surface)
Bio.PDB.ResidueDepth.get_surface(model, MSMS='msms')

将分子表面表示为点列表数组。

返回代表分子表面的顶点列表的NumPy数组。

论点:
  • 模型- BioPython DBC模型对象(用于获取输入模型的原子)

  • MSMS - msms可执行文件(用作subprocess.call的参数)

Bio.PDB.ResidueDepth.min_dist(coord, surface)

返回坐标和表面之间的最小距离。

Bio.PDB.ResidueDepth.residue_depth(residue, surface)

残余深度是其所有原子的平均深度。

返回残基中所有原子到表面的平均距离,即。残留深度。

Bio.PDB.ResidueDepth.ca_depth(residue, surface)

返回CA深度。

class Bio.PDB.ResidueDepth.ResidueDepth(model, msms_exec=None)

基类:AbstractPropertyMap

计算所有残留物的残留物和CA深度。

__init__(model, msms_exec=None)

初始化课程。

__annotations__ = {}
__firstlineno__ = 587
__static_attributes__ = ()