SlideShare ist ein Scribd-Unternehmen logo
1 von 36
Concepts of
Bioinformatics
Introduction to Bioinformatics
 Combined
to solve
complex
Biological problems
 Algorithms and techniques of computer science being used to solve the problems
faced by molecular biologists
 ‘Information technology applied to the management and analysis of biological data’
 Storage and Analysis are two important functions – bioinformaticians build tools for
each
 Bio IT market has observed significant growth in genomic era
Biology
Chemistry
Statistics
Computer
science
Bioinformatics
Fields of Bioinformatics
 The need for bioinformatics has arisen from the recent explosion of publicly
available genomic information, such as resulting from the Human Genome
Project.
 Gain a better understanding of gene analysis, taxonomy, & evolution.
 To work efficiently on the rational drug designs and reduce the time taken for
development of drug manually.
 Unravel the wealth of Biological information hidden in mass of sequence,
structure, literature and biological data
 Has environmental-clean up benefits
 In agriculture, it can be used to produce high productivity crops
 Gene Therapy
 Forensic Analysis
 Understanding biological pathways and networks in System Biology
Bioinformatics key areas
Bioinformatics lecture
March 5, 2002
organisation of knowledge
(sequences, structures,
functional data)
e.g. homology
searches
Applications of Bioinformatics
 Provides central, globally accessible databases that enable scientists to submit, search and analyze
information and offers software for data studies, modelling and interpretation.
 Sequence Analysis:-
The application of sequence analysis determines those genes which encode regulatory
sequences or peptides by using the information of sequencing. These computational tools
also detect the DNA mutations in an organism and identify those sequences which are related.
Special software is used to see the overlapping of fragments and their assembly.
 Prediction of Protein Structure:-
It is easy to determine the primary structure of proteins in the form of amino acids which
are present on the DNA molecule but it is difficult to determine the secondary, tertiary or
quaternary structures of proteins. Tools of bioinformatics can be used to determine the
complex protein structures.
 Genome Annotation:-
In genome annotation, genomes are marked to know the regulatory sequences and protein
coding. It is a very important part of the human genome project as it determines the
regulatory sequences
 Comparative Genomics:-
Comparative genomics is the branch of
bioinformatics which determines the
genomic structure and function relation
between different biological species
which enable the scientists to trace the
processes of evolution that occur in
genomes of different species.
 Pharmaceutical Research:-
Tools of bioinformatics are also helpful in
drug discovery, diagnosis and disease
management. Complete sequencing of
human genes has enabled the scientists
to make medicines and drugs which can
target more than 500 genes. Accurate
prediction in screening.
S.
No
Unix Windows Linux
1. Open source Close source Open source
2. Very high security system Low security system High security system
3. Command-line GUI Hybrid
4. File system is arranged in
hierarchical manner
File system is arranged in parallel
manner
File system is arranged in
hierarchical manner
5. Not user friendly User friendly User friendly
6. Single tasking Multi tasking Multi tasking
Biological databanks and databases
 Very fast growth of biological
data
 Diversity of biological data:
o Primary sequences
o 3D structures
o Functional data
 Database entry usually
required for publication
o Sequences
o Structures
Nucleic Acid Protein
EMBL (Europe) PIR -
Protein Information
Resource
GenBank (USA) MIPS
DDBJ (Japan) SWISS-PROT
University of Geneva,
now with EBI
TrEMBL
A supplement to SWISS- PROT
NRL-3D
Major primary databases
Sequence Databases
 Three databanks exchange data on a daily basis
 Data can be submitted and accessed at either location
Nucleotides db:
 GenBank - https://www.ncbi.nlm.nih.gov/
 EMBL - https://www.ebi.ac.uk/
 DDBJ - https://www.ddbj.nig.ac.jp/index-e.html
Bibliographic db:
 PubMed , Medline
Specialized db:
 RDP, IMGT, TRANSFAC, MitBase
Genetic db:
 SGD – https://www.yeastgenome.org/
ACeDB, OMIM
Composite Databases Secondary Databases
 Swiss Prot
 PIR
 GenBank
 NRL-3D
 Store structure info or results
of searches of the primary
databases
Composite Databases Primary Source
PROSITE
https://prosite.expasy.org/
SWISS-PROT
PRINTS
http://130.88.97.239/PRINTS/index.p
hp
OWL
Biological Database
Carbohydrate Structure Database:
 CCSD – https://cordis.europa.eu/project/id/BIOT0184
https://www.genome.jp/dbget-bin/www_bfind?carbbank
 Glycome DB – http://www.glycome-db.org/
Metabolic or Enzyme Databases
 BRENDA – https://www.brenda-enzymes.org/
 KEGG – https://www.genome.jp/kegg/
Structure Databases:
 CATH – https://www.cathdb.info/
 SCOP- http://scop.mrc-lmb.cam.ac.uk/
SCOP
 Structural Classification of Proteins
 http://scop.mrc-lmb.cam.ac.uk/
 SCOP database aims to provide a detailed and comprehensive description of
structural and evolutionary relationship between all proteins
 Levels of hierarchy
 Family : Pairwise residue identities of aa 30% or greater
 Superfamily : Eventhough low seq identities, should have common
evolutionary origin
Eg: ATPase domain of HSP and HK
 Fold : Major structural similarity
 Class : all α , all β, α or β, α and β, Multidomain
CATH
 https://www.cathdb.info/
 Class : 2º structure
 Architecture : Gross orientation of 2º structure, independent of connectivities
 Topology (fold family) : topological connection of super families
 S level : Sequence and structural identities
Basis of Sequence Alignment
1. Aligning sequences
2. To find the relatedness of the proteins or gene, if they have a
common ancestor or not.
3. Mutation in the sequences, brings the changes or divergence in the
sequences.
4. Can also reveal the part of the sequence which is crucial for the
functioning of gene or protein.
 Similarity indicates conserved function
 Human and mouse genes are more than 80% similar
 Comparing sequences helps us understand function
Sequence Alignment
 After obtaining nuc/aa sequences, first thing is to compare with the known sequences.
