SlideShare a Scribd company logo
Presented by
MARIYA RAJU
MULTIPLE SEQUENCE
ALIGNMENT
MULTIPLE SEQUENCE ALIGNMENT
TREE ALIGNMENT
STAR ALIGNMENT
GENETIC ALGORITHM
PATTERN IN PAIRWISE ALIGNMENT
Terminology
Homology - Two (or more) sequences have a common
ancestor
Similarity - Two sequences are similar, by some
criterias. It does not refer to any evolutionary process,
just to a comparison of the sequences by some method
Conservation - Changes at a specific position of an
amino acid in a sequence that preserve the physico-
chemical properties
Gaps
Positions at which a letter is paired with a
null are called gaps
Gap scores are typically negative
Since a single mutational event may cause
the insertion or deletion of more than one
residue
which may led to the fomation of Gaps
Identity-The extent to which two (nucleotide
or amino acid) sequences are invariant.
Motif- The biological factor which is used as a
model for studies.it may be a functional or
structural domain, active site, phosphorylation
site etc.
Profile- A quantitative motif description -
assigns a degree of similarity to a potential
match
Pairwise alignment
The process of lining up two or more
sequences.
Inorder to achieve ,maximal level of
identity
For the purpose of assessing the degree of
similarity and the possibility of homology.
It is used to find, whether the two proteins,or
nucleic acids are related structurally or
functionally.
It is used to identify, domains or motifs that
are shared between proteins.
It is the basis of BLAST searching .
It is used in the analysis of genomes.
In Pairwise alignment protein sequences
can be more informative than DNA.
protein is more informative: because
many amino acids share related
biophysical properties.
UniProt
UniProt is a comprehensive, high-quality and
freely accessible database of protein sequence
and functional information.
Many entries being derived from genome
sequencing projects.
It contains a large amount of information about
the biological function of proteins derived
from the research literature.
Dot plot
In Bioinformatics a Dot plot is a graphical
method that allows the comparison of
two biological sequences.
Which,identify regions of close similarity
between them. It is a kind of recurrence plot.
These were introduced by Gibbs and McIntyre in
1970.
They are two-dimensional matrices that have the
sequences of the proteins being compared along the
vertical and horizontal axes.
Individual cells in the matrix can be shaded black if
residues are identical so that matching sequence
segments appear as runs of diagonal lines across the
matrix.
A dot plot of a human zinc finger transcription factor.showing
regional self-similarity. The main diagonal represents the sequence's
alignmentwith itself; lines off the main diagonal represent similar or
repetitive patterns within the sequence.
A Multiple Sequence Alignment (MSA) is a
basic tool for the sequence alignment of two or
more biological sequences.
Generally Protein, DNA, or RNA.
In many cases, the input set of query sequences
are assumed to have an evolutionary
relationship.
By which they share a lineage and are
descended from a common ancestor.
Compare all sequences pairwise.
Perform cluster analysis on the pairwise data to
generate a hierarchy for alignment.
This may be in the form of a binary tree or a
simple ordering.
Build the Multiple Alignment by first aligning the
most similar pair of sequences.
Then the next most similar pair and so on.
Once an alignment of two sequences has been
made, then this is fixed.
Thus for a set of sequences A, B, C, D having
aligned .
A with C and B with D the alignment of A, B, C,
D is obtained by comparing the alignments of A
and C with that of B and D using averaged scores
at each aligned position.
An example of Multiple Alignment
• VTISCTGSSSNIGAG-NHVKWYQQLPG
• VTISCTGTSSNIGS--ITVNWYQQLPG
• LRLSCSSSGFIFSS--YAMYWVRQAPG
• LSLTCTVSGTSFDD--YYSTWVRQPPG
• PEVTCVVVDVSHEDPQVKFNWYVDG--
• ATLVCLISDFYPGA--VTVAWKADS--
• AALGCLVKDYFPEP--VTVSWNSG---
• VSLTCLVKGFYPSD--IAVEWWSNG--
Applications of MSA
Detecting similarities between sequences(closely or
distinctly related).
Detecting conserved regions or motifs in sequences.
Detection of structural homologies.
Thus, assisting the improved prediction of secondary
and teritiary structures of proteins.
Making patterns or profiles that can be further
used to predict new sequences falling in a given
family.
Inferring evolutionary trees or linkages.
Progressive Alignment Method
Iterative Refinment Method
Progressive Alignment Method
The most widely used approach to multiple sequence
alignments
Also known as the Hierarchical or Tree method
Developed by Paulien Hogeweg and Ben Hesper in
1984.
Progressive alignment builds up a final MSA by
combining pairwise alignments beginning with the
most similar pair and progressing to the most
distantly related.
All progressive alignment methods require two
stages.
First stage in which the relationships between the
sequences are represented as a tree, called a guide
tree.
Second step in which the MSA is built by adding
the sequences sequentially to the growing MSA
according to the guide tree.
Progressive alignment
algorithms
Clustal W
T-Coffee
Clustal W
The Clustal series of programs are widely used in
molecular biology
For the multiple alignment of both nucleic acid and
protein sequences and for preparing phylogenetic trees.
Works by progressive alignment: it aligns a pair of
sequences then aligns the next one onto the first pair.
Most closely related sequences are aligned first, and then
additional sequences and groups of sequences are added,
guided by the initial alignments
Uses alignment scores to produce a phylogenetic
tree.
Aligns the sequences sequentially, guided by the
phylogenetic relationships indicated by the tree.
T-Coffee
T-Coffee
(Tree based Consistency Objective Function For
alignment Evaluation)
It has advanced features to evaluate the quality of the
alignments
It produces alignment in the aln format (Clustal)
But can also produce PIR, MSF, and FASTA format.
The most common input formats are supported
(FASTA, PIR)
A set of methods to produce MSAs while reducing the errors
inherent in progressive methods are classified as "iterative"
They work similarly to progressive methods but repeatedly
realign the initial sequences as well as adding new sequences
to the growing MSA
Barton and Sternberg formulated this method for MSA.
Different iterative methods used in Bioinformatics are of
DIALGIN,MUSCLE(multiple sequence alignment by log-
expectation),etc
TREE ALIGNMENT
In computational phylogenetics, Tree Alignment is
used to analyse a set of sequences with evolutionary
relationship using a fixed tree.
Essentially,Tree Alignment is an algorithm for
optimizing phylogenetic tree
To be specific, phylogenetic tree shows an
evolutionary relationship between different species
and taxa joined together are assumed to have the
same ancestor.
In MSA ,DNA,RNA, and proteins sequences are
usually generated and they are assumed to have
evolutionary relationship .
Generally ,heuristic algorithm and tree alignment
graph are also adopted to solve multiple sequence
alignment problems.
Tree Alignment Graph
Roughly ,tree alignment graph aims to align
trees into a graph.
And finally synthesis them to develop statistics.
TAG is a combination of a set of aligning trees.
It can store conflicting hypotheses evolutionary
relationship and synthesize the source trees to develop
evolutionary hypotheses.
Therefore ,it is a basic method to solve other
alignment problems.
TAG
STAR ALIGNMENT
Star phylogeny is an another form of Tree Alignment
The Star Alignment is also used to analyse a set of
sequences with evolutionary relationship using a fixed
Star .
Instead of score , Star algorithm uses the cost notation .
An algorithm is a set of instructions that is
repeated to solve a problem.
A genetic algorithm conceptually follows steps
inspired by the biological processes of
evolution.
Genetic Algorithms follow the idea of
SURVIVAL OF THE FITTEST.
Originally developed by John Holland (1975)
Also known as Evolutionary Algorithms, genetic
algorithms demonstrate self organization and
adaptation similar to the way that the fittest
biological organism survive and reproduce.
Generally applied to spaces which are too large.
The method learns by producing offspring that are
better and better as measured by a fitness function.
Steps in Simple GA
Initialize population.
Evaluate population.
Select parents for reproduction.
Perform crossover and mutation.
Evaluate offspring.
Outline of the Basic Genetic
Algorithm
Selection-Select two parent chromosomes
from a population according to their fitness.
Crossover-With a crossover probability cross
over the parents to form a new offspring.
Mutation-With a mutation probability mutate
new offspring at each locus (position in
chromosome).
Accepting -Place new offspring in a new
population
Replace-Use new generated population
for a further run of algorithm
Test-If the end condition is satisfied, stop
and return the best solution in current
population.
MULTIPLE  SEQUENCE  ALIGNMENT

