Changes

From Opengenome.net

Computational biology

701 bytes removed, 03:16, 4 November 2006
no edit summary
<p><strong>Computational biology</strong> is biology that&nbsp;tries to solve biological problems using large amount of computational power and&nbsp;techniques from [[applied mathematics]], [[informatics]], [[statistics]], and [[computer science]].&nbsp;<br /><br /><strong>Bioinformatics and Compuational Biology</strong><br />Bioinformatics is an independant dscipline that was&nbsp;formed around mid 1990s. While computational biology is a more generic field of biology where much computing resource is necessary. They are different from each other in many ways. Biological informatics is essentially the reverse of Computational Biology as it is an informatics field where the major application is biological problems.<br /><br />Research in computational biology often overlaps with [[systems biology]]. Major research efforts in the field include [[sequence alignment]], [[Gene_finding|gene finding]], genome assembly, [[ protein structural alignment | protein structure alignment]], [[protein structure prediction]], prediction of [[gene expression]] and [[protein-protein interactions]], and the modeling of [[evolution]]. The terms ''bioinformatics'' and ''computational biology'' are often used interchangeably, although the latter typically focuses on algorithm development and specific computational methods. (In the biology-mathematics-computer science triad, bioinformatics will intimately involve all three components while computational biology will focus on biology and mathematics.) Due to interest from computer scientists and mathematicians and the popularity of computational techniques in the field of genomics, it is commonly referred to as ''computational biology''; a more accurate term is computational genomics. There are also lesser known but equally important areas of computational [[biochemistry]] and computational [[biophysics]], that are also a part of computational biology. (For working definitions of Bioinformatics and Computational Biology used by [[NIH|National Institutes of Health]] please see [http://www.bisti.nih.gov/CompuBioDef.pdf this link].) A common thread in projects in bioinformatics and computational genomics is the use of mathematical tools to extract useful information from [[noise|noisy]] data produced by high-throughput biological techniques. (The field of [[data mining]] overlaps with computational biology in this regard.) Representative problems in computational biology include the assembly of high-quality [[DNA]] sequences from fragmentary &quot;shotgun&quot; DNA [[sequencing]], and the prediction of [[gene regulation]] with data from [[Messenger RNA|mRNA]] [[DNA microarray|microarray]]s or [[mass spectrometry]]. </p>
<p><strong>==Major research areas==</strong></p>
<p><strong>===Sequence analysis===</strong><br />''Main articles:'' [[Sequence alignment]], [[Sequence database]]</p>
<p>Since the [[Phi-X174 phage|Phage &amp;Phi;-X174]] was [[sequencing|sequenced]] in 1977, the [[DNA sequence]]s of more and more organisms have been decoded and stored in electronic databases. This data is analyzed to determine genes that code for [[protein]]s, as well as regulatory sequences. A comparison of genes within a [[species]] or between different species can show similarities between protein functions, or relations between species (the use of [[molecular systematics]] to construct [[phylogenetic tree]]s). With the growing amount of data, it long ago became impractical to analyze DNA sequences manually. Today, [[computer program]]s are used to search the [[genome]] of thousands of organisms, containing billions of [[nucleotide]]s.&nbsp; These programs can compensate for mutations (exchanged, deleted or inserted bases) in the DNA sequence, in order to identify sequences that are related, but not identical. A variant of this [[sequence alignment]] is used in the sequencing process itself. The so-called [[shotgun sequencing]] technique (which was used, for example, by [[The Institute for Genomic Research]] to sequence the first bacterial genome, ''Haemophilus influenza'') does not give a sequential list of nucleotides, but instead the sequences of thousands of small DNA fragments (each about 600-800 nucleotides long). The ends of these fragments overlap and, when aligned in the right way, make up the complete genome. Shotgun sequencing yields sequence data quickly, but the task of assembling the fragments can be quite complicated for larger genomes. In the case of the [[Human Genome Project]], it took several months of CPU time (on a circa-2000 vintage DEC Alpha computer) to assemble the fragments.&nbsp; Shotgun sequencing is the method of choice for virtually all genomes sequenced today, and [[genome assembly]] algorithms are a critical area of bioinformatics research.</p>
<p>Another aspect of bioinformatics in sequence analysis is the automatic [[gene finding|search for genes]] and regulatory sequences within a genome.&nbsp; Not all of the nucleotides within a genome are genes. Within the genome of higher organisms, large parts of the DNA do not serve any obvious purpose.&nbsp; This so-called [[junk DNA]] may, however, contain unrecognized functional elements. Bioinformatics helps to bridge the gap between genome and [[proteome]] projects, for example in the use of DNA sequence for protein identification.</p>
<p>''See also:'' [[sequence analysis]], [[sequence profiling tool]], [[sequence motif]].</p>
<p><strong>====Genome annotation====</strong><br />''Main articles:'' [[Gene finding]]</p>
<p>In the context of genomics, '''annotation''' is the process of marking the genes and other biological features in a DNA sequence.&nbsp; The first genome annotation software system was designed in 1995 by Owen White, who was part of the team that sequenced and analyzed the first genome of a free-living organism to be decoded, the bacterium [[Haemophilus influenzae]].&nbsp; Dr. White built a software system to find the genes (places in the DNA sequence that encode a protein), the transfer RNA, and other features, and to make initial assignments of function to those genes.&nbsp; Most current genome annotation systems work similarly, but the programs available for analysis of genomic DNA are constantly changing and improving.</p>
<p>===Computational evolutionary biology===<br />[[Evolutionary biology]] is the study of the origin and descent of [[species]], as well as their change over time. Informatics has assisted evolutionary biologists in several key ways; it has enabled researchers to:<br />*trace the evolution of a large number of organisms by measuring changes in their [[DNA]], rather than through [[physical taxonomy]] or physiological observations alone,<br />*more recently, compare entire [[genomes]], which permits the study of more complex evolutionary events, such as [[gene duplication]], [[lateral gene transfer]], and the prediction of bacterial [[speciation factors]],<br />*build complex computational models of populations to predict the outcome of the system over time<br />*track and share information on an increasingly large number of species and organisms<br />Future work endeavours to reconstruct the now more complex [[Evolutionary_tree|tree of life]].</p>
<p>The area of research within [[computer science]] that uses [[genetic algorithm|genetic algorithms]] is sometimes confused with [[computational evolutionary biology]].&nbsp; Work in this area involves using specialized [[computer software]] to improve equations, algorithms, or [[integrated circuit]] designs.&nbsp; It is inspired by [[evolutionary principles]] such as [[replication]], [[diversification]] through [[recombination]] or [[mutation]], [[fitness]], survival through [[selection]] or [[culling]], and [[iteration]], collectively called a [[Darwinian machine]] or [[Darwinian ratchet]].</p>
<p>===Measuring biodiversity===<br />[[Biodiversity]] of an ecosystem might be defined as the total genomic complement of a particular environment, from all of the species present, whether it is a biofilm in an abandoned mine, a drop of sea water, a scoop of soil, or the entire [[biosphere]] of the planet [[Earth]].&nbsp; Databases are used to collect the [[species]] names, descriptions, distributions, genetic information, status and size of [[population]]s, [[Habitat (ecology)|habitat]] needs, and how each organism interacts with other species.&nbsp; Specialized [[computer software|software]] programs are used to find, visualize, and analyze the information, and most importantly, communicate it to other people.&nbsp; Computer simulations model such things as population dynamics, or calculate the cumulative genetic health of a breeding pool (in [[agriculture]]) or endangered population (in [[conservation ecology|conservation]]).&nbsp; One very exciting potential of this field is that entire [[DNA]] sequences, or [[genome]]s of [[endangered species]] can be preserved, allowing the results of Nature's genetic experiment to be remembered ''[[in silico]]'', and possibly reused in the future, even if that species is eventually lost.</p>
<p>''Important Projects:'' [http://www.sp2000.org/ Species 2000 project].</p>
<p>===Gene expression analysis===</p>
<p>The [[expression]] of many genes can be determined by measuring [[mRNA]] levels with multiple techniques including [[DNA_microarray|microarrays]],&nbsp; [[expressed sequence tag|expressed cDNA sequence tag]] (EST) sequencing, [[Serial Analysis of Gene Expression|serial analysis of gene expression]] (SAGE) tag sequencing, [[massively parallel signature sequencing]] (MPSS), or various applications of multiplexed in-situ hybridization.&nbsp; All of these techniques are extremely noise-prone and/or subject to bias in the biological measurement, and a major research area in computational biology involves developing statistical tools to separate [[signal (information theory)|signal]] from [[noise]] in high-throughput gene expression (HT) studies. HT studies are often used to determine the genes implicated in a disorder: one might compare microarray data from cancerous epithelial cells to data from non-cancerous cells to determine the proteins that are up-regulated and down-regulated in cancer cells.</p>
<p>===Regulation analysis===<br />Regulation is the complex orchestra of events starting with an [[extra-cellular signal]] and ultimately leading to the increase or decrease in the [[protein activity|activity]] of one or more protein molecules.&nbsp; Bioinformatics techniques have been applied to explore various steps in this process.&nbsp; For example, [[promoter analysis]] involves the elucidation and study of [[sequence motif]]s in the genomic region surround the coding region of a gene. These motifs influence the extent to which that region is transcribed into mRNA.&nbsp; Expression data can be used to infer gene regulation: one might compare [[microarray]] data from a wide variety of states of an organism to form hypotheses about the genes involved in each state. In a single-cell organism, one might compare stages of the [[cell cycle]], along with various stress conditions (heat shock, starvation, etc.). One can then apply [[cluster analysis|clustering algorithms]] to that expression data to determine which genes are co-expressed. Further analysis could take a variety of directions: one 2004 study analyzed the [[promoter]] sequences of co-expressed (clustered together) genes to find common [[regulatory elements]] and used [[machine learning]] techniques to identify the promoter elements involved in regulating each cluster{{ref|Beer_2004}}.</p><p>===Protein expression analysis===<br />Protein [[microarray]]s and high throughput (HT) [[mass spectrometry]] (MS) can provide a snapshot of the proteins present in a biological sample. Bioinformatics is very much involved in making sense of protein microarray and HT MS data; the former involves a number of the same problems involve in examining microarrays targeted at mRNA, the latter involves the problem of matching large amounts of mass data against predicted masses from protein sequence databases, and the complicated statistical analysis of samples where multiple, but incomplete, peptides from each protein are detected.</p><p>===Analysis of mutations in cancer===<br />Massive sequencing efforts are currently underway to identify [[point mutation]]s in a variety of [[gene]]s in [[cancer]]. The sheer volume of data produced requires automated systems to read sequence data, and to compare the sequencing results to the known sequence of the [[human genome]], including known [[germline]] polymorphisms.</p>
<p>[[Oligonucleotide]] microarrays, including [[comparative genomic hybridization]] and [[single nucleotide polymorphism]] arrays, able to probe simultaneously up to several hundred thousand sites throughout the genome are being used to identify chromosomal gains and losses in cancer. [[Hidden Markov model]] and [[change-point analysis]] methods are being developed to infer real copy number changes from often noisy data. Further informatics approaches are being developed to understand the implications of lesions found to be recurrent across many tumors.</p>
<p>Some modern tools (e.g. [http://www.q-pharm.com/home/contents/drug_d/soft Quantum 3.1] ) provide tool for changing the protein sequence at specific sites through alterations to its amino acids and predict changes in the bioactivity after mutations.</p>
<p>Many of these studies are based on the [[homology]] detection and protein families computation.&nbsp; [http://phigs.jgi-psf.org Phylogenetically Inferred Groups (PhIGs)], a recently developed method incorporates phylogenetic signals in building gene clusters for use in comparative genomics.</p>
<p>See also [[comparative genomics]], [[bayesian network]] and [[protein family]].</p>
<p>===Modeling biological systems===<br />''Main article:'' [[Systems biology]]</p>
<p>Systems biology involves the use of [[computer simulation]]s of [[cell (biology)|cellular]] subsystems (such as the [[metabolic network|networks of metabolites]] and [[enzyme]]s which comprise [[metabolism]], [[signal transduction]] pathways and [[gene regulatory network]]s) to both analyze and visualize the complex connections of these cellular processes.&nbsp; [[Artificial life]] or virtual evolution attempts to understand evolutionary processes via the computer simulation of simple (artificial) life forms.</p>
<p>===High-throughput image analysis===<br />Computational technologies are also used to accelerate or fully automate the processing, quantification and analysis of large amounts of high-information-content [[Biomedical imagery]]. Modern image analysis systems augment the observers ability to make measurements from a large or complex set of images, by improving [[accuracy]], [[objectivity]], or speed.&nbsp; A fully developed analysis system may completely replace the observer.&nbsp; While these systems are not unique to biology related imagery, their application to biologic problems continue to provide unique challenges and solutions, placing several imagery application under the umbrella of Bioinformatics. These systems are in the process of becoming more important for both [[diagnostics]] and research.&nbsp; Some examples: <br />* high-throughput and high-fidelity quantification and sub-cellular localization ([[high-content screening]], [[cytohistopathology]])<br />* [[morphometrics]] are used to analyze pictures of [[embryo]]s to track and to predict the fate of cell clusters during [[morphogenesis]]<br />* clinical image analysis and visualization<br />* determine the real-time air-flow patterns in breathing lungs of living individuals before and during challenge<br />* quantify occlusion size in real-time imagery from the development of and recovery during arterial injury<br />* making behavioural observations from extended video recordings of laboratory animals<br />* infrared measurements for metabolic activity determination</p>
<p>==Software tools==</p>
<p>The computational biology tool best-known among biologists is probably [[BLAST]], an algorithm for searching large sequence (protein, DNA) databases. [[NCBI]] provides a popular implementation that searches their massive sequence databases.<br />Bioinformatic meta search engines ([[Entrez]], [[Bioinformatic Harvester]]) help finding relevant information from several databases.&nbsp; There are also free Web-based software designed for [[structural bioinformatics]] such as [http://www.cbi.cnptia.embrapa.br/SMS/] [[STING]].</p><p>Computer scripting languages such as [[Perl]] and [[Python programming language|Python]] are often used to interface with [[biological databases]] and [[parse]] output from bioinformatics programs. <br />Communities of bioinformatics programmers have set up [[open source|free/open source]] projects such as [[EMBOSS]], [[Bioconductor]], [[BioPerl]], [[BioLinux]], [[BioPython]], [[BioRuby]], and [[BioJava]] which develop and distribute shared programming tools and objects (as program modules) that make bioinformatics easier.</p><p>An integrated software workbench consisting of many [[open source|free/open source]] tools described above and many others is known as [http://www.vigyaancd.org/ VigyaanCD].<br />[http://taverna.sourceforge.net/ Taverna] an open-source bioinformatics workbench that utilises a [[workflow]] model of experimental design.&nbsp; [http://taverna.sourceforge.net/ Taverna] is included as part of the [http://www.mygrid.org.uk/ myGRID] package of e-science software.<br />[http://www.q-pharm.com&nbsp; Quantum 3.1] is an example of the bioinformatics post-[[QSAR]]&nbsp; technology applying quantum and molecular physics instead of statistical methods. </p>
<p><!-- Please do not add advertisements for commerical tools here. Objective descriptions of noteworthy commercial tools are fine, but ads are not. --></p>
<p>== See also ==</p>
<p>* [[Biomedical informatics]]<br />* [[Biologically-inspired computing]]<br />* [[List_of_publications_in_biology#Bioinformatics|List of publications in bioinformatics]]<br />* [[Molecular modelling]]<br />* [[Morphometrics]]<br />* [[Metabolic network]]<br />* [[Biocybernetics]]<br />* [[Computational biomodeling]]</p>
<p>=== Related fields ===</p>
<p>* [[applied mathematics]] &amp;mdash; [[biology]] &amp;mdash; [[computer science]] &amp;mdash; [[informatics]] &amp;mdash; [[mathematical biology]] &amp;mdash; [[theoretical biology]] &amp;mdash; [[Scientific computing]] &amp;mdash; [[cheminformatics]] &amp;mdash; [[computational science]]</p>
<p>==External links==</p>
<p>* [http://wikiomics.org Wikiomics.org: bioinformatics wiki] for users and developers of bioinformatics worldwide. Focused on practical questions and pointers towards both academic publications and software resources (opened November 2005). <!-- please use it instead of cluttering Wikipedia with links; that's the right place for most of the stuff below --></p>
<p>* Major Societies<br />*[http://www.iscb.org/ The International Society for Computational Biology]</p><p>* Major Organizations<br />**[http://bioinformatics.org/ Bioinformatics Organization (Bioinformatics.Org): The Open-Access Institute]<br />**[http://www.embnet.org/ EMBnet is a science-based group of collaborating nodes throughout Europe and a number of nodes outside Europe]<br />**[http://www.cbse.ucsc.edu/ UCSC Center for Biomolecular Science and Engineering]<br />**[http://www.ebi.ac.uk/ European Bioinformatics Institute]<br />**[http://www.embl.org/ European Molecular Biology Laboratory]<br />**[http://www.girinst.org/ Genetic Information Research Institute]<br />**[http://www.ncbi.nlm.nih.gov/ National Center for Biotechnology Information]<br />**[http://www.open-bio.org/ Open Bioinformatics Foundation: umbrella non-profit organization supporting certain open-source projects in bioinformatics]<br />**[http://ncbo.us National Center for Biomedical Ontology]<br />**[http://www.jgi.doe.gov/ US Department of Energy Joint Genome Institute]</p><p>* Software projects<br />**[http://amos.sourceforge.net/ AMOS: a modular, open-source genome assembler]<br />**[http://www.biosimgrid.org/ BioSimGrid: a distributed database for biomolecular simulations]<br />**[http://www.bioconductor.org/ Bioconductor]<br />**[http://www.cbi.cnptia.embrapa.br/SMS Diamond STING]<br />**[http://bioinformatics.upmc.edu/ UPMC Bioinformatics Web Tools]<br />**[http://www.biojava.org/ BioJava]<br />**[http://biomap.org/ BIOMAP Project: Creating a Unified Global Map of various Macromolecular Biological Structures]<br />**[http://www.bind.ca/ Biomolecular Interaction Network Database]<br />**[http://www.bioperl.org/ BioPerl]<br />**[http://www.biophp.org/ BioPHP]<br />**[http://www.biolinux.fac.org.ar/ BioLinux]<br />**[http://www.biopython.org/ BioPython]<br />**[http://www.bioruby.org/ BioRuby]<br />**[http://www.phylo.org/ CIPRES Project: The Cyber-Infrastructure for Phylogenetic Research]<br />**[http://emboss.sourceforge.net/ EMBOSS]<br />**[http://www.ensembl.org/ Ensembl]<br />**[http://www.gmod.org/ GMOD: The Generic Model Organism Database Project]<br />**[http://harvester.embl.de/ HARVESTER: bioinformatic meta search engine for proteins in human, mouse and rat]<br />**[http://manatee.sourceforge.net/ MANATEE: a web-based system for genome annotation and curation]<br />**[http://proteomeontology.org/ Proteome Ontology Project: An effort to build a Protein Ontology Specification, a part of BIOMAP Project]<br />**[http://bioinformatics.georgetown.edu/Sequerome.htm Sequerome]<br />**[http://seqhound.blueprint.org/ Seqhound]<br />**[http://sidhe.cs.uni.edu/marbl.html MARBL: Text Indexing &amp; Retrieval from Bioinformatics Libraries GPL open source software package to search Genbank]<br />**[http://www.cs.uni.edu/~okane/source/IDF/idf.html Inverse Document Frequency Weighted Genomic Sequence Retrieval]<br />**[http://bio.macfast.org/bide/ BiDE - The Bioinformatics Desktop Environment - An Open Source project to develop a&nbsp; compact Red Hat Linux-based single CD installation, which provides all the flavours of bioinformatics to your desktop]<br />**[http://www.biocircle.org/bide BioCircle BiDE Page]<br />**[http://www.ebioinformatics.org/ eBiotools: A software package that brings most of the Bioinformatics programs to the MacOSX]</p><p>*Comprehensive, Reviewed, Third-Party Course Lists<br />**[http://wbiomed.curtin.edu.au/teach/biochem/resources/Bioinformatics.html A long list of courses world wide].<br />**[http://www.ebi.ac.uk/training/ Training courses] at the [[European Bioinformatics Institute]].<br />**[http://www.ensembl.org/info/courses.html Courses] given about [[Ensembl]].</p><p>*Major Journals<br />**[http://compbiol.plosjournals.org PLoS Computational Biology] <br />**[http://www.nature.com/msb/index.html Nature Molecular Systems Biology]<br />**[http://bioinformatics.oupjournals.org/ Bioinformatics journal]<br />**[http://www.biomedcentral.com/bmcbioinformatics BMC Bioinformatics journal]<br />**[http://www.la-press.com/caninfo.htm Cancer Informatics Open Access journal]<br />**[http://www.comcen.com.au/~journals/bioinfo.htm Online Journal of Bioinformatics ]<br />**[http://www.embnet.org/download/embnetnews/index.html EMBnet.News Online&nbsp; Journal]</p>
<p>*Other Important Sites</p>
<p>**[http://www.biocircle.org/ OpenSource Bioinformatics / Computational Systems Biology portal]<br />**[http://www.bionews.in/ Bioinformatics News]<br />**[http://www.bioinfo-online.net/ Bioinfo-Online News]<br />**[http://bio.oreilly.com/ Books and articles on Bioinformatics from O'Reilly]<br />**[http://gchelpdesk.ualberta.ca/servers/servers.php Genome Canada: Canadian Bioinformatics Help Desk]<br />**[http://www.ornl.gov/TechResources/Human_Genome/research/informatics.html Human Genome Project and Bioinformatics]<br />**[http://ontology.buffalo.edu/smith Barry Smith's biomedical ontology site]<br />**[http://www.microbesonline.org Virtual Insitute of Microbial Stress and Survival (VIMSS)]</p><p>==Notes &amp; references==<br /># {{note|Beer_2004}} Beer MA, Tavazoie S. &quot;[http://www.ncbi.nlm.nih.gov/entrez/query.fcgi?cmd=Retrieve&amp;db=pubmed&amp;dopt=Abstract&amp;list_uids=15084257 Predicting gene expression from sequence].&quot; In ''Cell''. 2004 Apr 16;117(2):185-98.]</p><p>==Bibliography==<br />* Baxevanis, A.D. and Ouellette, B.F.F., eds., ''Bioinformatics: A Practical Guide to the Analysis of Genes and Proteins'', third edition. Wiley, 2005. ISBN 0471478784<br />* Claverie, J.M. and C. Notredame, ''Bioinformatics for Dummies''. Wiley, 2003. ISBN 0764516965<br />* Durbin, R., S. Eddy, A. Krogh and G. Mitchison, ''Biological sequence analysis''. Cambridge University Press, 1998. ISBN 0521629713<br />* Kohane, et al. ''Microarrays for an Integrative Genomics.'' The MIT Press, 2002. ISBN 026211271X<br />* Michael S. Waterman, ''Introduction to Computational Biology: Sequences, Maps and Genomes''. CRC Press, 1995. ISBN 0412993910<br />* Mount, David W.&nbsp; ''Bioinformatics: Sequence and Genome Analysis'' Spring Harbor Press, May 2002. ISBN 0879696087<br />* Pevzner, Pavel A. ''Computational Molecular Biology: An Algorithmic Approach'' The MIT Press, 2000. ISBN 0262161974</p><p>{{genomics-footer}}<br />{{Biology-footer}}<br />[[Category:Bioinformatics|*]]<br />[[Category:Mathematical biology]]</p><p>[[ar:معلوماتية حيوية]]<br />[[de:Bioinformatik]]<br />[[es:Bioinform&aacute;tica]]<br />[[eo:Biokomputiko]]<br />[[fr:Bio-informatique]]<br />[[ko:생물정보학]]<br />[[id:Bioinformatika]]<br />[[is:L&iacute;fuppl&yacute;singafr&aelig;&eth;i]]<br />[[it:Bioinformatica]]<br />[[he:ביואינפורמטיקה]]<br />[[lt:Bioinformatika]]<br />[[lb:Bioinformatik]]<br />[[nl:Bio-informatica]]<br />[[ja:バイオインフォマティクス]]<br />[[no:Bioinformatikk]]<br />[[pl:Bioinformatyka]]<br />[[pt:Bioinform&aacutenbsp;tica]]<br />[[ru:Биоинформатика]]<br />[[simple:Bioinformatics]]<br />[[sr:Биоинформатика]]<br />[[sv:Bioinformatik]]<br />[[th:ชีวสารสนเทศศาสตร์]]<br />[[vi:Tin sinh học]]<br />[[zh:计算生物学]]<br /></p>
Anonymous user

Navigation menu