Comparison is done at the level of constituents. Then finding of conserved residues to predict
the nature and function of the protein. This process of mapping is called
Sequence Alignment
1. Local alignment – Smith & Waterman Algorithm
2. Global alignment – Needleman & Wunch Algorithm
 Gapped Alignment
 Ungapped Alignment
 Terms to Know - Homolog, Ortholog, Paralog, Xenolog, Similar and Identical
Alignment scoring and substitution matrices
Dot plots
Dynamic programming algorithm
Heuristic methods (In order to reduce time)
FASTA
BLAST
Pairwise sequence alignment
Multiple sequence alignment
Scoring a sequence alignment
Match score:
Mismatch score:
Gap penalty:
+ 1
+ 0
–1
Matches: 18 × (+1)
Mismatches: 2 × 0
Gaps: 7 × (– 1)
Score = +11
ACGTCTGAT-------ATAGTCTATCT
ACGTCTGATACGCCGTATAGTCTATCT
AC-T-TGA--CG-CGT-TA-TCTATCT
We can achieve this by penalizing more for a new
gap, than for extending an existing gap
 Maximum no of matches gives high similarity – Optimum Alignment
ACGTCTGATACGCCGTATAGTCTATCT
||||| ||| || ||||||||
----CTGATTCGC---ATCGTCTATCT
 Scores:
 positive for identical or similar
 negative for different
 negative for insertion in one of the two sequences
 Substitution matrices – weights replacement of one residue by another
 assumption of evolution by point mutations
 amino acid replacement (by base replacement)
 amino acid insertion
 amino acid deletion
 Significance of alignment
 Depends critically on gap penalty
 Need to adjust to given sequence
Derivation of substitution matrices
PAM matrices
 First substitution matrix; Developed by Dayhoff (1978) based on Point
Accepted Mutation (PAM) model of evolution
 1PAM (without sub) is a unit of evolutionary divergence in which 1% of the aa
have been changed
 Derived from alignment of very similar sequences
 PAM1 = mutation events that change 1%of AA
 PAM2, PAM3, ... extrapolated by matrix multiplication e.g.: PAM2 = PAM1*PAM1; PAM3 =
PAM2 * PAM1 etc
 Lower distance PAM matrix for closely related proteins eg., PAM30
 Higher distance PAM matrix for highly diverged sequences eg., PAM250
Problems with PAM matrices:
 Incorrect modelling of long time substitutions, since conservative mutations dominated by
single nucleotide change
 e.g.: L <–> I, L <–> V, Y <–> F
 long time: any Amino Acid change
positive and negative values identity score depends on residue
 positive and negative
values identity score
depends on residue
BLOSUM matrices
 BLOCKSAmino acid Substitution Matrices
 Similar as PAM; however the data were derived from local alignments for distantly related proteins
deposited in BLOCKS db
 Unlike PAM there is no evolutionary basis
 BLOSUM series (BLOSUM50, BLOSUM62, ...)
 BLOCKS database:
 ungapped multiple alignments of protein families at a given identity
E.g.,
BLOSUM 30 better for gapped alignments – for comparing highly diverged seq
 BLOSUM 90 better for ungapped alignments – for very close seq
 BLOSUM 62 was derived from a set of sequences which are 62% or less similar
DOT Plot
 Simple comparison without alignment
 2D graphical representation method primarily used for finding regions of