More Related Content

What's hot

sequence alignment
sequence alignmentsequence alignment
sequence alignment
ammar kareem
 
NCBI National Center for Biotechnology Information
NCBI National Center for Biotechnology InformationNCBI National Center for Biotechnology Information
NCBI National Center for Biotechnology Information
Thapar Institute of Engineering & Technology, Patiala, Punjab, India
 
Structural databases
Structural databases Structural databases
Structural databases
Priyadharshana
 
BLAST
BLASTBLAST
European molecular biology laboratory (EMBL)
European molecular biology laboratory (EMBL)European molecular biology laboratory (EMBL)
European molecular biology laboratory (EMBL)
Hafiz Muhammad Zeeshan Raza
 
Introduction to ncbi, embl, ddbj
Introduction to ncbi, embl, ddbjIntroduction to ncbi, embl, ddbj
Introduction to ncbi, embl, ddbj
KAUSHAL SAHU
 
Finding ORF
Finding ORFFinding ORF
Finding ORF
Sabahat Ali
 
Proteins databases
Proteins databasesProteins databases
Proteins databases
Hafiz Muhammad Zeeshan Raza
 
Phylogenetic analysis
Phylogenetic analysis Phylogenetic analysis
Phylogenetic analysis
Nitin Naik
 
Clustal
ClustalClustal
Clustal
Benittabenny
 
Protein data bank
Protein data bankProtein data bank
Protein data bank
Alichy Sowmya
 
Prosite
PrositeProsite
SEQUENCE ANALYSIS
SEQUENCE ANALYSISSEQUENCE ANALYSIS
SEQUENCE ANALYSIS
prashant tripathi
 
BLAST (Basic local alignment search Tool)
BLAST (Basic local alignment search Tool)BLAST (Basic local alignment search Tool)
BLAST (Basic local alignment search Tool)
Ariful Islam Sagar
 
Scop database
Scop databaseScop database
Scop database
Sayantani Roy
 
Blast
BlastBlast
PIR- Protein Information Resource
PIR- Protein Information ResourcePIR- Protein Information Resource
Multiple sequence alignment
Multiple sequence alignmentMultiple sequence alignment
Multiple sequence alignment
Subhranil Bhattacharjee
 
Application of Bioinformatics in different fields of sciences
Application of Bioinformatics in different fields of sciencesApplication of Bioinformatics in different fields of sciences
Application of Bioinformatics in different fields of sciences
Sobia
 

