SlideShare uma empresa Scribd logo
1 de 9
Baixar para ler offline
1 Department of Zoology , GACW (2018-2019)
SEQUENCE ALIGNMENT
Introduction:
In bioinformatics, a sequence alignment is a way of arranging the sequences of DNA,
RNA, or protein to identify regions of similarity that may be a consequence of
functional, structural, or evolutionary relationships between the sequences. It is an
important first step toward structural and functional analysis of newly determined
sequences. As new biological sequences are being generated at exponential rate,
sequence comparison is becoming increasingly important to draw functional and
evolutionary inference.
 The sequence alignment is made between a known sequence and unknown
sequence or between two unknown sequences.
 The known sequence is called reference sequence.
 The unknown sequence is called query sequence.
Types of Sequence Alignment
Sequence Alignment is of two types, namely:
 Global Alignment
 Local Alignment
GLOBAL ALIGNMENT:
Global alignment program is based on Needleman-Wunsch algorithm
In global alignment, two sequences to be aligned are assumed to be generally similar
over their entire length. Alignment is carried out from beginning to end of both
sequences to find the best possible alignment across the entire length between the
two sequences.
Input: treat the two sequences as potentially equivalent
Goal: identify conserved regions and differences
Applications:
- Comparing two genes with same function (in human vs. mouse).
- Comparing two proteins with similar function.
LOCAL ALIGNMENT:
Local alignment program is based on Smith-Waterman.
Local alignment, on the other hand, does not assume that the two sequences in
question have similarity over the entire length.
2 Department of Zoology , GACW (2018-2019)
It only finds local regions with the highest level of similarity between the two
sequences and aligns these regions without regard for the alignment of the rest of
the sequence regions.
The three primary methods of producing pairwise alignments are dot-matrix
methods, dynamic programming, and word methods.
Input: The two sequences may or may not be related
Goal: see whether a substring in one sequence aligns well with a substring in the
other
Applications:
 Searching for local similarities in large sequences (e.g., newly sequenced
genomes).
 Looking or conserved domins or motifs in two proteins.
PAIRWISE SEQUENCE ALIGNMENT
Pairwise sequence alignment methods are used to find the best-matching piecewise
(local or global) alignments of two query sequences.
Pairwise alignments can only be used between two sequences at a time, but they are
efficient to calculate.
The three primary methods of producing Pairwise alignments
1. Dot matrix method(old method)
2. The dynamic programming (DP) algorithm (advanced method)
3. Word or k -tuple methods
3 Department of Zoology , GACW (2018-2019)
DOT MATRIX ANALYSIS
A dot matrix is a grid system
where the similar nucleotides of
two DNA sequences are
represented as dots.
It also called dot plots.
It is a Pairwise sequence
alignment made in the
computer.
The dots appear as colorless
dots in the computer screen.
In dot matrix, nucleotides of one sequence are written from the left to right on the
top row and those of the other sequence are written from the top to bottom on the
left side (column) of the matrix. At every point, where the two nucleotides are the
same, a dot in the intersection of row and column becomes a dark dot. When all
these darken dots are connected, it gives a graph called dot plot. The line found in
the dot plot is called recurrence plot. Each dot in the plot represents a matching
nucleotide or amino acid. Dot matrix method is a qualitative and simple to analyze
sequences. However, it takes much time to analyze large sequences.
Dot matrix method is useful for the following studies:
 Sequence similarity between two nucleotide sequences or two amino acid
sequences.
 Insertion of short stretches in DNA or amino acid sequence.
 Deletion of short stretches from a DNA or amino acid sequence.
 Repeats or inserted repeats in a DNA or amino acid sequence.
DYNAMIC PROGRAMMING METHOD
 It was introduced by Richard Bellman in 1940.
 The word programming here denotes finding an acceptable plan of action not
computer programming.
 It is useful in aligning nucleotide sequence of DNA and amino acid sequence
of proteins coded by that DNA.
 Dynamic programming is a three step process that involves :