local matches between two sequences
 DOTTER, PALIGN, DOTLET (https://dotlet.vital-it.ch/)
 Distinguish by alignment score
 Similarities increase score (positive)
 Mismatches decrease score (Negative)
 Gaps decrease score
Number of possible dots = (probability of pair) x (length of seq A) x (length of seq B)
Disadv – No direct seq homology & Statistically weak
Dynamic programming algorithm
 To build up optimal alignment which maximizes the similarity we need some scoring
methods
 The dynamic programming relies on a principle of optimality.
PROCEDURE
 Construct a two-dimensional matrix whose axes are the two sequences to be compared.
 The scores are calculated one row at a time. This starts with the first row of one
sequence, which is used to scan through the entire length of the other sequence,
followed by scanning of the second row.
 The scanning of the second row takes into account the scores already obtained in the
first round. The best score is put into the bottom right corner of an intermediate
matrix.
 This process is iterated until values for all the cells are filled.
Depicting the results:
 Back tracing
 The best matching path is the one that has the maximum total score.
 If two or more paths reach the same highest score, one is chosen
arbitrarily to represent the best alignment.
 The path can also move horizontally or vertically at a certain
point, which corresponds to introduction of a gap or an insertion
or deletion for one of the two sequences.
BLAST
 Basic Local Alignment search tool
 https://blast.ncbi.nlm.nih.gov/Blast.cgi
 Multi-step approach to find high-scoring local alignments between
two sequences
 List words of fixed length (3AA) (11nuc) expected to give score larger
than threshold (seed alignment)
 For every word, search database and extend ungapped alignment in
both directions upto a certain length to get HSPs
 New versions of BLAST allow gaps
Blastn:
Blastp:
tBlastn:
Blastx:
tBlastx:
nucleotide sequences
protein sequences
protein query - translated database
nucleotide query - protein database
nucleotide query - translated database
Interpretation
 Rapid and easier to find homolog by scanning huge db
 Search against specialized db
 Blast program employ SEG program to filter low complexity regions before
executing db search
 Quality of the alignment is represented by score (to identify hits)
 Significance of the alignment is represented as e-value (Expected value)
 E-value decreases exponentially as the score increases
 The E-value provides information about the likelihood that a given sequence
match is purely by chance. The lower the E- value, the less likely the
database and therefore more significant the match is.
 If E is between 0.01 and 10, the match is considered not significant.
FASTA
 More sensitive than BLAST
 Table to locate all identically matching words of
length Ktup between two sequences
 Blast – Hit extension step
 Fasta – Exact word match
 As the high value of Ktup increases the search
becomes slow
 FASTA also uses E-values and bit scores. The FASTA
output provides one more statistical parameter,
the Z-score.
 If Z is in the range of 5 to 15, the sequence pair
can be described as highly probable homologs. If
Z < 5, their relationships is described as less
certain
Phylogenetics
 Phylogenetics is the study of evolutionary relatedness among various groups of
organisms (e.g., species, populations).
 Methods of Phylogenetic Analysis:
 Monophyletic group – all taxa share by one common ancestor
 Paraphyletic groping – share common ancestor but not all
 Errors in alignment mislead tree
Phenetic
NJ,
UPGMA
Cladistic
MP
ML
 A phylogenetic tree is a tree showing the
evolutionary interrelationships among various
species or other entities that are believed to
have a common ancestor. A phylogenetic tree
is a form of a cladogram. In a phylogenetic
tree, each node with descendants represents
the most recent common ancestor of the
descendants, and edge lengths correspond to
time estimates.
 Each node in a phylogenetic tree is called a
taxonomic unit. Internal nodes are generally
referred to as Hypothetical Taxonomic Units
(HTUs) as they cannot be directly observed
 Distances – no of changes
Parts of a phylogenetic tree
Node
Root
Outgroup
Ingroup
Branch
Phenetic Method of analysis:
 Also known as numerical taxonomy
 Involves various measures of overall similarity for ranking species
 All the data are first converted to a numerical value without any character
(weighing). Then no of similarities / differences is calculated.
 Then clustering or grouping close together
 Lack of evolutionary significance in phenetics
Cladistic method of analysis:
 Alternative approach
 Diagramming relationship between taxa
 Basic assumption – members of the group share a common evolutionary
history
 Typically based on morphological data
Distance and Character
A tree can be based on
 1. quantitative measures like the distance or similarity between species, or
 2. based on qualitative aspects like common characters.
 Molecular clock assumption – substitution in nu / aa are being compared at constant rate
Maximum Parsimony:
 Finds the optimum tree by minimizing the number of evolutionary changes
 No assumptions on the evolutionary pattern
 MSA then scoring
 Rather time consuming works well if seq have strong similarity
 May oversimplify evolution
 May produce several equally good trees
 PAUP, MacClade
Maximum Likelihood:
 The best tree is found based on assumptions on evolution model
 Nucleotide models more advanced at the moment than aminoacid models
 Programs require lot of capacity from the system
Neighbour Joining:
 The sequences that should be joined are chosen to give the best least-squares estimates of the
branch length that most closely reflect the actual distances between the sequences
 NJ method begins by creating a star topology in which no neighbours are connected
 Then tree is modified by joining pair of sequences. Pair to be joined is chosen by calculating
the sum of branch length
 Distance table
 No molecular clock assumed
UPGMA
 Unweighted Pair Group method with Arithmetic Mean
 Works by clustering, starting with more similar towards distant
 Dot representation
 Molecular clock assumed
PHYLIP (Phylogeny Inference Package)
 Available free in Windows/MacOS/Linux systems
 Parsimony, distance matrix and likelihood methods (bootstrapping and
consensus trees)
 Data can be molecular sequences, gene frequencies, restriction sites and
fragments, distance matrices and discrete characters
Bioinformatics

Weitere ähnliche Inhalte

Was ist angesagt? (20)

protein data bank
protein data bankprotein data bank
protein data bank
 
RNA-Seq
RNA-SeqRNA-Seq
RNA-Seq
 
Tools and database of NCBI
Tools and database of NCBITools and database of NCBI
Tools and database of NCBI
 
Proteins databases
Proteins databasesProteins databases
Proteins databases
 
Data mining
Data miningData mining
Data mining
 
sequence of file formats in bioinformatics
sequence of file formats in bioinformaticssequence of file formats in bioinformatics
sequence of file formats in bioinformatics
 
Gen bank databases
Gen bank databasesGen bank databases
Gen bank databases
 
BIOINFORMATICS Applications And Challenges
BIOINFORMATICS Applications And ChallengesBIOINFORMATICS Applications And Challenges
BIOINFORMATICS Applications And Challenges
 
Prosite
PrositeProsite
Prosite
 
Molecular modeling database
Molecular modeling database Molecular modeling database
Molecular modeling database
 
Role of bioinformatics of drug designing
Role of bioinformatics of drug designingRole of bioinformatics of drug designing
Role of bioinformatics of drug designing
 
Gene prediction and expression
Gene prediction and expressionGene prediction and expression
Gene prediction and expression
 
Gene prediction method
Gene prediction method Gene prediction method
Gene prediction method
 
Global and Local Sequence Alignment
Global and Local Sequence AlignmentGlobal and Local Sequence Alignment
Global and Local Sequence Alignment
 
Comparative genomics
Comparative genomicsComparative genomics
Comparative genomics
 
BLAST (Basic local alignment search Tool)
BLAST (Basic local alignment search Tool)BLAST (Basic local alignment search Tool)
BLAST (Basic local alignment search Tool)
 
Functional genomics, and tools
Functional genomics, and toolsFunctional genomics, and tools
Functional genomics, and tools
 
Dot matrix
Dot matrixDot matrix
Dot matrix
 
Kegg
KeggKegg
Kegg
 
Sequence Analysis
Sequence AnalysisSequence Analysis
Sequence Analysis
 

Ähnlich wie Bioinformatics

Project report-on-bio-informatics
Project report-on-bio-informaticsProject report-on-bio-informatics
Project report-on-bio-informaticsDaniela Rotariu
 
Bioinformatics_1_ChenS.pptx
Bioinformatics_1_ChenS.pptxBioinformatics_1_ChenS.pptx
Bioinformatics_1_ChenS.pptxxRowlet
 
Performance Improvement of BLAST with Use of MSA Techniques to Search Ancesto...
Performance Improvement of BLAST with Use of MSA Techniques to Search Ancesto...Performance Improvement of BLAST with Use of MSA Techniques to Search Ancesto...
Performance Improvement of BLAST with Use of MSA Techniques to Search Ancesto...journal ijrtem
 
Performance Improvement of BLAST with Use of MSA Techniques to Search Ancesto...
Performance Improvement of BLAST with Use of MSA Techniques to Search Ancesto...Performance Improvement of BLAST with Use of MSA Techniques to Search Ancesto...
Performance Improvement of BLAST with Use of MSA Techniques to Search Ancesto...IJRTEMJOURNAL
 
Bioinformatic, and tools by kk sahu
Bioinformatic, and tools by kk sahuBioinformatic, and tools by kk sahu
Bioinformatic, and tools by kk sahuKAUSHAL SAHU
 
Informal presentation on bioinformatics
Informal presentation on bioinformaticsInformal presentation on bioinformatics
Informal presentation on bioinformaticsAtai Rabby
 
Bioinformatics, application by kk sahu sir
Bioinformatics, application by kk sahu sirBioinformatics, application by kk sahu sir
Bioinformatics, application by kk sahu sirKAUSHAL SAHU
 
Knowing Your NGS Downstream: Functional Predictions
Knowing Your NGS Downstream: Functional PredictionsKnowing Your NGS Downstream: Functional Predictions
Knowing Your NGS Downstream: Functional PredictionsGolden Helix Inc
 
BioInformatics Tools -Genomics , Proteomics and metablomics
BioInformatics Tools -Genomics , Proteomics and metablomicsBioInformatics Tools -Genomics , Proteomics and metablomics
BioInformatics Tools -Genomics , Proteomics and metablomicsAyeshaYousaf20
 
Bioinformatics MiRON
Bioinformatics MiRONBioinformatics MiRON
Bioinformatics MiRONPrabin Shakya
 
Thesis def
Thesis defThesis def
Thesis defJay Vyas
 
Bioinformatics data mining
Bioinformatics data miningBioinformatics data mining
Bioinformatics data miningSangeeta Das
 
Role of bioinformatics in life sciences research
Role of bioinformatics in life sciences researchRole of bioinformatics in life sciences research
Role of bioinformatics in life sciences researchAnshika Bansal
 
Bioinformatics Introduction and Use of BLAST Tool
Bioinformatics Introduction and Use of BLAST ToolBioinformatics Introduction and Use of BLAST Tool
Bioinformatics Introduction and Use of BLAST ToolJesminBinti
 
Protein structure
Protein structureProtein structure
Protein structurePooja Pawar
 

Ähnlich wie Bioinformatics (20)

bioinformatic.pptx
bioinformatic.pptxbioinformatic.pptx
bioinformatic.pptx
 
Project report-on-bio-informatics
Project report-on-bio-informaticsProject report-on-bio-informatics
Project report-on-bio-informatics
 
Bioinformatics_1_ChenS.pptx
Bioinformatics_1_ChenS.pptxBioinformatics_1_ChenS.pptx
Bioinformatics_1_ChenS.pptx
 
Protein database
Protein databaseProtein database
Protein database
 
Performance Improvement of BLAST with Use of MSA Techniques to Search Ancesto...
Performance Improvement of BLAST with Use of MSA Techniques to Search Ancesto...Performance Improvement of BLAST with Use of MSA Techniques to Search Ancesto...
Performance Improvement of BLAST with Use of MSA Techniques to Search Ancesto...
 
Performance Improvement of BLAST with Use of MSA Techniques to Search Ancesto...
Performance Improvement of BLAST with Use of MSA Techniques to Search Ancesto...Performance Improvement of BLAST with Use of MSA Techniques to Search Ancesto...
Performance Improvement of BLAST with Use of MSA Techniques to Search Ancesto...
 
Bioinformatic, and tools by kk sahu
Bioinformatic, and tools by kk sahuBioinformatic, and tools by kk sahu
Bioinformatic, and tools by kk sahu
 
Protein databases
Protein databasesProtein databases
Protein databases
 
Informal presentation on bioinformatics
Informal presentation on bioinformaticsInformal presentation on bioinformatics
Informal presentation on bioinformatics
 
Bioinformatics, application by kk sahu sir
Bioinformatics, application by kk sahu sirBioinformatics, application by kk sahu sir
Bioinformatics, application by kk sahu sir
 
Data retrieval
Data retrievalData retrieval
Data retrieval
 
Knowing Your NGS Downstream: Functional Predictions
Knowing Your NGS Downstream: Functional PredictionsKnowing Your NGS Downstream: Functional Predictions
Knowing Your NGS Downstream: Functional Predictions
 
BioInformatics Tools -Genomics , Proteomics and metablomics
BioInformatics Tools -Genomics , Proteomics and metablomicsBioInformatics Tools -Genomics , Proteomics and metablomics
BioInformatics Tools -Genomics , Proteomics and metablomics
 
Bioinformatics MiRON
Bioinformatics MiRONBioinformatics MiRON
Bioinformatics MiRON
 
Thesis def
Thesis defThesis def
Thesis def
 
Bioinformatics data mining
Bioinformatics data miningBioinformatics data mining
Bioinformatics data mining
 
Role of bioinformatics in life sciences research
Role of bioinformatics in life sciences researchRole of bioinformatics in life sciences research
Role of bioinformatics in life sciences research
 
Bioinformatics Introduction and Use of BLAST Tool
Bioinformatics Introduction and Use of BLAST ToolBioinformatics Introduction and Use of BLAST Tool
Bioinformatics Introduction and Use of BLAST Tool
 
Genome comparision
Genome comparisionGenome comparision
Genome comparision
 
Protein structure
Protein structureProtein structure
Protein structure
 

Kürzlich hochgeladen

COST ESTIMATION FOR A RESEARCH PROJECT.pptx
COST ESTIMATION FOR A RESEARCH PROJECT.pptxCOST ESTIMATION FOR A RESEARCH PROJECT.pptx
COST ESTIMATION FOR A RESEARCH PROJECT.pptxFarihaAbdulRasheed
 
pumpkin fruit fly, water melon fruit fly, cucumber fruit fly
pumpkin fruit fly, water melon fruit fly, cucumber fruit flypumpkin fruit fly, water melon fruit fly, cucumber fruit fly
pumpkin fruit fly, water melon fruit fly, cucumber fruit flyPRADYUMMAURYA1
 
Bacterial Identification and Classifications
Bacterial Identification and ClassificationsBacterial Identification and Classifications
Bacterial Identification and ClassificationsAreesha Ahmad
 
The Mariana Trench remarkable geological features on Earth.pptx
The Mariana Trench remarkable geological features on Earth.pptxThe Mariana Trench remarkable geological features on Earth.pptx
The Mariana Trench remarkable geological features on Earth.pptxseri bangash
 
GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)Areesha Ahmad
 