What's hot (20)

sequence alignment
sequence alignmentsequence alignment
sequence alignment
 
NCBI National Center for Biotechnology Information
NCBI National Center for Biotechnology InformationNCBI National Center for Biotechnology Information
NCBI National Center for Biotechnology Information
 
Structural databases
Structural databases Structural databases
Structural databases
 
BLAST
BLASTBLAST
BLAST
 
European molecular biology laboratory (EMBL)
European molecular biology laboratory (EMBL)European molecular biology laboratory (EMBL)
European molecular biology laboratory (EMBL)
 
Introduction to ncbi, embl, ddbj
Introduction to ncbi, embl, ddbjIntroduction to ncbi, embl, ddbj
Introduction to ncbi, embl, ddbj
 
Finding ORF
Finding ORFFinding ORF
Finding ORF
 
Proteins databases
Proteins databasesProteins databases
Proteins databases
 
Phylogenetic analysis
Phylogenetic analysis Phylogenetic analysis
Phylogenetic analysis
 
Phylogenetic analysis
Phylogenetic analysisPhylogenetic analysis
Phylogenetic analysis
 
Clustal
ClustalClustal
Clustal
 
Protein data bank
Protein data bankProtein data bank
Protein data bank
 
Prosite
PrositeProsite
Prosite
 
SEQUENCE ANALYSIS
SEQUENCE ANALYSISSEQUENCE ANALYSIS
SEQUENCE ANALYSIS
 
BLAST (Basic local alignment search Tool)
BLAST (Basic local alignment search Tool)BLAST (Basic local alignment search Tool)
BLAST (Basic local alignment search Tool)
 
Scop database
Scop databaseScop database
Scop database
 
Blast
BlastBlast
Blast
 
PIR- Protein Information Resource
PIR- Protein Information ResourcePIR- Protein Information Resource
PIR- Protein Information Resource
 
Multiple sequence alignment
Multiple sequence alignmentMultiple sequence alignment
Multiple sequence alignment
 
Application of Bioinformatics in different fields of sciences
Application of Bioinformatics in different fields of sciencesApplication of Bioinformatics in different fields of sciences
Application of Bioinformatics in different fields of sciences
 

Similar to MULTIPLE SEQUENCE ALIGNMENT

Sequence homology search and multiple sequence alignment(1)
Sequence homology search and multiple sequence alignment(1)Sequence homology search and multiple sequence alignment(1)
Sequence homology search and multiple sequence alignment(1)
AnkitTiwari354
 
Sequence alignment.pptx
Sequence alignment.pptxSequence alignment.pptx
Sequence alignment.pptx
PagudalaSangeetha
 
4. sequence alignment.pptx
4. sequence alignment.pptx4. sequence alignment.pptx
4. sequence alignment.pptx
ArupKhakhlari1
 
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
 
BIOINFORMATICS_AND_PHYLOGENY.pdf.pdf
BIOINFORMATICS_AND_PHYLOGENY.pdf.pdfBIOINFORMATICS_AND_PHYLOGENY.pdf.pdf
BIOINFORMATICS_AND_PHYLOGENY.pdf.pdf
sirwansleman
 
multiple sequence alignment
multiple sequence alignmentmultiple sequence alignment
multiple sequence alignment
harshita agarwal
 
phy prAC.pptx
phy prAC.pptxphy prAC.pptx
Laboratory 1 sequence_alignments
Laboratory 1 sequence_alignmentsLaboratory 1 sequence_alignments
Laboratory 1 sequence_alignments
seham15
 
Introduction to sequence alignment
Introduction to sequence alignmentIntroduction to sequence alignment
Introduction to sequence alignment
Kubuldinho
 
Lecture 5.pptx
Lecture 5.pptxLecture 5.pptx
Lecture 5.pptx
ericndunek
 
Basics of bioinformatics
Basics of bioinformaticsBasics of bioinformatics
Basics of bioinformaticsAbhishek Vatsa
 
Sequencealignmentinbioinformatics 100204112518-phpapp02
Sequencealignmentinbioinformatics 100204112518-phpapp02Sequencealignmentinbioinformatics 100204112518-phpapp02
Sequencealignmentinbioinformatics 100204112518-phpapp02
PILLAI ASWATHY VISWANATH
 
Multiple Sequence Alignment
Multiple Sequence AlignmentMultiple Sequence Alignment
Multiple Sequence Alignment
Meghaj Mallick
 
Automatic Parallelization for Parallel Architectures Using Smith Waterman Alg...
Automatic Parallelization for Parallel Architectures Using Smith Waterman Alg...Automatic Parallelization for Parallel Architectures Using Smith Waterman Alg...
Automatic Parallelization for Parallel Architectures Using Smith Waterman Alg...
International Journal of Engineering Inventions www.ijeijournal.com
 
multiple sequence and pairwise alignment.pdf
multiple sequence and pairwise alignment.pdfmultiple sequence and pairwise alignment.pdf
multiple sequence and pairwise alignment.pdf
sriaisvariyasundar
 
Sequence alignment
Sequence alignmentSequence alignment
Sequence alignment
Zeeshan Hanjra
 
Multiple Sequence Alignment by Shubham Kaushik
Multiple Sequence Alignment by Shubham KaushikMultiple Sequence Alignment by Shubham Kaushik
Multiple Sequence Alignment by Shubham Kaushik
Shubham Kaushik
 