1) Breaking of the problem into small sub problems.
2) Solving sub problems using recursive methods.
3) Construction of optimal solutions for original problem using the optimal
Solutions.
4 Department of Zoology , GACW (2018-2019)
 Global alignment program is based on Needleman-Wunsch algorithm and
local alignment on Smith-Waterman. Both algorithms are derivates from the
basic dynamic programming algorithm.
Example:
Alignment:
Sequence 1: G A A T T C A G T T A
Sequence 2: G G A T C G A
So M = 11 and N = 7 (the length of sequence #1 and sequence #2, respectively)
A simple scoring scheme is assumed where
 Si,j = 1 if the residue at position i of sequence #1 is the same as the residue at position
j of sequence #2 (match score); otherwise
 Si,j = 0 (mismatch score)
 w = 0 (gap penalty)
Three steps in dynamic programming
1. Initialization
2. Matrix fill (scoring)
3. Traceback (alignment)
Initialization Step
The first step in the global alignment dynamic programming approach is to create
a matrix with M + 1 columns and N + 1 rows where M and N correspond to the
size of the sequences to be aligned.
The matrix can be initially filled with 0.
Matrix Fill Step
5 Department of Zoology , GACW (2018-2019)
One possible (inefficient) solution of the matrix fill step finds the maximum global
alignment score by starting in the upper left hand corner in the matrix and
finding the maximal score Mi,j for each position in the matrix.
After filling in all of the values the score matrix is as follows:
Traceback Step
The traceback step determines the actual alignment(s) that result in the
maximum score.
6 Department of Zoology , GACW (2018-2019)
Giving an alignment of:
G A A T T C A G T T A
| | | | | |
G G A _ T C _ G _ _ A
WORD METHOD OR K-TUPLE METHOD
 It is used to find an optimal alignment solution,but is more than dynamic
programming .
 This method is useful in large-scale database searches to find whether there is
significant match available with the query sequence.
 Word method is used in the database search tools FASTA and the BLAST
family.
 They identify a series of short, non-overlapping subsequences (words) of the
query sequence.
7 Department of Zoology , GACW (2018-2019)
MULTIPLE SEQUENCE ALIGNMENT
Introduction:
Multiple Sequence Alignment (MSA) is generally the alignment of three or more
biological sequence Protein or Nucleic acid) of similar length. From the output,
homology can be inferred and the evolutionary relationship between the
sequences studied.
Types of MSA:
o Dynamic Programming approach
o Progressive method
o Iterative method
Dynamic Programming approach
 In fact, dynamic programming is applicable to align any number of
sequences.
 Computes an optimal alignment for a given score function.
 Because of its high running time, it is not typically used in practice.
Progressive method:
 In this method, Pairwise global alignment is performed for all the possible
and these pairs are aligned together on the basis of their similarity.
8 Department of Zoology , GACW (2018-2019)
 The most similar sequences are aligned together and then less related
sequences are added to it progressively one-by-one until a complete
multiple query set is obtained.
 This method is also called hierarchical method or tree method
Iterative Method:
 A method of performing a series of steps to produce successively better
approximation to align many sequences step-by-step is called iterative
method.
 Here the Pairwise sequence alignment is totally avoided.
 Iterative methods attempt to improve on the weak point of the progressive
methods the heavy dependence on the accuracy of the initial Pairwise
alignment.
9 Department of Zoology , GACW (2018-2019)
Tools in MCA:
Clustal W, Clustal W2, Clustal Omega, Kalign, MAFFT, MUSCLE, M View, T-
Coffee etc.
Applications of MCA:
 Detecting similarities between sequences(closely or distinctly related).
 Detecting conserved regions or motifs in sequences.
 Detecting of structural homologies.
 Thus, assisting the improved prediction of secondary and tertiary
structures of proteins.
References:
https://en.wikipedia.org/wiki/Sequence_alignment
file:///C:/Users/god/Downloads/sequencealig-170209142647.pdf
http://avatar.se/lectures/molbioinfo2001/dynprog/dynamic.html
https://www.slideshare.net/RamyaS96/multiple-sequence-alignment-81493182