Asymmetry in the atmosphere of the ultra-hot Jupiter WASP-76 b
Asymmetry in the atmosphere of the ultra-hot Jupiter WASP-76 bAsymmetry in the atmosphere of the ultra-hot Jupiter WASP-76 b
Asymmetry in the atmosphere of the ultra-hot Jupiter WASP-76 bSérgio Sacani
 
Module for Grade 9 for Asynchronous/Distance learning
Module for Grade 9 for Asynchronous/Distance learningModule for Grade 9 for Asynchronous/Distance learning
Module for Grade 9 for Asynchronous/Distance learninglevieagacer
 
SAMASTIPUR CALL GIRL 7857803690 LOW PRICE ESCORT SERVICE
SAMASTIPUR CALL GIRL 7857803690  LOW PRICE  ESCORT SERVICESAMASTIPUR CALL GIRL 7857803690  LOW PRICE  ESCORT SERVICE
SAMASTIPUR CALL GIRL 7857803690 LOW PRICE ESCORT SERVICEayushi9330
 
Biogenic Sulfur Gases as Biosignatures on Temperate Sub-Neptune Waterworlds
Biogenic Sulfur Gases as Biosignatures on Temperate Sub-Neptune WaterworldsBiogenic Sulfur Gases as Biosignatures on Temperate Sub-Neptune Waterworlds
Biogenic Sulfur Gases as Biosignatures on Temperate Sub-Neptune WaterworldsSérgio Sacani
 