Similar to MULTIPLE SEQUENCE ALIGNMENT (20)

Sequence homology search and multiple sequence alignment(1)
Sequence homology search and multiple sequence alignment(1)Sequence homology search and multiple sequence alignment(1)
Sequence homology search and multiple sequence alignment(1)
 
Sequence alignment.pptx
Sequence alignment.pptxSequence alignment.pptx
Sequence alignment.pptx
 
4. sequence alignment.pptx
4. sequence alignment.pptx4. sequence alignment.pptx
4. sequence alignment.pptx
 
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...
 
BIOINFORMATICS_AND_PHYLOGENY.pdf.pdf
BIOINFORMATICS_AND_PHYLOGENY.pdf.pdfBIOINFORMATICS_AND_PHYLOGENY.pdf.pdf
BIOINFORMATICS_AND_PHYLOGENY.pdf.pdf
 
multiple sequence alignment
multiple sequence alignmentmultiple sequence alignment
multiple sequence alignment
 
phy prAC.pptx
phy prAC.pptxphy prAC.pptx
phy prAC.pptx
 
Laboratory 1 sequence_alignments
Laboratory 1 sequence_alignmentsLaboratory 1 sequence_alignments
Laboratory 1 sequence_alignments
 
Bioinformatics
BioinformaticsBioinformatics
Bioinformatics
 
Introduction to sequence alignment
Introduction to sequence alignmentIntroduction to sequence alignment
Introduction to sequence alignment
 
Sequence alignment belgaum
Sequence alignment belgaumSequence alignment belgaum
Sequence alignment belgaum
 
Lecture 5.pptx
Lecture 5.pptxLecture 5.pptx
Lecture 5.pptx
 
Basics of bioinformatics
Basics of bioinformaticsBasics of bioinformatics
Basics of bioinformatics
 
Sequencealignmentinbioinformatics 100204112518-phpapp02
Sequencealignmentinbioinformatics 100204112518-phpapp02Sequencealignmentinbioinformatics 100204112518-phpapp02
Sequencealignmentinbioinformatics 100204112518-phpapp02
 
Multiple Sequence Alignment
Multiple Sequence AlignmentMultiple Sequence Alignment
Multiple Sequence Alignment
 
Automatic Parallelization for Parallel Architectures Using Smith Waterman Alg...
Automatic Parallelization for Parallel Architectures Using Smith Waterman Alg...Automatic Parallelization for Parallel Architectures Using Smith Waterman Alg...
Automatic Parallelization for Parallel Architectures Using Smith Waterman Alg...
 
multiple sequence and pairwise alignment.pdf
multiple sequence and pairwise alignment.pdfmultiple sequence and pairwise alignment.pdf
multiple sequence and pairwise alignment.pdf
 
Sequence alignment
Sequence alignmentSequence alignment
Sequence alignment
 
Multiple Sequence Alignment by Shubham Kaushik
Multiple Sequence Alignment by Shubham KaushikMultiple Sequence Alignment by Shubham Kaushik
Multiple Sequence Alignment by Shubham Kaushik
 

More from Mariya Raju

MANUFACTURE OF BREAD
MANUFACTURE OF BREADMANUFACTURE OF BREAD
MANUFACTURE OF BREAD
Mariya Raju
 
FOOD QUALITY CONTROL
FOOD QUALITY CONTROLFOOD QUALITY CONTROL
FOOD QUALITY CONTROL
Mariya Raju
 
EXTREMOPHILES
EXTREMOPHILESEXTREMOPHILES
EXTREMOPHILES
Mariya Raju
 
EMBRYO CULTURE AND EMBRYO RESCUE
EMBRYO CULTURE AND EMBRYO RESCUEEMBRYO CULTURE AND EMBRYO RESCUE
EMBRYO CULTURE AND EMBRYO RESCUE
Mariya Raju
 
COVALENT MODIFICATION AND ZYMOGEN ACTIVATION
COVALENT MODIFICATION AND ZYMOGEN ACTIVATIONCOVALENT MODIFICATION AND ZYMOGEN ACTIVATION
COVALENT MODIFICATION AND ZYMOGEN ACTIVATION
Mariya Raju
 
ELECTRON SPIN RESONANCE SPECTROSCOPY
ELECTRON SPIN RESONANCE SPECTROSCOPYELECTRON SPIN RESONANCE SPECTROSCOPY
ELECTRON SPIN RESONANCE SPECTROSCOPY
Mariya Raju
 
THE CYTOSKELETON
THE CYTOSKELETONTHE CYTOSKELETON
THE CYTOSKELETON
Mariya Raju
 
HIGH FRUCTOSE CORN SYRUP
HIGH FRUCTOSE CORN SYRUPHIGH FRUCTOSE CORN SYRUP
HIGH FRUCTOSE CORN SYRUP
Mariya Raju
 
NEURODEGENERATIVE DISORDERS
NEURODEGENERATIVE DISORDERSNEURODEGENERATIVE DISORDERS
NEURODEGENERATIVE DISORDERS
Mariya Raju
 
THE ARCHAEA
THE ARCHAEATHE ARCHAEA
THE ARCHAEA
Mariya Raju
 
MYCOPROTEINS
MYCOPROTEINSMYCOPROTEINS
MYCOPROTEINS
Mariya Raju
 