Mais conteúdo relacionado

Mais procurados (20)

Gen bank databases
Gen bank databasesGen bank databases
Gen bank databases
 
Blast and fasta
Blast and fastaBlast and fasta
Blast and fasta
 
Clustal W - Multiple Sequence alignment
Clustal W - Multiple Sequence alignment   Clustal W - Multiple Sequence alignment
Clustal W - Multiple Sequence alignment
 
sequence alignment
sequence alignmentsequence alignment
sequence alignment
 
Scoring matrices
Scoring matricesScoring matrices
Scoring matrices
 
Swiss prot database
Swiss prot databaseSwiss prot database
Swiss prot database
 
Introduction OF BIOLOGICAL DATABASE
Introduction OF BIOLOGICAL DATABASEIntroduction OF BIOLOGICAL DATABASE
Introduction OF BIOLOGICAL DATABASE
 
NCBI National Center for Biotechnology Information
NCBI National Center for Biotechnology InformationNCBI National Center for Biotechnology Information
NCBI National Center for Biotechnology Information
 
Rasmol
RasmolRasmol
Rasmol
 
SEQUENCE ANALYSIS
SEQUENCE ANALYSISSEQUENCE ANALYSIS
SEQUENCE ANALYSIS
 
Scop database
Scop databaseScop database
Scop database
 
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
 
Ddbj
DdbjDdbj
Ddbj
 
Introduction to ncbi, embl, ddbj
Introduction to ncbi, embl, ddbjIntroduction to ncbi, embl, ddbj
Introduction to ncbi, embl, ddbj
 
European molecular biology laboratory (EMBL)
European molecular biology laboratory (EMBL)European molecular biology laboratory (EMBL)
European molecular biology laboratory (EMBL)
 
Nucleic Acid Sequence databases
Nucleic Acid Sequence databasesNucleic Acid Sequence databases
Nucleic Acid Sequence databases
 
Clustal
ClustalClustal
Clustal
 
Dot matrix
Dot matrixDot matrix
Dot matrix
 
Phylogenetic analysis
Phylogenetic analysis Phylogenetic analysis
Phylogenetic analysis
 
Global and local alignment (bioinformatics)
Global and local alignment (bioinformatics)Global and local alignment (bioinformatics)
Global and local alignment (bioinformatics)
 

Semelhante a Sequence alignment

Bioinformatics_Sequence Analysis
Bioinformatics_Sequence AnalysisBioinformatics_Sequence Analysis
Bioinformatics_Sequence AnalysisSangeeta Das
 
International Journal of Computer Science, Engineering and Information Techno...
International Journal of Computer Science, Engineering and Information Techno...International Journal of Computer Science, Engineering and Information Techno...
International Journal of Computer Science, Engineering and Information Techno...IJCSEIT Journal
 
Needleman wunsch computional ppt
Needleman wunsch computional pptNeedleman wunsch computional ppt
Needleman wunsch computional ppttarun shekhawat
 
GPCODON ALIGNMENT: A GLOBAL PAIRWISE CODON BASED SEQUENCE ALIGNMENT APPROACH
GPCODON ALIGNMENT: A GLOBAL PAIRWISE CODON BASED SEQUENCE ALIGNMENT APPROACHGPCODON ALIGNMENT: A GLOBAL PAIRWISE CODON BASED SEQUENCE ALIGNMENT APPROACH
GPCODON ALIGNMENT: A GLOBAL PAIRWISE CODON BASED SEQUENCE ALIGNMENT APPROACHijdms
 
multiple sequence and pairwise alignment.pdf
multiple sequence and pairwise alignment.pdfmultiple sequence and pairwise alignment.pdf
multiple sequence and pairwise alignment.pdfsriaisvariyasundar
 
5. Global and Local Alignment Algorithms.pptx
5. Global and Local Alignment Algorithms.pptx5. Global and Local Alignment Algorithms.pptx
5. Global and Local Alignment Algorithms.pptxArupKhakhlari1
 
