Nw.cab.zju.edu.cn/cab/ xueyuanxiashubumen/nx/ bioinplant.htm《生物信息学札记》樊龙江 附录:生物信息学主要英文术话及释义 Abstract Syntax Notation(ASN.)(NcB发展的许多程序,如显示蛋白质三维 结构的cn3D等所使用的内部格式 a language that is used to describe structured data types formally, Within bioinformaties, it has been used by the National Center for Biotechnology Information to encode sequences, maps, taxonomic information, molecular structures, and biographical information in such a way that it can be easily accessed and exchanged by computer software Accession number(记录号) A unique identifier that is assigned to a single database entry for a dNa or protein sequence. Affine gap penalty(一种设置空位罚分策略) a gap penalty score that is a linear function of gap length, consisting of a gap opening penalty and a gap extension penalty multiplied by the length of the gap. Using this penalty scheme greatly enhances the performance of dynamic programming methods for sequence alignment. See also Gap penalty Algorithm(算法 A systematic procedure for solving a problem in a finite number of steps, typically involving a repetition of operations. Once specified, an algorithm can be written in a computer language and run as a program Alignment(联配/比对/联配) Refers to the procedure of comparing two or more sequences by looking for a series of individual characters or character patterns that are in the same order in the sequences. Of the two types of alignment, local and global, a local alignment is generally the most useful. See also Local and Global alignments Alignment score(联配/比对联配值 An algorithmically computed score based on the number of matches substitutions, insertions, and deletions ( gaps)within an alignment. Scores for matches and substitutions Are derived from a scoring matrix such as the BLOSUM and PAM matrices for proteins, and afine gap penalties suitable for the matrix are chosen. Alignment scores are in log odds units, often bit units (log to the base 2). Higher scores denote better alignments. See also Similarity score, Distance in sequence analysis Alphabet(字母表 The total number of symbols in a sequence-4 for DNA sequences and 20 for protein sequences Annotation(注释) Th genes In a genome g the location o protein-encoding genes, the sequence of the encoded proteins, any significant
www.cab.zju.edu.cn/cab/xueyuanxiashubumen/nx/bioinplant.htm 《生物信息学札记》 樊龙江 附录: 生物信息学主要英文术语及释义 Abstract Syntax Notation (ASN.l)(NCBI发展的许多程序,如显示蛋白质三维 结构的Cn3D等所使用的内部格式) A language that is used to describe structured data types formally, Within bioinformatits,it has been used by the National Center for Biotechnology Information to encode sequences, maps, taxonomic information, molecular structures, and biographical information in such a way that it can be easily accessed and exchanged by computer software. Accession number(记录号) A unique identifier that is assigned to a single database entry for a DNA or protein sequence. Affine gap penalty(一种设置空位罚分策略) A gap penalty score that is a linear function of gap length, consisting of a gap opening penalty and a gap extension penalty multiplied by the length of the gap. Using this penalty scheme greatly enhances the performance of dynamic programming methods for sequence alignment. See also Gap penalty. Algorithm(算法) A systematic procedure for solving a problem in a finite number of steps, typically involving a repetition of operations. Once specified, an algorithm can be written in a computer language and run as a program. Alignment(联配/比对/联配) Refers to the procedure of comparing two or more sequences by looking for a series of individual characters or character patterns that are in the same order in the sequences. Of the two types of alignment, local and global, a local alignment is generally the most useful. See also Local and Global alignments. Alignment score(联配/比对/联配值) An algorithmically computed score based on the number of matches, substitutions, insertions, and deletions (gaps) within an alignment. Scores for matches and substitutions Are derived from a scoring matrix such as the BLOSUM and PAM matrices for proteins, and aftine gap penalties suitable for the matrix are chosen. Alignment scores are in log odds units, often bit units (log to the base 2). Higher scores denote better alignments. See also Similarity score, Distance in sequence analysis. Alphabet(字母表) The total number of symbols in a sequence-4 for DNA sequences and 20 for protein sequences. Annotation(注释) The prediction of genes in a genome, including the location of protein-encoding genes, the sequence of the encoded proteins, any significant 125
Nw.cab.zju.edu.cn/cab/ xueyuanxiashubumen/nx/ bioinplant.htm《生物信息学札记》樊龙江 matches to other proteins of known function and the location of RNA-encoding genes. Predictions are based on gene models; e.g., hidden Markov models of introns and exons in proteins encoding genes, and models of secondary structure in rna Anonymous FTP(匿名FTP) When a FtP service allows anyone to log in, it is said to provide anonymous FTP ser-vice. A user can log in to an anonymous FTP server by typing anonymous as the user name and his E-mail address as a password. most Web browsers now negotiate anonymous FTP logon without asking the user for a user name and password. See also FTP ASC The American Standard Code for Information Interchange(AScII)encodes unaccented letters a-Z, A-Z, the numbers o-9, most punctuation marks, space and a set of control characters such as carriage return and tab. ASCll specifies 128 characters that are mapped to the values o-127. AScll tiles are commonly called plain text, meaning that they only encode text without extra markup BAC clone(细菌人工染色体克隆) Bacterial artificial chromosome vector carrying a genomic DNA insert, typically 100-200 kb. Most of the large- insert clones sequenced in the project were BAC clones Back- propagation(反向传输) When training feed-forward neural networks, a back-propagation algorithm can be used to modify the network weights. After each training input pattern is fed through the network, the network's output is compared with the desired output and the amount of error is calculated. This error is back-propagated through the network by using an error function to correct the network weights See also feed-forward neural network Baum-Welch algorithm( Baum-Welch算法) An expectation maximization algorithm that is used to train hidden Markov models Baye'srue(贝叶斯法则) Forms the basis of conditional probability by calculating the likelihood of an event occurring based on the history of the event and relevant background information In terms of two parameters a and b, the theorem is stated in an equation The condition-al probability of A, given B, P(AlB), is equal to the probability of A, P(A), times the conditional probability of B, given A, P(BIA) divided by the probability of B, P(B). P(A is the historical or prior distribution value of A, P(BlA)is a new prediction for b for a particular value of A, and P(B is the sum of the newly predicted values for B P(A/B)is a posterior probability representing a new prediction for a given the prior knowledge of A and the newly discovered relationships between A and B Bayesian analysis(贝叶斯分析 A statistical procedure used to estimate parameters of an underlying 126
www.cab.zju.edu.cn/cab/xueyuanxiashubumen/nx/bioinplant.htm 《生物信息学札记》 樊龙江 matches to other Proteins of known function, and the location of RNA-encoding genes. Predictions are based on gene models; e.g., hidden Markov models of introns and exons in proteins encoding genes, and models of secondary structure in RNA. Anonymous FTP(匿名FTP) When a FTP service allows anyone to log in, it is said to provide anonymous FTP ser-vice. A user can log in to an anonymous FTP server by typing anonymous as the user name and his E-mail address as a password. Most Web browsers now negotiate anonymous FTP logon without asking the user for a user name and password. See also FTP. ASCII The American Standard Code for Information Interchange (ASCII) encodes unaccented letters a-z, A-Z, the numbers O-9, most punctuation marks, space, and a set of control characters such as carriage return and tab. ASCII specifies 128 characters that are mapped to the values O-127. ASCII tiles are commonly called plain text, meaning that they only encode text without extra markup. BAC clone(细菌人工染色体克隆) Bacterial artificial chromosome vector carrying a genomic DNA insert, typically 100–200 kb. Most of the large-insert clones sequenced in the project were BAC clones. Back-propagation(反向传输) When training feed-forward neural networks, a back-propagation algorithm can be used to modify the network weights. After each training input pattern is fed through the network, the network’s output is compared with the desired output and the amount of error is calculated. This error is back-propagated through the network by using an error function to correct the network weights. See also Feed-forward neural network. Baum-Welch algorithm(Baum-Welch算法) An expectation maximization algorithm that is used to train hidden Markov models. Baye’s rule(贝叶斯法则) Forms the basis of conditional probability by calculating the likelihood of an event occurring based on the history of the event and relevant background information. In terms of two parameters A and B, the theorem is stated in an equation: The condition-al probability of A, given B, P(AIB), is equal to the probability of A, P(A), times the conditional probability of B, given A, P(BIA), divided by the probability of B, P(B). P(A) is the historical or prior distribution value of A, P(BIA) is a new prediction for B for a particular value of A, and P(B) is the sum of the newly predicted values for B. P(AIB) is a posterior probability, representing a new prediction for A given the prior knowledge of A and the newly discovered relationships between A and B. Bayesian analysis(贝叶斯分析) A statistical procedure used to estimate parameters of an underlying 126
Nw.cab.zju.edu.cn/cab/ xueyuanxiashubumen/nx/ bioinplant.htm《生物信息学札记》樊龙江 distribution based on an observed distribution. See also Bayes rule Biochips(生物芯片 Miniaturized arrays of large numbers of molecular substrates, often oligonucleotides, in a defined pattern. They are also called DNA microarrays and microchips Bioinformatics(生物信息学) The merger of biotechnology and information technology with the goal of revealing new insights and principles in biology. /The discipline of obtaining information about genomic or protein sequence data. This may involve similarity searches of databases, comparing your unidentified sequence to the sequences in a database, or making predictions about the sequence based or current knowledge of similar sequences. Databases are frequently made publically available through the Internet, or locally at your institution Bit score(二进制值/Bt值 The value s is derived from the raw alignment score s in which the statistical properties of the scoring system used have been taken into account. Because bit scores have been normalized with respect to the scoring system, they car be used to compare alignment scores from different searches Bit units From information theory, a bit denotes the amount of information required to distinguish between two equally likely possibilities. The number of bits of information, AJ, required to convey a message that has a4 possibilities is log2 M=bits BLAST(基本局部联配搜索工具,一种主要数据库搜索程序 Basic Local Alignment Search Tool. A set of programs, used to perform fast similarity searches. Nucleotide sequences can be compared with nucleotide sequences in a database using BLASTN, for example. Complex statistics are applied to judge the significance of each match. Reported sequences may be homologous to, or related to the query sequence. The BLaSTP program is used to search a protein database for a match against a query protein sequence. There are several other flavours of BLasT. BLaST2 is a newer release of BLAST. Allows for insertions or deletions in the sequences being aligned. Gapped alignments may be more biologically significant Bock(蛋白质家族中保守区域的组块) Conserved ungapped patterns approximately 3-60 amino acids in length in a set of related proteins BLOSUM matrices(模块替换矩阵,一种主要替换矩阵 An alternative to PAM tables, BLOSUM tables were derived using local multiple alignments of more distantly related sequences than were used for the PAM matrix. These are used to assess the similarity of sequences when performing alignments Boltzmann distribution( Boltzmann分布) Describes the number of molecules that have energies above a certain level based on the boltzmann gas constant and the absolute temperature 127
www.cab.zju.edu.cn/cab/xueyuanxiashubumen/nx/bioinplant.htm 《生物信息学札记》 樊龙江 distribution based on an observed distribution. See also Baye’s rule. Biochips(生物芯片) Miniaturized arrays of large numbers of molecular substrates, often oligonucleotides, in a defined pattern. They are also called DNA microarrays and microchips. Bioinformatics (生物信息学) The merger of biotechnology and information technology with the goal of revealing new insights and principles in biology. /The discipline of obtaining information about genomic or protein sequence data. This may involve similarity searches of databases, comparing your unidentified sequence to the sequences in a database, or making predictions about the sequence based on current knowledge of similar sequences. Databases are frequently made publically available through the Internet, or locally at your institution. Bit score (二进制值/ Bit 值) The value S' is derived from the raw alignment score S in which the statistical properties of the scoring system used have been taken into account. Because bit scores have been normalized with respect to the scoring system, they can be used to compare alignment scores from different searches. Bit units From information theory, a bit denotes the amount of information required to distinguish between two equally likely possibilities. The number of bits of information, AJ, required to convey a message that has A4 possibilities is log2 M = N bits. BLAST (基本局部联配搜索工具,一种主要数据库搜索程序) Basic Local Alignment Search Tool. A set of programs, used to perform fast similarity searches. Nucleotide sequences can be compared with nucleotide sequences in a database using BLASTN, for example. Complex statistics are applied to judge the significance of each match. Reported sequences may be homologous to, or related to the query sequence. The BLASTP program is used to search a protein database for a match against a query protein sequence. There are several other flavours of BLAST. BLAST2 is a newer release of BLAST. Allows for insertions or deletions in the sequences being aligned. Gapped alignments may be more biologically significant. Block(蛋白质家族中保守区域的组块) Conserved ungapped patterns approximately 3-60 amino acids in length in a set of related proteins. BLOSUM matrices(模块替换矩阵,一种主要替换矩阵) An alternative to PAM tables, BLOSUM tables were derived using local multiple alignments of more distantly related sequences than were used for the PAM matrix. These are used to assess the similarity of sequences when performing alignments. Boltzmann distribution(Boltzmann 分布) Describes the number of molecules that have energies above a certain level, based on the Boltzmann gas constant and the absolute temperature. 127
Nw.cab.zju.edu.cn/cab/ xueyuanxiashubumen/nx/ bioinplant.htm《生物信息学札记》樊龙江 Boltzmann probability function( Boltzmann概率函数 See boltzmann distribution Bootstrap analysis A method for testing how well a particular data set fits a model. For example the validity of the branch arrangement in a predicted phylogenetic tree can be tested by resampling columns in a multiple sequence alignment to create many new alignments. The appearance of a particular branch in trees generated from these resampled sequences can then be measured Alternatively, a sequence may be left out of an analysis to deter-mine how much the sequence influences the results of an analysis Branch| ength(分支长度) In sequence analysis, the number of sequence changes along a particular branch of a phylogenetic tree CDS or cds(编码序列) Coding sequence Chebyshe, d inequality The probability that a random variable exceeds its mean is less than or equal to the square of 1 over the number of standard deviations from the mean Clone(克隆) Population of identical cells or molecules(e.g. DNA), derived from a single ancestor Cloning Vector(克隆载体 A molecule that carries a foreign gene into a host, and allows/facilitates the multiplication of that gene in a host. When sequencing a gene that has been cloned using a cloning vector (rather than by PCr), care should be taken not to include the cloning vector sequence when performing similarity searches Plasmids, cosmids, phagemids, YACs and PACs are example types of cloning vectors Cluster analysis(聚类分析) A method for grouping together a set of objects that are most similar from a larger group of related objects. The relationships are based on some criterion of similarity or difference. For sequences, a similarity or distance score or a statistical evaluation of those scores is used Cobbler a single sequence that represents the most conserved regions in a multiple sequence alignment. The BLOCKs server uses the cobbler sequence to perform a database similarity search as a way to reach sequences that are more divergent than would be found using the single sequences in the alignment for searches Coding system(neural networks) Regarding neural networks, a coding system needs to be designed for representing input and output. The level of success found when training the model will be partially dependent on the quality of the coding system chosen Codon usage
www.cab.zju.edu.cn/cab/xueyuanxiashubumen/nx/bioinplant.htm 《生物信息学札记》 樊龙江 Boltzmann probability function(Boltzmann概率函数) See Boltzmann distribution. Bootstrap analysis A method for testing how well a particular data set fits a model. For example, the validity of the branch arrangement in a predicted phylogenetic tree can be tested by resampling columns in a multiple sequence alignment to create many new alignments. The appearance of a particular branch in trees generated from these resampled sequences can then be measured. Alternatively, a sequence may be left out of an analysis to deter-mine how much the sequence influences the results of an analysis. Branch length(分支长度) In sequence analysis, the number of sequence changes along a particular branch of a phylogenetic tree. CDS or cds (编码序列) Coding sequence. Chebyshe, d inequality The probability that a random variable exceeds its mean is less than or equal to the square of 1 over the number of standard deviations from the mean. Clone (克隆) Population of identical cells or molecules (e.g. DNA), derived from a single ancestor. Cloning Vector (克隆载体) A molecule that carries a foreign gene into a host, and allows/facilitates the multiplication of that gene in a host. When sequencing a gene that has been cloned using a cloning vector (rather than by PCR), care should be taken not to include the cloning vector sequence when performing similarity searches. Plasmids, cosmids, phagemids, YACs and PACs are example types of cloning vectors. Cluster analysis(聚类分析) A method for grouping together a set of objects that are most similar from a larger group of related objects. The relationships are based on some criterion of similarity or difference. For sequences, a similarity or distance score or a statistical evaluation of those scores is used. Cobbler A single sequence that represents the most conserved regions in a multiple sequence alignment. The BLOCKS server uses the cobbler sequence to perform a database similarity search as a way to reach sequences that are more divergent than would be found using the single sequences in the alignment for searches. Coding system (neural networks) Regarding neural networks, a coding system needs to be designed for representing input and output. The level of success found when training the model will be partially dependent on the quality of the coding system chosen. Codon usage 128
Nw.cab.zju.edu.cn/cab/ xueyuanxiashubumen/nx/ bioinplant.htm《生物信息学札记》樊龙江 Analysis of the codons used in a particular gene or organism coG(直系同源簇) Clusters of orthologous groups in a set of groups of related sequences in microorganism and yeast(S. cerevisiae). These groups are found by whole proteome comparisons and include orthologs and paralogs. See also Orthologs and Paralogs Comparative genomics(比较基因组学) A comparison of gene numbers, gene locations, and biological functions of genes in the genomes of diverse organisms, one objective being to identify groups of genes that play a unique biological role in a particular organism Complexity( of an algorithm)(算法的复杂性) Describes the number of steps required by the algorithm to solve a problem as a function of the amount of data; for example, the length of sequences to be aligned Conditional probability(条件概率) The probability of a particular result (or of a particular value of a variabl given one or more events or conditions(or values of other variables Conservation(保守) Changes at a specific position of an amino acid or(less commonly, DNA) sequence that preserve the physico-chemical properties of the original residue Consensus(一致序列) A single sequence that represents at each subsequent position, the variation found within corresponding columns of a multiple sequence alignment Context-free grammars A recursive set of production rules for generating patterns of strings. These consist of a set of terminal characters that are used to create strings, a set of nonterminal symbols that correspond to rules and act as placeholders for patterns that can be generated using terminal characters, a set of rules for replacing nonterminal symbols with terminal characters, and a start symbol Contig(序列重叠群/拼接序列 A set of clones that can be assembled into a linear order. A DNA sequence that overlaps with another contig. The full set of overlapping sequences (contigs)can be put together to obtain the sequence for a long region of DNA that cannot be sequenced in one run in a sequencing assay. Important in genetic mapping at the molecular level CORBA(国际对象管理协作组制定的使OOP对象与网络接口统一起来的一套跨 计算机、操作系统、程序语言和网络的共同标准) The Common object Request Broker Architecture (CORBA)is an open industry standard for working with distributed objects, developed by the object Management Group. CORBA allows the interconnection of objects and applications regardless of computer language, machine architecture, oI geographic location of the computers Correlation coefficient(相关系数)
www.cab.zju.edu.cn/cab/xueyuanxiashubumen/nx/bioinplant.htm 《生物信息学札记》 樊龙江 Analysis of the codons used in a particular gene or organism. COG(直系同源簇) Clusters of orthologous groups in a set of groups of related sequences in microorganism and yeast (S. cerevisiae). These groups are found by whole proteome comparisons and include orthologs and paralogs. See also Orthologs and Paralogs. Comparative genomics(比较基因组学) A comparison of gene numbers, gene locations, and biological functions of genes in the genomes of diverse organisms, one objective being to identify groups of genes that play a unique biological role in a particular organism. Complexity (of an algorithm)(算法的复杂性) Describes the number of steps required by the algorithm to solve a problem as a function of the amount of data; for example, the length of sequences to be aligned. Conditional probability(条件概率) The probability of a particular result (or of a particular value of a variable) given one or more events or conditions (or values of other variables). Conservation (保守) Changes at a specific position of an amino acid or (less commonly, DNA) sequence that preserve the physico-chemical properties of the original residue. Consensus(一致序列) A single sequence that represents, at each subsequent position, the variation found within corresponding columns of a multiple sequence alignment. Context-free grammars A recursive set of production rules for generating patterns of strings. These consist of a set of terminal characters that are used to create strings, a set of nonterminal symbols that correspond to rules and act as placeholders for patterns that can be generated using terminal characters, a set of rules for replacing nonterminal symbols with terminal characters, and a start symbol. Contig (序列重叠群/拼接序列) A set of clones that can be assembled into a linear order. A DNA sequence that overlaps with another contig. The full set of overlapping sequences (contigs) can be put together to obtain the sequence for a long region of DNA that cannot be sequenced in one run in a sequencing assay. Important in genetic mapping at the molecular level. CORBA(国际对象管理协作组制定的使OOP对象与网络接口统一起来的一套跨 计算机、操作系统、程序语言和网络的共同标准) The Common Object Request Broker Architecture (CORBA) is an open industry standard for working with distributed objects, developed by the Object Management Group. CORBA allows the interconnection of objects and applications regardless of computer language, machine architecture, or geographic location of the computers. Correlation coefficient(相关系数) 129