FERMENTATIVE PRODUCTION OF BEER,WINE AND OTHER DISTILLED BEVARAGES
FERMENTATIVE PRODUCTION OF BEER,WINE AND OTHER DISTILLED BEVARAGESFERMENTATIVE PRODUCTION OF BEER,WINE AND OTHER DISTILLED BEVARAGES
FERMENTATIVE PRODUCTION OF BEER,WINE AND OTHER DISTILLED BEVARAGES
Mariya Raju
 
Hypersensitivity
HypersensitivityHypersensitivity
Hypersensitivity
Mariya Raju
 
VITAMINS
VITAMINSVITAMINS
VITAMINS
Mariya Raju
 
Bacteriological analysis of drinking water
Bacteriological analysis of drinking waterBacteriological analysis of drinking water
Bacteriological analysis of drinking water
Mariya Raju
 

More from Mariya Raju (15)

MANUFACTURE OF BREAD
MANUFACTURE OF BREADMANUFACTURE OF BREAD
MANUFACTURE OF BREAD
 
FOOD QUALITY CONTROL
FOOD QUALITY CONTROLFOOD QUALITY CONTROL
FOOD QUALITY CONTROL
 
EXTREMOPHILES
EXTREMOPHILESEXTREMOPHILES
EXTREMOPHILES
 
EMBRYO CULTURE AND EMBRYO RESCUE
EMBRYO CULTURE AND EMBRYO RESCUEEMBRYO CULTURE AND EMBRYO RESCUE
EMBRYO CULTURE AND EMBRYO RESCUE
 
COVALENT MODIFICATION AND ZYMOGEN ACTIVATION
COVALENT MODIFICATION AND ZYMOGEN ACTIVATIONCOVALENT MODIFICATION AND ZYMOGEN ACTIVATION
COVALENT MODIFICATION AND ZYMOGEN ACTIVATION
 
ELECTRON SPIN RESONANCE SPECTROSCOPY
ELECTRON SPIN RESONANCE SPECTROSCOPYELECTRON SPIN RESONANCE SPECTROSCOPY
ELECTRON SPIN RESONANCE SPECTROSCOPY
 
THE CYTOSKELETON
THE CYTOSKELETONTHE CYTOSKELETON
THE CYTOSKELETON
 
HIGH FRUCTOSE CORN SYRUP
HIGH FRUCTOSE CORN SYRUPHIGH FRUCTOSE CORN SYRUP
HIGH FRUCTOSE CORN SYRUP
 
NEURODEGENERATIVE DISORDERS
NEURODEGENERATIVE DISORDERSNEURODEGENERATIVE DISORDERS
NEURODEGENERATIVE DISORDERS
 
THE ARCHAEA
THE ARCHAEATHE ARCHAEA
THE ARCHAEA
 
MYCOPROTEINS
MYCOPROTEINSMYCOPROTEINS
MYCOPROTEINS
 
FERMENTATIVE PRODUCTION OF BEER,WINE AND OTHER DISTILLED BEVARAGES
FERMENTATIVE PRODUCTION OF BEER,WINE AND OTHER DISTILLED BEVARAGESFERMENTATIVE PRODUCTION OF BEER,WINE AND OTHER DISTILLED BEVARAGES
FERMENTATIVE PRODUCTION OF BEER,WINE AND OTHER DISTILLED BEVARAGES
 
Hypersensitivity
HypersensitivityHypersensitivity
Hypersensitivity
 
VITAMINS
VITAMINSVITAMINS
VITAMINS
 
Bacteriological analysis of drinking water
Bacteriological analysis of drinking waterBacteriological analysis of drinking water
Bacteriological analysis of drinking water
 

Recently uploaded

ESR_factors_affect-clinic significance-Pathysiology.pptx
ESR_factors_affect-clinic significance-Pathysiology.pptxESR_factors_affect-clinic significance-Pathysiology.pptx
ESR_factors_affect-clinic significance-Pathysiology.pptx
muralinath2
 
Observation of Io’s Resurfacing via Plume Deposition Using Ground-based Adapt...
Observation of Io’s Resurfacing via Plume Deposition Using Ground-based Adapt...Observation of Io’s Resurfacing via Plume Deposition Using Ground-based Adapt...
Observation of Io’s Resurfacing via Plume Deposition Using Ground-based Adapt...
Sérgio Sacani
 
Structural Classification Of Protein (SCOP)
Structural Classification Of Protein  (SCOP)Structural Classification Of Protein  (SCOP)
Structural Classification Of Protein (SCOP)
aishnasrivastava
 
platelets- lifespan -Clot retraction-disorders.pptx
platelets- lifespan -Clot retraction-disorders.pptxplatelets- lifespan -Clot retraction-disorders.pptx
platelets- lifespan -Clot retraction-disorders.pptx
muralinath2
 
Earliest Galaxies in the JADES Origins Field: Luminosity Function and Cosmic ...
Earliest Galaxies in the JADES Origins Field: Luminosity Function and Cosmic ...Earliest Galaxies in the JADES Origins Field: Luminosity Function and Cosmic ...
Earliest Galaxies in the JADES Origins Field: Luminosity Function and Cosmic ...
Sérgio Sacani
 
Hemoglobin metabolism_pathophysiology.pptx
Hemoglobin metabolism_pathophysiology.pptxHemoglobin metabolism_pathophysiology.pptx
Hemoglobin metabolism_pathophysiology.pptx
muralinath2
 
insect taxonomy importance systematics and classification
insect taxonomy importance systematics and classificationinsect taxonomy importance systematics and classification
insect taxonomy importance systematics and classification
anitaento25
 