Laboratory 1 sequence_alignments
Laboratory 1 sequence_alignmentsLaboratory 1 sequence_alignments
Laboratory 1 sequence_alignmentsseham15
 
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
 
AI 바이오 (4일차).pdf
AI 바이오 (4일차).pdfAI 바이오 (4일차).pdf
AI 바이오 (4일차).pdfH K Yoon
 
multiple sequence alignment
multiple sequence alignmentmultiple sequence alignment
multiple sequence alignmentharshita agarwal
 
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
 
Basics of bioinformatics
Basics of bioinformaticsBasics of bioinformatics
Basics of bioinformaticsAbhishek Vatsa
 

Semelhante a Sequence alignment (20)

Bioinformatics_Sequence Analysis
Bioinformatics_Sequence AnalysisBioinformatics_Sequence Analysis
Bioinformatics_Sequence Analysis
 
Sequence Alignment
Sequence AlignmentSequence Alignment
Sequence Alignment
 
Seq alignment
Seq alignment Seq alignment
Seq alignment
 
International Journal of Computer Science, Engineering and Information Techno...
International Journal of Computer Science, Engineering and Information Techno...International Journal of Computer Science, Engineering and Information Techno...
International Journal of Computer Science, Engineering and Information Techno...
 
Sequence alignment
Sequence alignmentSequence alignment
Sequence alignment
 
Sequence Analysis
Sequence AnalysisSequence Analysis
Sequence Analysis
 
Needleman wunsch computional ppt
Needleman wunsch computional pptNeedleman wunsch computional ppt
Needleman wunsch computional ppt
 
Sequence alignment.pptx
Sequence alignment.pptxSequence alignment.pptx
Sequence alignment.pptx
 
GPCODON ALIGNMENT: A GLOBAL PAIRWISE CODON BASED SEQUENCE ALIGNMENT APPROACH
GPCODON ALIGNMENT: A GLOBAL PAIRWISE CODON BASED SEQUENCE ALIGNMENT APPROACHGPCODON ALIGNMENT: A GLOBAL PAIRWISE CODON BASED SEQUENCE ALIGNMENT APPROACH
GPCODON ALIGNMENT: A GLOBAL PAIRWISE CODON BASED SEQUENCE ALIGNMENT APPROACH
 
multiple sequence and pairwise alignment.pdf
multiple sequence and pairwise alignment.pdfmultiple sequence and pairwise alignment.pdf
multiple sequence and pairwise alignment.pdf
 
5. Global and Local Alignment Algorithms.pptx
5. Global and Local Alignment Algorithms.pptx5. Global and Local Alignment Algorithms.pptx
5. Global and Local Alignment Algorithms.pptx
 
Laboratory 1 sequence_alignments
Laboratory 1 sequence_alignmentsLaboratory 1 sequence_alignments
Laboratory 1 sequence_alignments
 
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)
 
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...
 
AI 바이오 (4일차).pdf
AI 바이오 (4일차).pdfAI 바이오 (4일차).pdf
AI 바이오 (4일차).pdf
 
Parwati sihag
Parwati sihagParwati sihag
Parwati sihag
 
multiple sequence alignment
multiple sequence alignmentmultiple sequence alignment
multiple sequence alignment
 
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...
 
Basics of bioinformatics
Basics of bioinformaticsBasics of bioinformatics
Basics of bioinformatics
 

Mais de Vidya Kalaivani Rajkumar

Transgenic plants- Abiotic stress tolerance
Transgenic plants- Abiotic stress toleranceTransgenic plants- Abiotic stress tolerance
Transgenic plants- Abiotic stress toleranceVidya Kalaivani Rajkumar
 
Protein structure visualization tools-RASMOL
Protein structure visualization tools-RASMOLProtein structure visualization tools-RASMOL
Protein structure visualization tools-RASMOLVidya Kalaivani Rajkumar
 

Mais de Vidya Kalaivani Rajkumar (20)