Introduction to Viruses
Introduction to VirusesIntroduction to Viruses
Introduction to VirusesAreesha Ahmad
 
PSYCHOSOCIAL NEEDS. in nursing II sem pptx
PSYCHOSOCIAL NEEDS. in nursing II sem pptxPSYCHOSOCIAL NEEDS. in nursing II sem pptx
PSYCHOSOCIAL NEEDS. in nursing II sem pptxSuji236384
 
❤Jammu Kashmir Call Girls 8617697112 Personal Whatsapp Number 💦✅.
❤Jammu Kashmir Call Girls 8617697112 Personal Whatsapp Number 💦✅.❤Jammu Kashmir Call Girls 8617697112 Personal Whatsapp Number 💦✅.
❤Jammu Kashmir Call Girls 8617697112 Personal Whatsapp Number 💦✅.Nitya salvi
 
Vip profile Call Girls In Lonavala 9748763073 For Genuine Sex Service At Just...
Vip profile Call Girls In Lonavala 9748763073 For Genuine Sex Service At Just...Vip profile Call Girls In Lonavala 9748763073 For Genuine Sex Service At Just...
Vip profile Call Girls In Lonavala 9748763073 For Genuine Sex Service At Just...Monika Rani
 
Grade 7 - Lesson 1 - Microscope and Its Functions
Grade 7 - Lesson 1 - Microscope and Its FunctionsGrade 7 - Lesson 1 - Microscope and Its Functions
Grade 7 - Lesson 1 - Microscope and Its FunctionsOrtegaSyrineMay
 
Forensic Biology & Its biological significance.pdf
Forensic Biology & Its biological significance.pdfForensic Biology & Its biological significance.pdf
Forensic Biology & Its biological significance.pdfrohankumarsinghrore1
 
9654467111 Call Girls In Raj Nagar Delhi Short 1500 Night 6000
9654467111 Call Girls In Raj Nagar Delhi Short 1500 Night 60009654467111 Call Girls In Raj Nagar Delhi Short 1500 Night 6000
9654467111 Call Girls In Raj Nagar Delhi Short 1500 Night 6000Sapana Sha
 
Pulmonary drug delivery system M.pharm -2nd sem P'ceutics
Pulmonary drug delivery system M.pharm -2nd sem P'ceuticsPulmonary drug delivery system M.pharm -2nd sem P'ceutics
Pulmonary drug delivery system M.pharm -2nd sem P'ceuticssakshisoni2385
 
9999266834 Call Girls In Noida Sector 22 (Delhi) Call Girl Service
9999266834 Call Girls In Noida Sector 22 (Delhi) Call Girl Service9999266834 Call Girls In Noida Sector 22 (Delhi) Call Girl Service
9999266834 Call Girls In Noida Sector 22 (Delhi) Call Girl Servicenishacall1
 
Factory Acceptance Test( FAT).pptx .
Factory Acceptance Test( FAT).pptx       .Factory Acceptance Test( FAT).pptx       .
Factory Acceptance Test( FAT).pptx .Poonam Aher Patil
 

Kürzlich hochgeladen (20)

COST ESTIMATION FOR A RESEARCH PROJECT.pptx
COST ESTIMATION FOR A RESEARCH PROJECT.pptxCOST ESTIMATION FOR A RESEARCH PROJECT.pptx
COST ESTIMATION FOR A RESEARCH PROJECT.pptx
 
pumpkin fruit fly, water melon fruit fly, cucumber fruit fly
pumpkin fruit fly, water melon fruit fly, cucumber fruit flypumpkin fruit fly, water melon fruit fly, cucumber fruit fly
pumpkin fruit fly, water melon fruit fly, cucumber fruit fly
 
Bacterial Identification and Classifications
Bacterial Identification and ClassificationsBacterial Identification and Classifications
Bacterial Identification and Classifications
 
The Mariana Trench remarkable geological features on Earth.pptx
The Mariana Trench remarkable geological features on Earth.pptxThe Mariana Trench remarkable geological features on Earth.pptx
The Mariana Trench remarkable geological features on Earth.pptx
 
GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)
 
Asymmetry in the atmosphere of the ultra-hot Jupiter WASP-76 b
Asymmetry in the atmosphere of the ultra-hot Jupiter WASP-76 bAsymmetry in the atmosphere of the ultra-hot Jupiter WASP-76 b
Asymmetry in the atmosphere of the ultra-hot Jupiter WASP-76 b
 
Module for Grade 9 for Asynchronous/Distance learning
Module for Grade 9 for Asynchronous/Distance learningModule for Grade 9 for Asynchronous/Distance learning
Module for Grade 9 for Asynchronous/Distance learning
 
