Bio.Data.CodonTable模块
密码子表基于NCBI的密码子表。
这些表基于使用Deliver/Update_ncbi_podon_table. py解析NCBI文件 ftp://ftp.ncbi.nih.gov/entrez/misc/data/gc.prt
最后更新于版本4.4(2019年5月)
- exception Bio.Data.CodonTable.TranslationError
基类:
Exception
翻译特定例外的容器。
- __firstlineno__ = 44
- __static_attributes__ = ()
- class Bio.Data.CodonTable.CodonTable(nucleotide_alphabet: str | None = None, protein_alphabet: str | None = None, forward_table: dict[str, str] = forward_table, back_table: dict[str, str] = back_table, start_codons: list[str] = start_codons, stop_codons: list[str] = stop_codons)
基类:
object
密码表,或遗传密码。
- __init__(nucleotide_alphabet: str | None = None, protein_alphabet: str | None = None, forward_table: dict[str, str] = forward_table, back_table: dict[str, str] = back_table, start_codons: list[str] = start_codons, stop_codons: list[str] = stop_codons) None
初始化课程。
- forward_table: dict[str, str] = {}
- back_table: dict[str, str] = {}
- start_codons: list[str] = []
- stop_codons: list[str] = []
- __str__()
返回密码子表的简单文本表示。
例如::
>>> import Bio.Data.CodonTable >>> print(Bio.Data.CodonTable.standard_dna_table) Table 1 Standard, SGC0 | T | C | A | G | --+---------+---------+---------+---------+-- T | TTT F | TCT S | TAT Y | TGT C | T T | TTC F | TCC S | TAC Y | TGC C | C ... G | GTA V | GCA A | GAA E | GGA G | A G | GTG V | GCG A | GAG E | GGG G | G --+---------+---------+---------+---------+-- >>> print(Bio.Data.CodonTable.generic_by_id[1]) Table 1 Standard, SGC0 | U | C | A | G | --+---------+---------+---------+---------+-- U | UUU F | UCU S | UAU Y | UGU C | U U | UUC F | UCC S | UAC Y | UGC C | C ... G | GUA V | GCA A | GAA E | GGA G | A G | GUG V | GCG A | GAG E | GGG G | G --+---------+---------+---------+---------+--
- __annotations__ = {'back_table': dict[str, str], 'forward_table': dict[str, str], 'start_codons': list[str], 'stop_codons': list[str]}
- __firstlineno__ = 48
- __static_attributes__ = ('back_table', 'forward_table', 'nucleotide_alphabet', 'protein_alphabet', 'start_codons', 'stop_codons')
- Bio.Data.CodonTable.make_back_table(table, default_stop_codon)
回到后台(原始单密码子映射)。
仅返回单个密码,根据排序顺序从可能的替代方案中进行选择。
- class Bio.Data.CodonTable.NCBICodonTable(id, names, table, start_codons, stop_codons)
基类:
CodonTable
通用核苷序列的密码子表。
- nucleotide_alphabet: str | None = None
- protein_alphabet = 'ACDEFGHIKLMNPQRSTVWY'
- __init__(id, names, table, start_codons, stop_codons)
初始化课程。
- __repr__()
将NCBI密码子表类表示为字符串以进行调试。
- __annotations__ = {'nucleotide_alphabet': typing.Optional[str]}
- __firstlineno__ = 164
- __static_attributes__ = ('back_table', 'forward_table', 'id', 'names', 'start_codons', 'stop_codons')
- class Bio.Data.CodonTable.NCBICodonTableDNA(id, names, table, start_codons, stop_codons)
-
明确DNA序列的密码子表。
- nucleotide_alphabet: str | None = 'GATC'
- __annotations__ = {}
- __firstlineno__ = 184
- __static_attributes__ = ()
- class Bio.Data.CodonTable.NCBICodonTableRNA(id, names, table, start_codons, stop_codons)
-
明确RNA序列的密码子表。
- nucleotide_alphabet: str | None = 'GAUC'
- __annotations__ = {}
- __firstlineno__ = 190
- __static_attributes__ = ()
- class Bio.Data.CodonTable.AmbiguousCodonTable(codon_table, ambiguous_nucleotide_alphabet, ambiguous_nucleotide_values, ambiguous_protein_alphabet, ambiguous_protein_values)
基类:
CodonTable
模糊序列的基本密码子表。
- __init__(codon_table, ambiguous_nucleotide_alphabet, ambiguous_nucleotide_values, ambiguous_protein_alphabet, ambiguous_protein_values)
初始化课程。
- __getattr__(name)
将属性查找转发到原始表。
- __annotations__ = {}
- __firstlineno__ = 199
- __static_attributes__ = ('_codon_table',)
- Bio.Data.CodonTable.list_possible_proteins(codon, forward_table, ambiguous_nucleotide_values)
返回模糊密码子的所有可能编码的氨基酸。
- Bio.Data.CodonTable.list_ambiguous_codons(codons, ambiguous_nucleotide_values)
扩展密码子列表以包括所有可能的模糊密码子。
例如::
['TAG', 'TAA'] -> ['TAG', 'TAA', 'TAR'] ['UAG', 'UGA'] -> ['UAG', 'UGA', 'URA']
注意 ['TAG', 'TGA'] -> ['TAG', 'TGA'] ,这不会添加“TRR”(也可能意味着“TAA”或“TGG”)。因此,以下仅添加了两个密码子:
例如::
['TGA', 'TAA', 'TAG'] -> ['TGA', 'TAA', 'TAG', 'TRA', 'TAR']
返回新的(更长的)密码子串列表。
- class Bio.Data.CodonTable.AmbiguousForwardTable(forward_table, ambiguous_nucleotide, ambiguous_protein)
基类:
object
用于翻译歧义核苷序列的向前表。
- __init__(forward_table, ambiguous_nucleotide, ambiguous_protein)
初始化课程。
- __contains__(codon)
检查密码子是否充当模棱两可的forward_table的键。
仅在forward_table时返回“True” [codon] 返回一个值。
- __firstlineno__ = 373
- __static_attributes__ = ('_cache', '_inverted', 'ambiguous_nucleotide', 'ambiguous_protein', 'forward_table')
- get(codon, failobj=None)
为类似字典的行为实现get。
- __getitem__(codon)
为AmbiguousForwardTable实现类似字典的行为。
forward_table [codon] 将返回一个氨基酸字母,或者抛出KeyLock(如果密码子不编码一个氨基酸)或TranslationLock(如果密码子确实编码一个氨基酸,但也是终止密码子或确实编码几个氨基酸,对于这些氨基酸,给定字母表中没有唯一的字母可用。
- Bio.Data.CodonTable.register_ncbi_table(name, alt_name, id, table, start_codons, stop_codons)
将密码子表数据转换为对象(PRIVATE)。
数据存储在字典中。