Recombinant vaccines-Peptide Vaccines
Recombinant vaccines-Peptide Vaccines Recombinant vaccines-Peptide Vaccines
Recombinant vaccines-Peptide Vaccines
 
Transgenic plants- Abiotic stress tolerance
Transgenic plants- Abiotic stress toleranceTransgenic plants- Abiotic stress tolerance
Transgenic plants- Abiotic stress tolerance
 
Bioreactors in tissue engineering
Bioreactors in tissue engineeringBioreactors in tissue engineering
Bioreactors in tissue engineering
 
Tissue assembly in microgravity
Tissue assembly in microgravityTissue assembly in microgravity
Tissue assembly in microgravity
 
In vivo synthesis of tissues and organs
In vivo synthesis of tissues and organsIn vivo synthesis of tissues and organs
In vivo synthesis of tissues and organs
 
Bioartificial pancreas
Bioartificial pancreasBioartificial pancreas
Bioartificial pancreas
 
Biomaterials for tissue engineering
Biomaterials for tissue engineeringBiomaterials for tissue engineering
Biomaterials for tissue engineering
 
Haematopoietic system
Haematopoietic systemHaematopoietic system
Haematopoietic system
 
Fasta
FastaFasta
Fasta
 
Water vascular system of star fish
Water vascular system of star fishWater vascular system of star fish
Water vascular system of star fish
 
Cephalopodes are advance molluscs
Cephalopodes are advance molluscsCephalopodes are advance molluscs
Cephalopodes are advance molluscs
 
Beat air pollution
Beat air pollution Beat air pollution
Beat air pollution
 
Birth control methods
Birth control methodsBirth control methods
Birth control methods
 
Future of human evolution
Future of human evolutionFuture of human evolution
Future of human evolution
 
Assignment on developmental zoology
Assignment on developmental zoologyAssignment on developmental zoology
Assignment on developmental zoology
 
Development of chick
Development of chickDevelopment of chick
Development of chick
 
Major biological nucleotide databases
Major biological nucleotide databasesMajor biological nucleotide databases
Major biological nucleotide databases
 
Protein structure visualization tools-RASMOL
Protein structure visualization tools-RASMOLProtein structure visualization tools-RASMOL
Protein structure visualization tools-RASMOL
 
Swiss pdb viewer
Swiss pdb viewerSwiss pdb viewer
Swiss pdb viewer
 
Swiss PROT
Swiss PROT Swiss PROT
Swiss PROT
 

Último

Disentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOSTDisentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOSTSérgio Sacani
 
Isotopic evidence of long-lived volcanism on Io
Isotopic evidence of long-lived volcanism on IoIsotopic evidence of long-lived volcanism on Io
Isotopic evidence of long-lived volcanism on IoSérgio Sacani
 
Nightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43b
Nightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43bNightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43b
Nightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43bSérgio Sacani
 
Nanoparticles synthesis and characterization​ ​
Nanoparticles synthesis and characterization​  ​Nanoparticles synthesis and characterization​  ​
Nanoparticles synthesis and characterization​ ​kaibalyasahoo82800
 
Presentation Vikram Lander by Vedansh Gupta.pptx
Presentation Vikram Lander by Vedansh Gupta.pptxPresentation Vikram Lander by Vedansh Gupta.pptx
Presentation Vikram Lander by Vedansh Gupta.pptxgindu3009
 
STERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCE
STERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCESTERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCE
STERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCEPRINCE C P
 
GFP in rDNA Technology (Biotechnology).pptx
GFP in rDNA Technology (Biotechnology).pptxGFP in rDNA Technology (Biotechnology).pptx
GFP in rDNA Technology (Biotechnology).pptxAleenaTreesaSaji
 
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...Sérgio Sacani
 
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...jana861314
 
GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)Areesha Ahmad
 
TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...
TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...
TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...ssifa0344
 
Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)PraveenaKalaiselvan1
 
Orientation, design and principles of polyhouse
Orientation, design and principles of polyhouseOrientation, design and principles of polyhouse
Orientation, design and principles of polyhousejana861314
 