role of pramana in research.pptx in science
role of pramana in research.pptx in sciencerole of pramana in research.pptx in science
role of pramana in research.pptx in science
sonaliswain16
 
THE IMPORTANCE OF MARTIAN ATMOSPHERE SAMPLE RETURN.
THE IMPORTANCE OF MARTIAN ATMOSPHERE SAMPLE RETURN.THE IMPORTANCE OF MARTIAN ATMOSPHERE SAMPLE RETURN.
THE IMPORTANCE OF MARTIAN ATMOSPHERE SAMPLE RETURN.
Sérgio Sacani
 
(May 29th, 2024) Advancements in Intravital Microscopy- Insights for Preclini...
(May 29th, 2024) Advancements in Intravital Microscopy- Insights for Preclini...(May 29th, 2024) Advancements in Intravital Microscopy- Insights for Preclini...
(May 29th, 2024) Advancements in Intravital Microscopy- Insights for Preclini...
Scintica Instrumentation
 
Deep Behavioral Phenotyping in Systems Neuroscience for Functional Atlasing a...
Deep Behavioral Phenotyping in Systems Neuroscience for Functional Atlasing a...Deep Behavioral Phenotyping in Systems Neuroscience for Functional Atlasing a...
Deep Behavioral Phenotyping in Systems Neuroscience for Functional Atlasing a...
Ana Luísa Pinho
 
NuGOweek 2024 Ghent - programme - final version
NuGOweek 2024 Ghent - programme - final versionNuGOweek 2024 Ghent - programme - final version
NuGOweek 2024 Ghent - programme - final version
pablovgd
 
Unveiling the Energy Potential of Marshmallow Deposits.pdf
Unveiling the Energy Potential of Marshmallow Deposits.pdfUnveiling the Energy Potential of Marshmallow Deposits.pdf
Unveiling the Energy Potential of Marshmallow Deposits.pdf
Erdal Coalmaker
 
Comparative structure of adrenal gland in vertebrates
Comparative structure of adrenal gland in vertebratesComparative structure of adrenal gland in vertebrates
Comparative structure of adrenal gland in vertebrates
sachin783648
 
in vitro propagation of plants lecture note.pptx
in vitro propagation of plants lecture note.pptxin vitro propagation of plants lecture note.pptx
in vitro propagation of plants lecture note.pptx
yusufzako14
 
Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...
Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...
Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...
muralinath2
 
Lab report on liquid viscosity of glycerin
Lab report on liquid viscosity of glycerinLab report on liquid viscosity of glycerin
Lab report on liquid viscosity of glycerin
ossaicprecious19
 
Nucleic Acid-its structural and functional complexity.
Nucleic Acid-its structural and functional complexity.Nucleic Acid-its structural and functional complexity.
Nucleic Acid-its structural and functional complexity.
Nistarini College, Purulia (W.B) India
 
GBSN- Microbiology (Lab 3) Gram Staining
GBSN- Microbiology (Lab 3) Gram StainingGBSN- Microbiology (Lab 3) Gram Staining
GBSN- Microbiology (Lab 3) Gram Staining
Areesha Ahmad
 
PRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATION
PRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATIONPRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATION
PRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATION
ChetanK57
 

Recently uploaded (20)

ESR_factors_affect-clinic significance-Pathysiology.pptx
ESR_factors_affect-clinic significance-Pathysiology.pptxESR_factors_affect-clinic significance-Pathysiology.pptx
ESR_factors_affect-clinic significance-Pathysiology.pptx
 
Observation of Io’s Resurfacing via Plume Deposition Using Ground-based Adapt...
Observation of Io’s Resurfacing via Plume Deposition Using Ground-based Adapt...Observation of Io’s Resurfacing via Plume Deposition Using Ground-based Adapt...
Observation of Io’s Resurfacing via Plume Deposition Using Ground-based Adapt...
 
Structural Classification Of Protein (SCOP)
Structural Classification Of Protein  (SCOP)Structural Classification Of Protein  (SCOP)
Structural Classification Of Protein (SCOP)
 
platelets- lifespan -Clot retraction-disorders.pptx
platelets- lifespan -Clot retraction-disorders.pptxplatelets- lifespan -Clot retraction-disorders.pptx
platelets- lifespan -Clot retraction-disorders.pptx
 
Earliest Galaxies in the JADES Origins Field: Luminosity Function and Cosmic ...
Earliest Galaxies in the JADES Origins Field: Luminosity Function and Cosmic ...Earliest Galaxies in the JADES Origins Field: Luminosity Function and Cosmic ...
Earliest Galaxies in the JADES Origins Field: Luminosity Function and Cosmic ...
 
Hemoglobin metabolism_pathophysiology.pptx
Hemoglobin metabolism_pathophysiology.pptxHemoglobin metabolism_pathophysiology.pptx
Hemoglobin metabolism_pathophysiology.pptx
 
insect taxonomy importance systematics and classification
insect taxonomy importance systematics and classificationinsect taxonomy importance systematics and classification
insect taxonomy importance systematics and classification
 
role of pramana in research.pptx in science
role of pramana in research.pptx in sciencerole of pramana in research.pptx in science
role of pramana in research.pptx in science
 
THE IMPORTANCE OF MARTIAN ATMOSPHERE SAMPLE RETURN.
THE IMPORTANCE OF MARTIAN ATMOSPHERE SAMPLE RETURN.THE IMPORTANCE OF MARTIAN ATMOSPHERE SAMPLE RETURN.
THE IMPORTANCE OF MARTIAN ATMOSPHERE SAMPLE RETURN.
 