SAMASTIPUR CALL GIRL 7857803690 LOW PRICE ESCORT SERVICE
SAMASTIPUR CALL GIRL 7857803690  LOW PRICE  ESCORT SERVICESAMASTIPUR CALL GIRL 7857803690  LOW PRICE  ESCORT SERVICE
SAMASTIPUR CALL GIRL 7857803690 LOW PRICE ESCORT SERVICE
 
Biogenic Sulfur Gases as Biosignatures on Temperate Sub-Neptune Waterworlds
Biogenic Sulfur Gases as Biosignatures on Temperate Sub-Neptune WaterworldsBiogenic Sulfur Gases as Biosignatures on Temperate Sub-Neptune Waterworlds
Biogenic Sulfur Gases as Biosignatures on Temperate Sub-Neptune Waterworlds
 
Introduction to Viruses
Introduction to VirusesIntroduction to Viruses
Introduction to Viruses
 
PSYCHOSOCIAL NEEDS. in nursing II sem pptx
PSYCHOSOCIAL NEEDS. in nursing II sem pptxPSYCHOSOCIAL NEEDS. in nursing II sem pptx
PSYCHOSOCIAL NEEDS. in nursing II sem pptx
 
❤Jammu Kashmir Call Girls 8617697112 Personal Whatsapp Number 💦✅.
❤Jammu Kashmir Call Girls 8617697112 Personal Whatsapp Number 💦✅.❤Jammu Kashmir Call Girls 8617697112 Personal Whatsapp Number 💦✅.
❤Jammu Kashmir Call Girls 8617697112 Personal Whatsapp Number 💦✅.
 
Vip profile Call Girls In Lonavala 9748763073 For Genuine Sex Service At Just...
Vip profile Call Girls In Lonavala 9748763073 For Genuine Sex Service At Just...Vip profile Call Girls In Lonavala 9748763073 For Genuine Sex Service At Just...
Vip profile Call Girls In Lonavala 9748763073 For Genuine Sex Service At Just...
 
Grade 7 - Lesson 1 - Microscope and Its Functions
Grade 7 - Lesson 1 - Microscope and Its FunctionsGrade 7 - Lesson 1 - Microscope and Its Functions
Grade 7 - Lesson 1 - Microscope and Its Functions
 
Forensic Biology & Its biological significance.pdf
Forensic Biology & Its biological significance.pdfForensic Biology & Its biological significance.pdf
Forensic Biology & Its biological significance.pdf
 
9654467111 Call Girls In Raj Nagar Delhi Short 1500 Night 6000
9654467111 Call Girls In Raj Nagar Delhi Short 1500 Night 60009654467111 Call Girls In Raj Nagar Delhi Short 1500 Night 6000
9654467111 Call Girls In Raj Nagar Delhi Short 1500 Night 6000
 
Pulmonary drug delivery system M.pharm -2nd sem P'ceutics
Pulmonary drug delivery system M.pharm -2nd sem P'ceuticsPulmonary drug delivery system M.pharm -2nd sem P'ceutics
Pulmonary drug delivery system M.pharm -2nd sem P'ceutics
 
9999266834 Call Girls In Noida Sector 22 (Delhi) Call Girl Service
9999266834 Call Girls In Noida Sector 22 (Delhi) Call Girl Service9999266834 Call Girls In Noida Sector 22 (Delhi) Call Girl Service
9999266834 Call Girls In Noida Sector 22 (Delhi) Call Girl Service
 
Clean In Place(CIP).pptx .
Clean In Place(CIP).pptx                 .Clean In Place(CIP).pptx                 .
Clean In Place(CIP).pptx .
 
Factory Acceptance Test( FAT).pptx .
Factory Acceptance Test( FAT).pptx       .Factory Acceptance Test( FAT).pptx       .
Factory Acceptance Test( FAT).pptx .
 