Chemistry 4th semester series (krishna).pdf
Chemistry 4th semester series (krishna).pdfChemistry 4th semester series (krishna).pdf
Chemistry 4th semester series (krishna).pdfSumit Kumar yadav
 
Spermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatidSpermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatidSarthak Sekhar Mondal
 
GBSN - Microbiology (Unit 1)
GBSN - Microbiology (Unit 1)GBSN - Microbiology (Unit 1)
GBSN - Microbiology (Unit 1)Areesha Ahmad
 
Broad bean, Lima Bean, Jack bean, Ullucus.pptx
Broad bean, Lima Bean, Jack bean, Ullucus.pptxBroad bean, Lima Bean, Jack bean, Ullucus.pptx
Broad bean, Lima Bean, Jack bean, Ullucus.pptxjana861314
 
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral AnalysisRaman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral AnalysisDiwakar Mishra
 

Último (20)

Disentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOSTDisentangling the origin of chemical differences using GHOST
Disentangling the origin of chemical differences using GHOST
 
Isotopic evidence of long-lived volcanism on Io
Isotopic evidence of long-lived volcanism on IoIsotopic evidence of long-lived volcanism on Io
Isotopic evidence of long-lived volcanism on Io
 
Nightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43b
Nightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43bNightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43b
Nightside clouds and disequilibrium chemistry on the hot Jupiter WASP-43b
 
Nanoparticles synthesis and characterization​ ​
Nanoparticles synthesis and characterization​  ​Nanoparticles synthesis and characterization​  ​
Nanoparticles synthesis and characterization​ ​
 
Presentation Vikram Lander by Vedansh Gupta.pptx
Presentation Vikram Lander by Vedansh Gupta.pptxPresentation Vikram Lander by Vedansh Gupta.pptx
Presentation Vikram Lander by Vedansh Gupta.pptx
 
STERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCE
STERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCESTERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCE
STERILITY TESTING OF PHARMACEUTICALS ppt by DR.C.P.PRINCE
 
GFP in rDNA Technology (Biotechnology).pptx
GFP in rDNA Technology (Biotechnology).pptxGFP in rDNA Technology (Biotechnology).pptx
GFP in rDNA Technology (Biotechnology).pptx
 
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...
Discovery of an Accretion Streamer and a Slow Wide-angle Outflow around FUOri...
 
Engler and Prantl system of classification in plant taxonomy
Engler and Prantl system of classification in plant taxonomyEngler and Prantl system of classification in plant taxonomy
Engler and Prantl system of classification in plant taxonomy
 
CELL -Structural and Functional unit of life.pdf
CELL -Structural and Functional unit of life.pdfCELL -Structural and Functional unit of life.pdf
CELL -Structural and Functional unit of life.pdf
 
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...
Traditional Agroforestry System in India- Shifting Cultivation, Taungya, Home...
 
GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)
 
TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...
TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...
TEST BANK For Radiologic Science for Technologists, 12th Edition by Stewart C...
 
Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)Recombinant DNA technology (Immunological screening)
Recombinant DNA technology (Immunological screening)
 
Orientation, design and principles of polyhouse
Orientation, design and principles of polyhouseOrientation, design and principles of polyhouse
Orientation, design and principles of polyhouse
 
Chemistry 4th semester series (krishna).pdf
Chemistry 4th semester series (krishna).pdfChemistry 4th semester series (krishna).pdf
Chemistry 4th semester series (krishna).pdf
 
Spermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatidSpermiogenesis or Spermateleosis or metamorphosis of spermatid
Spermiogenesis or Spermateleosis or metamorphosis of spermatid
 
GBSN - Microbiology (Unit 1)
GBSN - Microbiology (Unit 1)GBSN - Microbiology (Unit 1)
GBSN - Microbiology (Unit 1)
 