(May 29th, 2024) Advancements in Intravital Microscopy- Insights for Preclini...
(May 29th, 2024) Advancements in Intravital Microscopy- Insights for Preclini...(May 29th, 2024) Advancements in Intravital Microscopy- Insights for Preclini...
(May 29th, 2024) Advancements in Intravital Microscopy- Insights for Preclini...
 
Deep Behavioral Phenotyping in Systems Neuroscience for Functional Atlasing a...
Deep Behavioral Phenotyping in Systems Neuroscience for Functional Atlasing a...Deep Behavioral Phenotyping in Systems Neuroscience for Functional Atlasing a...
Deep Behavioral Phenotyping in Systems Neuroscience for Functional Atlasing a...
 
NuGOweek 2024 Ghent - programme - final version
NuGOweek 2024 Ghent - programme - final versionNuGOweek 2024 Ghent - programme - final version
NuGOweek 2024 Ghent - programme - final version
 
Unveiling the Energy Potential of Marshmallow Deposits.pdf
Unveiling the Energy Potential of Marshmallow Deposits.pdfUnveiling the Energy Potential of Marshmallow Deposits.pdf
Unveiling the Energy Potential of Marshmallow Deposits.pdf
 
Comparative structure of adrenal gland in vertebrates
Comparative structure of adrenal gland in vertebratesComparative structure of adrenal gland in vertebrates
Comparative structure of adrenal gland in vertebrates
 
in vitro propagation of plants lecture note.pptx
in vitro propagation of plants lecture note.pptxin vitro propagation of plants lecture note.pptx
in vitro propagation of plants lecture note.pptx
 
Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...
Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...
Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...
 
Lab report on liquid viscosity of glycerin
Lab report on liquid viscosity of glycerinLab report on liquid viscosity of glycerin
Lab report on liquid viscosity of glycerin
 
Nucleic Acid-its structural and functional complexity.
Nucleic Acid-its structural and functional complexity.Nucleic Acid-its structural and functional complexity.
Nucleic Acid-its structural and functional complexity.
 
GBSN- Microbiology (Lab 3) Gram Staining
GBSN- Microbiology (Lab 3) Gram StainingGBSN- Microbiology (Lab 3) Gram Staining
GBSN- Microbiology (Lab 3) Gram Staining
 
PRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATION
PRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATIONPRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATION
PRESENTATION ABOUT PRINCIPLE OF COSMATIC EVALUATION
 