Bioinformatics

  • 2. Introduction to Bioinformatics  Combined to solve complex Biological problems  Algorithms and techniques of computer science being used to solve the problems faced by molecular biologists  ‘Information technology applied to the management and analysis of biological data’  Storage and Analysis are two important functions – bioinformaticians build tools for each  Bio IT market has observed significant growth in genomic era Biology Chemistry Statistics Computer science Bioinformatics
  • 3. Fields of Bioinformatics  The need for bioinformatics has arisen from the recent explosion of publicly available genomic information, such as resulting from the Human Genome Project.  Gain a better understanding of gene analysis, taxonomy, & evolution.  To work efficiently on the rational drug designs and reduce the time taken for development of drug manually.  Unravel the wealth of Biological information hidden in mass of sequence, structure, literature and biological data  Has environmental-clean up benefits  In agriculture, it can be used to produce high productivity crops  Gene Therapy  Forensic Analysis  Understanding biological pathways and networks in System Biology
  • 4. Bioinformatics key areas Bioinformatics lecture March 5, 2002 organisation of knowledge (sequences, structures, functional data) e.g. homology searches
  • 5. Applications of Bioinformatics  Provides central, globally accessible databases that enable scientists to submit, search and analyze information and offers software for data studies, modelling and interpretation.  Sequence Analysis:- The application of sequence analysis determines those genes which encode regulatory sequences or peptides by using the information of sequencing. These computational tools also detect the DNA mutations in an organism and identify those sequences which are related. Special software is used to see the overlapping of fragments and their assembly.  Prediction of Protein Structure:- It is easy to determine the primary structure of proteins in the form of amino acids which are present on the DNA molecule but it is difficult to determine the secondary, tertiary or quaternary structures of proteins. Tools of bioinformatics can be used to determine the complex protein structures.  Genome Annotation:- In genome annotation, genomes are marked to know the regulatory sequences and protein coding. It is a very important part of the human genome project as it determines the regulatory sequences
  • 6.  Comparative Genomics:- Comparative genomics is the branch of bioinformatics which determines the genomic structure and function relation between different biological species which enable the scientists to trace the processes of evolution that occur in genomes of different species.  Pharmaceutical Research:- Tools of bioinformatics are also helpful in drug discovery, diagnosis and disease management. Complete sequencing of human genes has enabled the scientists to make medicines and drugs which can target more than 500 genes. Accurate prediction in screening.
  • 7. S. No Unix Windows Linux 1. Open source Close source Open source 2. Very high security system Low security system High security system 3. Command-line GUI Hybrid 4. File system is arranged in hierarchical manner File system is arranged in parallel manner File system is arranged in hierarchical manner 5. Not user friendly User friendly User friendly 6. Single tasking Multi tasking Multi tasking
  • 8.
  • 9. Biological databanks and databases  Very fast growth of biological data  Diversity of biological data: o Primary sequences o 3D structures o Functional data  Database entry usually required for publication o Sequences o Structures Nucleic Acid Protein EMBL (Europe) PIR - Protein Information Resource GenBank (USA) MIPS DDBJ (Japan) SWISS-PROT University of Geneva, now with EBI TrEMBL A supplement to SWISS- PROT NRL-3D Major primary databases
  • 10. Sequence Databases  Three databanks exchange data on a daily basis  Data can be submitted and accessed at either location Nucleotides db:  GenBank - https://www.ncbi.nlm.nih.gov/  EMBL - https://www.ebi.ac.uk/  DDBJ - https://www.ddbj.nig.ac.jp/index-e.html Bibliographic db:  PubMed , Medline Specialized db:  RDP, IMGT, TRANSFAC, MitBase Genetic db:  SGD – https://www.yeastgenome.org/ ACeDB, OMIM
  • 11. Composite Databases Secondary Databases  Swiss Prot  PIR  GenBank  NRL-3D  Store structure info or results of searches of the primary databases Composite Databases Primary Source PROSITE https://prosite.expasy.org/ SWISS-PROT PRINTS http://130.88.97.239/PRINTS/index.p hp OWL
  • 12. Biological Database Carbohydrate Structure Database:  CCSD – https://cordis.europa.eu/project/id/BIOT0184 https://www.genome.jp/dbget-bin/www_bfind?carbbank  Glycome DB – http://www.glycome-db.org/ Metabolic or Enzyme Databases  BRENDA – https://www.brenda-enzymes.org/  KEGG – https://www.genome.jp/kegg/ Structure Databases:  CATH – https://www.cathdb.info/  SCOP- http://scop.mrc-lmb.cam.ac.uk/
  • 13. SCOP  Structural Classification of Proteins  http://scop.mrc-lmb.cam.ac.uk/  SCOP database aims to provide a detailed and comprehensive description of structural and evolutionary relationship between all proteins  Levels of hierarchy  Family : Pairwise residue identities of aa 30% or greater  Superfamily : Eventhough low seq identities, should have common evolutionary origin Eg: ATPase domain of HSP and HK  Fold : Major structural similarity  Class : all α , all β, α or β, α and β, Multidomain
  • 14. CATH  https://www.cathdb.info/  Class : 2º structure  Architecture : Gross orientation of 2º structure, independent of connectivities  Topology (fold family) : topological connection of super families  S level : Sequence and structural identities
  • 15. Basis of Sequence Alignment 1. Aligning sequences 2. To find the relatedness of the proteins or gene, if they have a common ancestor or not. 3. Mutation in the sequences, brings the changes or divergence in the sequences. 4. Can also reveal the part of the sequence which is crucial for the functioning of gene or protein.  Similarity indicates conserved function  Human and mouse genes are more than 80% similar  Comparing sequences helps us understand function
  • 16. Sequence Alignment  After obtaining nuc/aa sequences, first thing is to compare with the known sequences. Comparison is done at the level of constituents. Then finding of conserved residues to predict the nature and function of the protein. This process of mapping is called Sequence Alignment 1. Local alignment – Smith & Waterman Algorithm 2. Global alignment – Needleman & Wunch Algorithm  Gapped Alignment  Ungapped Alignment  Terms to Know - Homolog, Ortholog, Paralog, Xenolog, Similar and Identical Alignment scoring and substitution matrices Dot plots Dynamic programming algorithm Heuristic methods (In order to reduce time) FASTA BLAST Pairwise sequence alignment Multiple sequence alignment
  • 17. Scoring a sequence alignment Match score: Mismatch score: Gap penalty: + 1 + 0 –1 Matches: 18 × (+1) Mismatches: 2 × 0 Gaps: 7 × (– 1) Score = +11 ACGTCTGAT-------ATAGTCTATCT ACGTCTGATACGCCGTATAGTCTATCT AC-T-TGA--CG-CGT-TA-TCTATCT We can achieve this by penalizing more for a new gap, than for extending an existing gap  Maximum no of matches gives high similarity – Optimum Alignment ACGTCTGATACGCCGTATAGTCTATCT ||||| ||| || |||||||| ----CTGATTCGC---ATCGTCTATCT
  • 18.  Scores:  positive for identical or similar  negative for different  negative for insertion in one of the two sequences  Substitution matrices – weights replacement of one residue by another  assumption of evolution by point mutations  amino acid replacement (by base replacement)  amino acid insertion  amino acid deletion  Significance of alignment  Depends critically on gap penalty  Need to adjust to given sequence
  • 19. Derivation of substitution matrices PAM matrices  First substitution matrix; Developed by Dayhoff (1978) based on Point Accepted Mutation (PAM) model of evolution  1PAM (without sub) is a unit of evolutionary divergence in which 1% of the aa have been changed  Derived from alignment of very similar sequences  PAM1 = mutation events that change 1%of AA  PAM2, PAM3, ... extrapolated by matrix multiplication e.g.: PAM2 = PAM1*PAM1; PAM3 = PAM2 * PAM1 etc  Lower distance PAM matrix for closely related proteins eg., PAM30  Higher distance PAM matrix for highly diverged sequences eg., PAM250 Problems with PAM matrices:  Incorrect modelling of long time substitutions, since conservative mutations dominated by single nucleotide change  e.g.: L <–> I, L <–> V, Y <–> F  long time: any Amino Acid change
  • 20. positive and negative values identity score depends on residue  positive and negative values identity score depends on residue
  • 21. BLOSUM matrices  BLOCKSAmino acid Substitution Matrices  Similar as PAM; however the data were derived from local alignments for distantly related proteins deposited in BLOCKS db  Unlike PAM there is no evolutionary basis  BLOSUM series (BLOSUM50, BLOSUM62, ...)  BLOCKS database:  ungapped multiple alignments of protein families at a given identity E.g., BLOSUM 30 better for gapped alignments – for comparing highly diverged seq  BLOSUM 90 better for ungapped alignments – for very close seq  BLOSUM 62 was derived from a set of sequences which are 62% or less similar
  • 22. DOT Plot  Simple comparison without alignment  2D graphical representation method primarily used for finding regions of local matches between two sequences  DOTTER, PALIGN, DOTLET (https://dotlet.vital-it.ch/)  Distinguish by alignment score  Similarities increase score (positive)  Mismatches decrease score (Negative)  Gaps decrease score Number of possible dots = (probability of pair) x (length of seq A) x (length of seq B) Disadv – No direct seq homology & Statistically weak
  • 23. Dynamic programming algorithm  To build up optimal alignment which maximizes the similarity we need some scoring methods  The dynamic programming relies on a principle of optimality. PROCEDURE  Construct a two-dimensional matrix whose axes are the two sequences to be compared.  The scores are calculated one row at a time. This starts with the first row of one sequence, which is used to scan through the entire length of the other sequence, followed by scanning of the second row.  The scanning of the second row takes into account the scores already obtained in the first round. The best score is put into the bottom right corner of an intermediate matrix.  This process is iterated until values for all the cells are filled.
  • 24. Depicting the results:  Back tracing  The best matching path is the one that has the maximum total score.  If two or more paths reach the same highest score, one is chosen arbitrarily to represent the best alignment.  The path can also move horizontally or vertically at a certain point, which corresponds to introduction of a gap or an insertion or deletion for one of the two sequences.
  • 25. BLAST  Basic Local Alignment search tool  https://blast.ncbi.nlm.nih.gov/Blast.cgi  Multi-step approach to find high-scoring local alignments between two sequences  List words of fixed length (3AA) (11nuc) expected to give score larger than threshold (seed alignment)  For every word, search database and extend ungapped alignment in both directions upto a certain length to get HSPs  New versions of BLAST allow gaps Blastn: Blastp: tBlastn: Blastx: tBlastx: nucleotide sequences protein sequences protein query - translated database nucleotide query - protein database nucleotide query - translated database
  • 26.
  • 27. Interpretation  Rapid and easier to find homolog by scanning huge db  Search against specialized db  Blast program employ SEG program to filter low complexity regions before executing db search  Quality of the alignment is represented by score (to identify hits)  Significance of the alignment is represented as e-value (Expected value)  E-value decreases exponentially as the score increases  The E-value provides information about the likelihood that a given sequence match is purely by chance. The lower the E- value, the less likely the database and therefore more significant the match is.  If E is between 0.01 and 10, the match is considered not significant.
  • 28. FASTA  More sensitive than BLAST  Table to locate all identically matching words of length Ktup between two sequences  Blast – Hit extension step  Fasta – Exact word match  As the high value of Ktup increases the search becomes slow  FASTA also uses E-values and bit scores. The FASTA output provides one more statistical parameter, the Z-score.  If Z is in the range of 5 to 15, the sequence pair can be described as highly probable homologs. If Z < 5, their relationships is described as less certain
  • 29. Phylogenetics  Phylogenetics is the study of evolutionary relatedness among various groups of organisms (e.g., species, populations).  Methods of Phylogenetic Analysis:  Monophyletic group – all taxa share by one common ancestor  Paraphyletic groping – share common ancestor but not all  Errors in alignment mislead tree Phenetic NJ, UPGMA Cladistic MP ML
  • 30.  A phylogenetic tree is a tree showing the evolutionary interrelationships among various species or other entities that are believed to have a common ancestor. A phylogenetic tree is a form of a cladogram. In a phylogenetic tree, each node with descendants represents the most recent common ancestor of the descendants, and edge lengths correspond to time estimates.  Each node in a phylogenetic tree is called a taxonomic unit. Internal nodes are generally referred to as Hypothetical Taxonomic Units (HTUs) as they cannot be directly observed  Distances – no of changes Parts of a phylogenetic tree Node Root Outgroup Ingroup Branch
  • 31. Phenetic Method of analysis:  Also known as numerical taxonomy  Involves various measures of overall similarity for ranking species  All the data are first converted to a numerical value without any character (weighing). Then no of similarities / differences is calculated.  Then clustering or grouping close together  Lack of evolutionary significance in phenetics Cladistic method of analysis:  Alternative approach  Diagramming relationship between taxa  Basic assumption – members of the group share a common evolutionary history  Typically based on morphological data
  • 32. Distance and Character A tree can be based on  1. quantitative measures like the distance or similarity between species, or  2. based on qualitative aspects like common characters.  Molecular clock assumption – substitution in nu / aa are being compared at constant rate
  • 33. Maximum Parsimony:  Finds the optimum tree by minimizing the number of evolutionary changes  No assumptions on the evolutionary pattern  MSA then scoring  Rather time consuming works well if seq have strong similarity  May oversimplify evolution  May produce several equally good trees  PAUP, MacClade Maximum Likelihood:  The best tree is found based on assumptions on evolution model  Nucleotide models more advanced at the moment than aminoacid models  Programs require lot of capacity from the system
  • 34. Neighbour Joining:  The sequences that should be joined are chosen to give the best least-squares estimates of the branch length that most closely reflect the actual distances between the sequences  NJ method begins by creating a star topology in which no neighbours are connected  Then tree is modified by joining pair of sequences. Pair to be joined is chosen by calculating the sum of branch length  Distance table  No molecular clock assumed UPGMA  Unweighted Pair Group method with Arithmetic Mean  Works by clustering, starting with more similar towards distant  Dot representation  Molecular clock assumed
  • 35. PHYLIP (Phylogeny Inference Package)  Available free in Windows/MacOS/Linux systems  Parsimony, distance matrix and likelihood methods (bootstrapping and consensus trees)  Data can be molecular sequences, gene frequencies, restriction sites and fragments, distance matrices and discrete characters