Broad bean, Lima Bean, Jack bean, Ullucus.pptx
Broad bean, Lima Bean, Jack bean, Ullucus.pptxBroad bean, Lima Bean, Jack bean, Ullucus.pptx
Broad bean, Lima Bean, Jack bean, Ullucus.pptx
 
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral AnalysisRaman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
Raman spectroscopy.pptx M Pharm, M Sc, Advanced Spectral Analysis
 

Sequence alignment

  • 1. 1 Department of Zoology , GACW (2018-2019) SEQUENCE ALIGNMENT Introduction: In bioinformatics, a sequence alignment is a way of arranging the sequences of DNA, RNA, or protein to identify regions of similarity that may be a consequence of functional, structural, or evolutionary relationships between the sequences. It is an important first step toward structural and functional analysis of newly determined sequences. As new biological sequences are being generated at exponential rate, sequence comparison is becoming increasingly important to draw functional and evolutionary inference.  The sequence alignment is made between a known sequence and unknown sequence or between two unknown sequences.  The known sequence is called reference sequence.  The unknown sequence is called query sequence. Types of Sequence Alignment Sequence Alignment is of two types, namely:  Global Alignment  Local Alignment GLOBAL ALIGNMENT: Global alignment program is based on Needleman-Wunsch algorithm In global alignment, two sequences to be aligned are assumed to be generally similar over their entire length. Alignment is carried out from beginning to end of both sequences to find the best possible alignment across the entire length between the two sequences. Input: treat the two sequences as potentially equivalent Goal: identify conserved regions and differences Applications: - Comparing two genes with same function (in human vs. mouse). - Comparing two proteins with similar function. LOCAL ALIGNMENT: Local alignment program is based on Smith-Waterman. Local alignment, on the other hand, does not assume that the two sequences in question have similarity over the entire length.
  • 2. 2 Department of Zoology , GACW (2018-2019) It only finds local regions with the highest level of similarity between the two sequences and aligns these regions without regard for the alignment of the rest of the sequence regions. The three primary methods of producing pairwise alignments are dot-matrix methods, dynamic programming, and word methods. Input: The two sequences may or may not be related Goal: see whether a substring in one sequence aligns well with a substring in the other Applications:  Searching for local similarities in large sequences (e.g., newly sequenced genomes).  Looking or conserved domins or motifs in two proteins. PAIRWISE SEQUENCE ALIGNMENT Pairwise sequence alignment methods are used to find the best-matching piecewise (local or global) alignments of two query sequences. Pairwise alignments can only be used between two sequences at a time, but they are efficient to calculate. The three primary methods of producing Pairwise alignments 1. Dot matrix method(old method) 2. The dynamic programming (DP) algorithm (advanced method) 3. Word or k -tuple methods
  • 3. 3 Department of Zoology , GACW (2018-2019) DOT MATRIX ANALYSIS A dot matrix is a grid system where the similar nucleotides of two DNA sequences are represented as dots. It also called dot plots. It is a Pairwise sequence alignment made in the computer. The dots appear as colorless dots in the computer screen. In dot matrix, nucleotides of one sequence are written from the left to right on the top row and those of the other sequence are written from the top to bottom on the left side (column) of the matrix. At every point, where the two nucleotides are the same, a dot in the intersection of row and column becomes a dark dot. When all these darken dots are connected, it gives a graph called dot plot. The line found in the dot plot is called recurrence plot. Each dot in the plot represents a matching nucleotide or amino acid. Dot matrix method is a qualitative and simple to analyze sequences. However, it takes much time to analyze large sequences. Dot matrix method is useful for the following studies:  Sequence similarity between two nucleotide sequences or two amino acid sequences.  Insertion of short stretches in DNA or amino acid sequence.  Deletion of short stretches from a DNA or amino acid sequence.  Repeats or inserted repeats in a DNA or amino acid sequence. DYNAMIC PROGRAMMING METHOD  It was introduced by Richard Bellman in 1940.  The word programming here denotes finding an acceptable plan of action not computer programming.  It is useful in aligning nucleotide sequence of DNA and amino acid sequence of proteins coded by that DNA.  Dynamic programming is a three step process that involves : 1) Breaking of the problem into small sub problems. 2) Solving sub problems using recursive methods. 3) Construction of optimal solutions for original problem using the optimal Solutions.
  • 4. 4 Department of Zoology , GACW (2018-2019)  Global alignment program is based on Needleman-Wunsch algorithm and local alignment on Smith-Waterman. Both algorithms are derivates from the basic dynamic programming algorithm. Example: Alignment: Sequence 1: G A A T T C A G T T A Sequence 2: G G A T C G A So M = 11 and N = 7 (the length of sequence #1 and sequence #2, respectively) A simple scoring scheme is assumed where  Si,j = 1 if the residue at position i of sequence #1 is the same as the residue at position j of sequence #2 (match score); otherwise  Si,j = 0 (mismatch score)  w = 0 (gap penalty) Three steps in dynamic programming 1. Initialization 2. Matrix fill (scoring) 3. Traceback (alignment) Initialization Step The first step in the global alignment dynamic programming approach is to create a matrix with M + 1 columns and N + 1 rows where M and N correspond to the size of the sequences to be aligned. The matrix can be initially filled with 0. Matrix Fill Step
  • 5. 5 Department of Zoology , GACW (2018-2019) One possible (inefficient) solution of the matrix fill step finds the maximum global alignment score by starting in the upper left hand corner in the matrix and finding the maximal score Mi,j for each position in the matrix. After filling in all of the values the score matrix is as follows: Traceback Step The traceback step determines the actual alignment(s) that result in the maximum score.
  • 6. 6 Department of Zoology , GACW (2018-2019) Giving an alignment of: G A A T T C A G T T A | | | | | | G G A _ T C _ G _ _ A WORD METHOD OR K-TUPLE METHOD  It is used to find an optimal alignment solution,but is more than dynamic programming .  This method is useful in large-scale database searches to find whether there is significant match available with the query sequence.  Word method is used in the database search tools FASTA and the BLAST family.  They identify a series of short, non-overlapping subsequences (words) of the query sequence.
  • 7. 7 Department of Zoology , GACW (2018-2019) MULTIPLE SEQUENCE ALIGNMENT Introduction: Multiple Sequence Alignment (MSA) is generally the alignment of three or more biological sequence Protein or Nucleic acid) of similar length. From the output, homology can be inferred and the evolutionary relationship between the sequences studied. Types of MSA: o Dynamic Programming approach o Progressive method o Iterative method Dynamic Programming approach  In fact, dynamic programming is applicable to align any number of sequences.  Computes an optimal alignment for a given score function.  Because of its high running time, it is not typically used in practice. Progressive method:  In this method, Pairwise global alignment is performed for all the possible and these pairs are aligned together on the basis of their similarity.
  • 8. 8 Department of Zoology , GACW (2018-2019)  The most similar sequences are aligned together and then less related sequences are added to it progressively one-by-one until a complete multiple query set is obtained.  This method is also called hierarchical method or tree method Iterative Method:  A method of performing a series of steps to produce successively better approximation to align many sequences step-by-step is called iterative method.  Here the Pairwise sequence alignment is totally avoided.  Iterative methods attempt to improve on the weak point of the progressive methods the heavy dependence on the accuracy of the initial Pairwise alignment.
  • 9. 9 Department of Zoology , GACW (2018-2019) Tools in MCA: Clustal W, Clustal W2, Clustal Omega, Kalign, MAFFT, MUSCLE, M View, T- Coffee etc. Applications of MCA:  Detecting similarities between sequences(closely or distinctly related).  Detecting conserved regions or motifs in sequences.  Detecting of structural homologies.  Thus, assisting the improved prediction of secondary and tertiary structures of proteins. References: https://en.wikipedia.org/wiki/Sequence_alignment file:///C:/Users/god/Downloads/sequencealig-170209142647.pdf http://avatar.se/lectures/molbioinfo2001/dynprog/dynamic.html https://www.slideshare.net/RamyaS96/multiple-sequence-alignment-81493182