MULTIPLE SEQUENCE ALIGNMENT

  • 2. MULTIPLE SEQUENCE ALIGNMENT TREE ALIGNMENT STAR ALIGNMENT GENETIC ALGORITHM PATTERN IN PAIRWISE ALIGNMENT
  • 3. Terminology Homology - Two (or more) sequences have a common ancestor Similarity - Two sequences are similar, by some criterias. It does not refer to any evolutionary process, just to a comparison of the sequences by some method Conservation - Changes at a specific position of an amino acid in a sequence that preserve the physico- chemical properties
  • 4.
  • 5. Gaps Positions at which a letter is paired with a null are called gaps Gap scores are typically negative Since a single mutational event may cause the insertion or deletion of more than one residue which may led to the fomation of Gaps
  • 6.
  • 7. Identity-The extent to which two (nucleotide or amino acid) sequences are invariant. Motif- The biological factor which is used as a model for studies.it may be a functional or structural domain, active site, phosphorylation site etc. Profile- A quantitative motif description - assigns a degree of similarity to a potential match
  • 8.
  • 9. Pairwise alignment The process of lining up two or more sequences. Inorder to achieve ,maximal level of identity For the purpose of assessing the degree of similarity and the possibility of homology.
  • 10.
  • 11. It is used to find, whether the two proteins,or nucleic acids are related structurally or functionally. It is used to identify, domains or motifs that are shared between proteins. It is the basis of BLAST searching . It is used in the analysis of genomes.
  • 12. In Pairwise alignment protein sequences can be more informative than DNA. protein is more informative: because many amino acids share related biophysical properties.
  • 13. UniProt UniProt is a comprehensive, high-quality and freely accessible database of protein sequence and functional information. Many entries being derived from genome sequencing projects. It contains a large amount of information about the biological function of proteins derived from the research literature.
  • 14. Dot plot In Bioinformatics a Dot plot is a graphical method that allows the comparison of two biological sequences. Which,identify regions of close similarity between them. It is a kind of recurrence plot.
  • 15. These were introduced by Gibbs and McIntyre in 1970. They are two-dimensional matrices that have the sequences of the proteins being compared along the vertical and horizontal axes. Individual cells in the matrix can be shaded black if residues are identical so that matching sequence segments appear as runs of diagonal lines across the matrix.
  • 16. A dot plot of a human zinc finger transcription factor.showing regional self-similarity. The main diagonal represents the sequence's alignmentwith itself; lines off the main diagonal represent similar or repetitive patterns within the sequence.
  • 17.
  • 18. A Multiple Sequence Alignment (MSA) is a basic tool for the sequence alignment of two or more biological sequences. Generally Protein, DNA, or RNA. In many cases, the input set of query sequences are assumed to have an evolutionary relationship. By which they share a lineage and are descended from a common ancestor.
  • 19. Compare all sequences pairwise. Perform cluster analysis on the pairwise data to generate a hierarchy for alignment. This may be in the form of a binary tree or a simple ordering.
  • 20. Build the Multiple Alignment by first aligning the most similar pair of sequences. Then the next most similar pair and so on. Once an alignment of two sequences has been made, then this is fixed. Thus for a set of sequences A, B, C, D having aligned . A with C and B with D the alignment of A, B, C, D is obtained by comparing the alignments of A and C with that of B and D using averaged scores at each aligned position.
  • 21. An example of Multiple Alignment • VTISCTGSSSNIGAG-NHVKWYQQLPG • VTISCTGTSSNIGS--ITVNWYQQLPG • LRLSCSSSGFIFSS--YAMYWVRQAPG • LSLTCTVSGTSFDD--YYSTWVRQPPG • PEVTCVVVDVSHEDPQVKFNWYVDG-- • ATLVCLISDFYPGA--VTVAWKADS-- • AALGCLVKDYFPEP--VTVSWNSG--- • VSLTCLVKGFYPSD--IAVEWWSNG--
  • 22. Applications of MSA Detecting similarities between sequences(closely or distinctly related). Detecting conserved regions or motifs in sequences. Detection of structural homologies. Thus, assisting the improved prediction of secondary and teritiary structures of proteins.
  • 23. Making patterns or profiles that can be further used to predict new sequences falling in a given family. Inferring evolutionary trees or linkages.
  • 25. Progressive Alignment Method The most widely used approach to multiple sequence alignments Also known as the Hierarchical or Tree method Developed by Paulien Hogeweg and Ben Hesper in 1984. Progressive alignment builds up a final MSA by combining pairwise alignments beginning with the most similar pair and progressing to the most distantly related.
  • 26. All progressive alignment methods require two stages. First stage in which the relationships between the sequences are represented as a tree, called a guide tree. Second step in which the MSA is built by adding the sequences sequentially to the growing MSA according to the guide tree.
  • 28. Clustal W The Clustal series of programs are widely used in molecular biology For the multiple alignment of both nucleic acid and protein sequences and for preparing phylogenetic trees. Works by progressive alignment: it aligns a pair of sequences then aligns the next one onto the first pair. Most closely related sequences are aligned first, and then additional sequences and groups of sequences are added, guided by the initial alignments
  • 29. Uses alignment scores to produce a phylogenetic tree. Aligns the sequences sequentially, guided by the phylogenetic relationships indicated by the tree.
  • 30. T-Coffee T-Coffee (Tree based Consistency Objective Function For alignment Evaluation) It has advanced features to evaluate the quality of the alignments It produces alignment in the aln format (Clustal) But can also produce PIR, MSF, and FASTA format. The most common input formats are supported (FASTA, PIR)
  • 31. A set of methods to produce MSAs while reducing the errors inherent in progressive methods are classified as "iterative" They work similarly to progressive methods but repeatedly realign the initial sequences as well as adding new sequences to the growing MSA Barton and Sternberg formulated this method for MSA. Different iterative methods used in Bioinformatics are of DIALGIN,MUSCLE(multiple sequence alignment by log- expectation),etc
  • 32. TREE ALIGNMENT In computational phylogenetics, Tree Alignment is used to analyse a set of sequences with evolutionary relationship using a fixed tree. Essentially,Tree Alignment is an algorithm for optimizing phylogenetic tree To be specific, phylogenetic tree shows an evolutionary relationship between different species and taxa joined together are assumed to have the same ancestor.
  • 33. In MSA ,DNA,RNA, and proteins sequences are usually generated and they are assumed to have evolutionary relationship . Generally ,heuristic algorithm and tree alignment graph are also adopted to solve multiple sequence alignment problems.
  • 34. Tree Alignment Graph Roughly ,tree alignment graph aims to align trees into a graph. And finally synthesis them to develop statistics.
  • 35. TAG is a combination of a set of aligning trees. It can store conflicting hypotheses evolutionary relationship and synthesize the source trees to develop evolutionary hypotheses. Therefore ,it is a basic method to solve other alignment problems.
  • 36. TAG
  • 37. STAR ALIGNMENT Star phylogeny is an another form of Tree Alignment The Star Alignment is also used to analyse a set of sequences with evolutionary relationship using a fixed Star . Instead of score , Star algorithm uses the cost notation .
  • 38.
  • 39. An algorithm is a set of instructions that is repeated to solve a problem. A genetic algorithm conceptually follows steps inspired by the biological processes of evolution. Genetic Algorithms follow the idea of SURVIVAL OF THE FITTEST. Originally developed by John Holland (1975)
  • 40. Also known as Evolutionary Algorithms, genetic algorithms demonstrate self organization and adaptation similar to the way that the fittest biological organism survive and reproduce. Generally applied to spaces which are too large. The method learns by producing offspring that are better and better as measured by a fitness function.
  • 41. Steps in Simple GA Initialize population. Evaluate population. Select parents for reproduction. Perform crossover and mutation. Evaluate offspring.
  • 42. Outline of the Basic Genetic Algorithm Selection-Select two parent chromosomes from a population according to their fitness. Crossover-With a crossover probability cross over the parents to form a new offspring. Mutation-With a mutation probability mutate new offspring at each locus (position in chromosome).
  • 43. Accepting -Place new offspring in a new population Replace-Use new generated population for a further run of algorithm Test-If the end condition is satisfied, stop and return the best solution in current population.