Bio.PDB.Polypeptide 模組
與多肽相關的類別(建構和表示)。
具有多條鏈的簡單範例,
>>> from Bio.PDB.PDBParser import PDBParser
>>> from Bio.PDB.Polypeptide import PPBuilder
>>> structure = PDBParser().get_structure('2BEG', 'PDB/2BEG.pdb')
>>> ppb=PPBuilder()
>>> for pp in ppb.build_peptides(structure):
... print(pp.get_sequence())
LVFFAEDVGSNKGAIIGLMVGGVVIA
LVFFAEDVGSNKGAIIGLMVGGVVIA
LVFFAEDVGSNKGAIIGLMVGGVVIA
LVFFAEDVGSNKGAIIGLMVGGVVIA
LVFFAEDVGSNKGAIIGLMVGGVVIA
在 PDB 檔案中使用 HETATM 行,處理非標準胺基酸的範例,在此案例中為硒甲硫胺酸(MSE)
>>> from Bio.PDB.PDBParser import PDBParser
>>> from Bio.PDB.Polypeptide import PPBuilder
>>> structure = PDBParser().get_structure('1A8O', 'PDB/1A8O.pdb')
>>> ppb=PPBuilder()
>>> for pp in ppb.build_peptides(structure):
... print(pp.get_sequence())
DIRQGPKEPFRDYVDRFYKTLRAEQASQEVKNW
TETLLVQNANPDCKTILKALGPGATLEE
TACQG
如果需要,您可以在肽中包含非標準胺基酸
>>> for pp in ppb.build_peptides(structure, aa_only=False):
... print(pp.get_sequence())
... print("%s %s" % (pp.get_sequence()[0], pp[0].get_resname()))
... print("%s %s" % (pp.get_sequence()[-7], pp[-7].get_resname()))
... print("%s %s" % (pp.get_sequence()[-6], pp[-6].get_resname()))
MDIRQGPKEPFRDYVDRFYKTLRAEQASQEVKNWMTETLLVQNANPDCKTILKALGPGATLEEMMTACQG
M MSE
M MSE
M MSE
在此案例中,硒甲硫胺酸(第一個以及倒數第七個和第六個殘基)已被 get_sequence 方法顯示為 M(甲硫胺酸)。
- Bio.PDB.Polypeptide.index_to_one(index)
索引對應到單字母胺基酸名稱。
>>> index_to_one(0) 'A' >>> index_to_one(19) 'Y'
- Bio.PDB.Polypeptide.one_to_index(s)
單字母代碼轉索引。
>>> one_to_index('A') 0 >>> one_to_index('Y') 19
- Bio.PDB.Polypeptide.index_to_three(i)
索引對應到三字母胺基酸名稱。
>>> index_to_three(0) 'ALA' >>> index_to_three(19) 'TYR'
- Bio.PDB.Polypeptide.three_to_index(s)
三字母代碼轉索引。
>>> three_to_index('ALA') 0 >>> three_to_index('TYR') 19
- Bio.PDB.Polypeptide.is_aa(residue, standard=False)
如果殘基物件/字串是胺基酸,則回傳 True。
- 參數:
residue (L{Residue} 或 字串) – L{Residue} 物件或三字母胺基酸代碼
standard (布林值) – 檢查 20 種標準胺基酸的旗標(預設為 False)
>>> is_aa('ALA') True
支援修飾胺基酸的已知三字母代碼,
>>> is_aa('FME') True >>> is_aa('FME', standard=True) False
- Bio.PDB.Polypeptide.is_nucleic(residue, standard=False)
如果殘基物件/字串是核酸,則回傳 True。
- 參數:
residue (L{Residue} 或 字串) – L{Residue} 物件或三字母代碼
standard (布林值) – 檢查 8 種(DNA + RNA)標準鹼基的旗標。預設為 False。
>>> is_nucleic('DA ') True
>>> is_nucleic('A ') True
支援修飾核苷酸的已知三字母代碼,
>>> is_nucleic('A2L') True >>> is_nucleic('A2L', standard=True) False
- class Bio.PDB.Polypeptide.Polypeptide(iterable=(), /)
基底類別:
list
多肽只是 L{Residue} 物件的列表。
- get_ca_list()
取得多肽中 C-alpha 原子的列表。
- 回傳值:
C-alpha 原子的列表
- 回傳類型:
[L{Atom}, L{Atom}, …]
- get_phi_psi_list()
回傳 phi/psi 二面角的列表。
- get_tau_list()
所有 4 個連續 Calpha 原子的 tau 扭轉角的列表。
- get_theta_list()
所有 3 個連續 Calpha 原子的 theta 角的列表。
- get_sequence()
回傳 AA 序列作為 Seq 物件。
- 回傳值:
多肽序列
- 回傳類型:
L{Seq}
- __repr__()
回傳多肽的字串表示。
回傳 <Polypeptide start=START end=END>,其中 START 和 END 是外部殘基的序列識別符。