SlideShare une entreprise Scribd logo
1  sur  27
 Used to find the local similarity or alignment
shared by two sequences.
 Method to find the similarity is called the
alignment. It can be of two types,
 Global alignment – align the entire sequence
using as many characters as possible.
 Local alignment – focuses on region of
similarity in parts of the sequence only
 Alignment of two sequences is performed by
following methods:
 Dot matrix analysis
 Dynamic programming
 Word or k-tuple method (FASTA & BLAST
programs)
 Align two sequences very quickly, first by
searching for identical short stretches of
sequences called word or k –tuple.
 Then by joining these words into an alignment by
dynamic programming method.
 BLAST and FASTA methods are heuristic.
 Basic local alignment search tool (BLAST) is a
popular user friendly tool for searching all the
major sequence databases.
 It is used to find sequence homolog to predict the
identity, function, 3D structure of the query
sequence.
 It shows better results for protein sequences than
nucleotide sequences.
 Local alignment: BLAST tries to find patches of
regional similarity, rather than trying for global
fit between the query and the database sequence.
 BLAST works under the assumption that high-
scoring alignments are likely to contain short
stretches of identical or near identical letters,
called words.
 BLAST is extremely fast, the program can be run
locally or queries can be e-mailed to NCBI
server.
 It does not guarantee to find the best alignment
between query and database, it may miss
matches.
 Its because its strategy is expected to find most
matches, & this way it sacrifices complete
sensitivity thus to gain speed.
 BLAST searches in two phases.
 First, it looks for short subsequences that are
likely to have significant matches.
 Then it tries to extend these matched regions on
both sides in order to obtain maximum sequence
similarity.
 It is a scoring method used in alignment of one
residue against other.
 Margaret dayhoff and her co-workers developed
the first substitution matrix used in comparison
of protein sequences for evolutionary terms.
 These matrices are commonly called as PAM
matrices.
 In contrast to PAM, Steve Henikoff and his
coworkers developed BLOSUM matrices.
Percentacceptedmutation
matrix(PAM)BLOSUM
 PAM matrices are based on global alignment of
closely related proteins.
 Number accompanying PAM refers to
evolutionary distanced. Larger number represent
greater evolutionary distance.
 PAM 250 is widely used.
o BLOSUM matrices are based on local alignments.
o Smaller number corresponds to greater
evolutionary distant sequences.
o BLOSUM 62 is widely used
Pre processing of the query:-
Quickly locate ungapped similarity between query sequence
and sequence from database.
All words of length ‘W’, of the query are compared with
database sequences.
Generation of hits:-
Hit is made with one or several successive pairs of similar
words, and characterised by its positon in each of two
sequences.
All the possible hits between query and database are
calculated
 Extension of the hits:-
every hit is now extended, without gaps, inorder
to determine whether this hits may be part of a larger
segment of similarity.
every extended segment pair that scores the same
or better than S (set as parameter of program) is kept
and called as HSP( high scoring segment pair).
 Standard BLAST are of five types:
 BLASTp
 BLASTn
 BLASTx
 tBLASTn
 tBLASTx
o Other class include:
 MegaBLAST
 PSI BLAST
 PHI BLAST
 BLASTp – this program compares an amino acid
query sequence against a protein sequence database.
 BLASTn – it compares a nucleotide query sequence
against a nucleotide sequence database.
 BLASTx – it searches the six frame translation
products of a nucleotide sequence against a protein
database.
 tBLASTn – it searches a protein sequence against
translated nucleotide sequence in the database.
 tBLASTx – it compares the six frame translations of
a nucleotide query sequence against six frame
translations of database.
 Mega BLAST – it is a program optimized for
aligning long sequences. It can only work with
DNA sequences.
 PSI BLAST – it stands for position specific
iterated BLAST. It is useful for protein similarity
search.
 PHI BLAST – pattern hit initiated BLAST, it can
be used to search for a specific pattern or motif
 It’s a sequence analysis tool, similar to BLAST.
 It was developed by W.R. Pearson and Lipman
and this algorithm can be accessed from EBI site.
 Fast A gives better results for nucleotide
sequences than protein.
 FastP is for protein sequences.
 finds regions of similarity by first breaking the
sequence into short subsequences, then searching
for diagonals with highest density of words that
match.
 The alignment in diagonals is then refined.
 Its fast but is not guaranteed to find the best
alignment, it may miss matches.
 First FASTA prepares a list of words from the pair of
sequences to be matched. Words can be 3-6 nucleotides
or 1or 2 amino acids.
 It uses non overlapping words, it matches the words and
makes a count of it.
 It creates the word diagonal and finds a high scoring
match. The output is labeled as unit1
 Only if score is sizable it proceeds to the second level.
 In the second level, for every best hit of words, it looks
for neighboring approximate hits
 If the score value is good, and prepares a larger dot
matrix diagonal.
 The best score from this second level scoring is
called initin,
 The initin scores are saved for each comparison
of a query sequence with database sequence.
 Different programs in FASTA include
 FASTP (protein sequence).
 TFASTA (compares a query protein sequence to a
DNA sequence database).
 FASTF( compares a set of ordered peptide fragments
obtained from analysis of protein by cleavage and
sequencing of protein bands resolved by
electrophoresis against a protein database).
 TFASTF( compares a set of ordered peptide
fragments against a DNA database).
Blast and fasta

Contenu connexe

Tendances (20)

Clustal W - Multiple Sequence alignment
Clustal W - Multiple Sequence alignment   Clustal W - Multiple Sequence alignment
Clustal W - Multiple Sequence alignment
 
MULTIPLE SEQUENCE ALIGNMENT
MULTIPLE  SEQUENCE  ALIGNMENTMULTIPLE  SEQUENCE  ALIGNMENT
MULTIPLE SEQUENCE ALIGNMENT
 
Structural databases
Structural databases Structural databases
Structural databases
 
Cath
CathCath
Cath
 
Scop database
Scop databaseScop database
Scop database
 
Ddbj
DdbjDdbj
Ddbj
 
European molecular biology laboratory (EMBL)
European molecular biology laboratory (EMBL)European molecular biology laboratory (EMBL)
European molecular biology laboratory (EMBL)
 
sequence alignment
sequence alignmentsequence alignment
sequence alignment
 
BLAST (Basic local alignment search Tool)
BLAST (Basic local alignment search Tool)BLAST (Basic local alignment search Tool)
BLAST (Basic local alignment search Tool)
 
blast bioinformatics
blast bioinformaticsblast bioinformatics
blast bioinformatics
 
Primary and secondary databases ppt by puneet kulyana
Primary and secondary databases ppt by puneet kulyanaPrimary and secondary databases ppt by puneet kulyana
Primary and secondary databases ppt by puneet kulyana
 
Fasta
FastaFasta
Fasta
 
Tools of bioinforformatics by kk
Tools of bioinforformatics by kkTools of bioinforformatics by kk
Tools of bioinforformatics by kk
 
Protein data bank
Protein data bankProtein data bank
Protein data bank
 
Swiss prot database
Swiss prot databaseSwiss prot database
Swiss prot database
 
Tools and database of NCBI
Tools and database of NCBITools and database of NCBI
Tools and database of NCBI
 
Entrez databases
Entrez databasesEntrez databases
Entrez databases
 
Sequence alignment global vs. local
Sequence alignment  global vs. localSequence alignment  global vs. local
Sequence alignment global vs. local
 
Gene bank by kk sahu
Gene bank by kk sahuGene bank by kk sahu
Gene bank by kk sahu
 
Rasmol
RasmolRasmol
Rasmol
 

Similaire à Blast and fasta

BLAST AND FASTA.pptx
BLAST AND FASTA.pptxBLAST AND FASTA.pptx
BLAST AND FASTA.pptxPiyushBehgal1
 
Lecture 5.pptx
Lecture 5.pptxLecture 5.pptx
Lecture 5.pptxericndunek
 
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
 
Sequencealignmentinbioinformatics 100204112518-phpapp02
Sequencealignmentinbioinformatics 100204112518-phpapp02Sequencealignmentinbioinformatics 100204112518-phpapp02
Sequencealignmentinbioinformatics 100204112518-phpapp02PILLAI ASWATHY VISWANATH
 
BLAST AND FASTA.pptx12345789999987544321234
BLAST AND FASTA.pptx12345789999987544321234BLAST AND FASTA.pptx12345789999987544321234
BLAST AND FASTA.pptx12345789999987544321234alizain9604
 
Blast gp assignment
Blast  gp assignmentBlast  gp assignment
Blast gp assignmentbarathvaj
 
Sequence similarity tools.pptx
Sequence similarity tools.pptxSequence similarity tools.pptx
Sequence similarity tools.pptxPagudalaSangeetha
 
Blast bioinformatics
Blast bioinformaticsBlast bioinformatics
Blast bioinformaticsatmapandey
 
BLAST(Basic Local Alignment Tool)
BLAST(Basic Local Alignment Tool)BLAST(Basic Local Alignment Tool)
BLAST(Basic Local Alignment Tool)Sobia
 
FastA HOMOLOGY SEARCH ALGORITHM
FastA HOMOLOGY SEARCH ALGORITHMFastA HOMOLOGY SEARCH ALGORITHM
FastA HOMOLOGY SEARCH ALGORITHMMuunda Mudenda
 
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
 

Similaire à Blast and fasta (20)

BLAST AND FASTA.pptx
BLAST AND FASTA.pptxBLAST AND FASTA.pptx
BLAST AND FASTA.pptx
 
Lecture 5.pptx
Lecture 5.pptxLecture 5.pptx
Lecture 5.pptx
 
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)
 
Sequencealignmentinbioinformatics 100204112518-phpapp02
Sequencealignmentinbioinformatics 100204112518-phpapp02Sequencealignmentinbioinformatics 100204112518-phpapp02
Sequencealignmentinbioinformatics 100204112518-phpapp02
 
BLAST AND FASTA.pptx12345789999987544321234
BLAST AND FASTA.pptx12345789999987544321234BLAST AND FASTA.pptx12345789999987544321234
BLAST AND FASTA.pptx12345789999987544321234
 
Blast gp assignment
Blast  gp assignmentBlast  gp assignment
Blast gp assignment
 
BLAST
BLASTBLAST
BLAST
 
Sequence similarity tools.pptx
Sequence similarity tools.pptxSequence similarity tools.pptx
Sequence similarity tools.pptx
 
Blast bioinformatics
Blast bioinformaticsBlast bioinformatics
Blast bioinformatics
 
Sequence database
Sequence databaseSequence database
Sequence database
 
BLAST(Basic Local Alignment Tool)
BLAST(Basic Local Alignment Tool)BLAST(Basic Local Alignment Tool)
BLAST(Basic Local Alignment Tool)
 
Sequence Alignment
Sequence AlignmentSequence Alignment
Sequence Alignment
 
Bioinformatics
BioinformaticsBioinformatics
Bioinformatics
 
FastA HOMOLOGY SEARCH ALGORITHM
FastA HOMOLOGY SEARCH ALGORITHMFastA HOMOLOGY SEARCH ALGORITHM
FastA HOMOLOGY SEARCH ALGORITHM
 
Blasta
BlastaBlasta
Blasta
 
Blast
BlastBlast
Blast
 
Blast
BlastBlast
Blast
 
Sequence alignment.pptx
Sequence alignment.pptxSequence alignment.pptx
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...
 

Dernier

GBSN - Biochemistry (Unit 1)
GBSN - Biochemistry (Unit 1)GBSN - Biochemistry (Unit 1)
GBSN - Biochemistry (Unit 1)Areesha Ahmad
 
Nanoparticles synthesis and characterization​ ​
Nanoparticles synthesis and characterization​  ​Nanoparticles synthesis and characterization​  ​
Nanoparticles synthesis and characterization​ ​kaibalyasahoo82800
 
fundamental of entomology all in one topics of entomology
fundamental of entomology all in one topics of entomologyfundamental of entomology all in one topics of entomology
fundamental of entomology all in one topics of entomologyDrAnita Sharma
 
GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)Areesha Ahmad
 
Zoology 4th semester series (krishna).pdf
Zoology 4th semester series (krishna).pdfZoology 4th semester series (krishna).pdf
Zoology 4th semester series (krishna).pdfSumit Kumar yadav
 
Botany 4th semester series (krishna).pdf
Botany 4th semester series (krishna).pdfBotany 4th semester series (krishna).pdf
Botany 4th semester series (krishna).pdfSumit Kumar yadav
 
Botany 4th semester file By Sumit Kumar yadav.pdf
Botany 4th semester file By Sumit Kumar yadav.pdfBotany 4th semester file By Sumit Kumar yadav.pdf
Botany 4th semester file By Sumit Kumar yadav.pdfSumit Kumar yadav
 
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
 
❤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
 
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
 
CALL ON ➥8923113531 🔝Call Girls Kesar Bagh Lucknow best Night Fun service 🪡
CALL ON ➥8923113531 🔝Call Girls Kesar Bagh Lucknow best Night Fun service  🪡CALL ON ➥8923113531 🔝Call Girls Kesar Bagh Lucknow best Night Fun service  🪡
CALL ON ➥8923113531 🔝Call Girls Kesar Bagh Lucknow best Night Fun service 🪡anilsa9823
 
VIRUSES structure and classification ppt by Dr.Prince C P
VIRUSES structure and classification ppt by Dr.Prince C PVIRUSES structure and classification ppt by Dr.Prince C P
VIRUSES structure and classification ppt by Dr.Prince C PPRINCE C P
 
Chromatin Structure | EUCHROMATIN | HETEROCHROMATIN
Chromatin Structure | EUCHROMATIN | HETEROCHROMATINChromatin Structure | EUCHROMATIN | HETEROCHROMATIN
Chromatin Structure | EUCHROMATIN | HETEROCHROMATINsankalpkumarsahoo174
 
Recombination DNA Technology (Nucleic Acid Hybridization )
Recombination DNA Technology (Nucleic Acid Hybridization )Recombination DNA Technology (Nucleic Acid Hybridization )
Recombination DNA Technology (Nucleic Acid Hybridization )aarthirajkumar25
 
Unlocking the Potential: Deep dive into ocean of Ceramic Magnets.pptx
Unlocking  the Potential: Deep dive into ocean of Ceramic Magnets.pptxUnlocking  the Potential: Deep dive into ocean of Ceramic Magnets.pptx
Unlocking the Potential: Deep dive into ocean of Ceramic Magnets.pptxanandsmhk
 
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
 
All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...
All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...
All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...Sérgio Sacani
 
Botany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questionsBotany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questionsSumit Kumar yadav
 
Natural Polymer Based Nanomaterials
Natural Polymer Based NanomaterialsNatural Polymer Based Nanomaterials
Natural Polymer Based NanomaterialsAArockiyaNisha
 

Dernier (20)

GBSN - Biochemistry (Unit 1)
GBSN - Biochemistry (Unit 1)GBSN - Biochemistry (Unit 1)
GBSN - Biochemistry (Unit 1)
 
Nanoparticles synthesis and characterization​ ​
Nanoparticles synthesis and characterization​  ​Nanoparticles synthesis and characterization​  ​
Nanoparticles synthesis and characterization​ ​
 
fundamental of entomology all in one topics of entomology
fundamental of entomology all in one topics of entomologyfundamental of entomology all in one topics of entomology
fundamental of entomology all in one topics of entomology
 
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
 
GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)GBSN - Microbiology (Unit 2)
GBSN - Microbiology (Unit 2)
 
Zoology 4th semester series (krishna).pdf
Zoology 4th semester series (krishna).pdfZoology 4th semester series (krishna).pdf
Zoology 4th semester series (krishna).pdf
 
Botany 4th semester series (krishna).pdf
Botany 4th semester series (krishna).pdfBotany 4th semester series (krishna).pdf
Botany 4th semester series (krishna).pdf
 
Botany 4th semester file By Sumit Kumar yadav.pdf
Botany 4th semester file By Sumit Kumar yadav.pdfBotany 4th semester file By Sumit Kumar yadav.pdf
Botany 4th semester file By Sumit Kumar yadav.pdf
 
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
 
❤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 💦✅.
 
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...
 
CALL ON ➥8923113531 🔝Call Girls Kesar Bagh Lucknow best Night Fun service 🪡
CALL ON ➥8923113531 🔝Call Girls Kesar Bagh Lucknow best Night Fun service  🪡CALL ON ➥8923113531 🔝Call Girls Kesar Bagh Lucknow best Night Fun service  🪡
CALL ON ➥8923113531 🔝Call Girls Kesar Bagh Lucknow best Night Fun service 🪡
 
VIRUSES structure and classification ppt by Dr.Prince C P
VIRUSES structure and classification ppt by Dr.Prince C PVIRUSES structure and classification ppt by Dr.Prince C P
VIRUSES structure and classification ppt by Dr.Prince C P
 
Chromatin Structure | EUCHROMATIN | HETEROCHROMATIN
Chromatin Structure | EUCHROMATIN | HETEROCHROMATINChromatin Structure | EUCHROMATIN | HETEROCHROMATIN
Chromatin Structure | EUCHROMATIN | HETEROCHROMATIN
 
Recombination DNA Technology (Nucleic Acid Hybridization )
Recombination DNA Technology (Nucleic Acid Hybridization )Recombination DNA Technology (Nucleic Acid Hybridization )
Recombination DNA Technology (Nucleic Acid Hybridization )
 
Unlocking the Potential: Deep dive into ocean of Ceramic Magnets.pptx
Unlocking  the Potential: Deep dive into ocean of Ceramic Magnets.pptxUnlocking  the Potential: Deep dive into ocean of Ceramic Magnets.pptx
Unlocking the Potential: Deep dive into ocean of Ceramic Magnets.pptx
 
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
 
All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...
All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...
All-domain Anomaly Resolution Office U.S. Department of Defense (U) Case: “Eg...
 
Botany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questionsBotany krishna series 2nd semester Only Mcq type questions
Botany krishna series 2nd semester Only Mcq type questions
 
Natural Polymer Based Nanomaterials
Natural Polymer Based NanomaterialsNatural Polymer Based Nanomaterials
Natural Polymer Based Nanomaterials
 

Blast and fasta

  • 1.
  • 2.  Used to find the local similarity or alignment shared by two sequences.  Method to find the similarity is called the alignment. It can be of two types,  Global alignment – align the entire sequence using as many characters as possible.  Local alignment – focuses on region of similarity in parts of the sequence only
  • 3.
  • 4.  Alignment of two sequences is performed by following methods:  Dot matrix analysis  Dynamic programming  Word or k-tuple method (FASTA & BLAST programs)
  • 5.  Align two sequences very quickly, first by searching for identical short stretches of sequences called word or k –tuple.  Then by joining these words into an alignment by dynamic programming method.  BLAST and FASTA methods are heuristic.
  • 6.
  • 7.  Basic local alignment search tool (BLAST) is a popular user friendly tool for searching all the major sequence databases.  It is used to find sequence homolog to predict the identity, function, 3D structure of the query sequence.  It shows better results for protein sequences than nucleotide sequences.
  • 8.  Local alignment: BLAST tries to find patches of regional similarity, rather than trying for global fit between the query and the database sequence.  BLAST works under the assumption that high- scoring alignments are likely to contain short stretches of identical or near identical letters, called words.
  • 9.  BLAST is extremely fast, the program can be run locally or queries can be e-mailed to NCBI server.  It does not guarantee to find the best alignment between query and database, it may miss matches.  Its because its strategy is expected to find most matches, & this way it sacrifices complete sensitivity thus to gain speed.
  • 10.  BLAST searches in two phases.  First, it looks for short subsequences that are likely to have significant matches.  Then it tries to extend these matched regions on both sides in order to obtain maximum sequence similarity.
  • 11.
  • 12.  It is a scoring method used in alignment of one residue against other.  Margaret dayhoff and her co-workers developed the first substitution matrix used in comparison of protein sequences for evolutionary terms.  These matrices are commonly called as PAM matrices.  In contrast to PAM, Steve Henikoff and his coworkers developed BLOSUM matrices.
  • 13. Percentacceptedmutation matrix(PAM)BLOSUM  PAM matrices are based on global alignment of closely related proteins.  Number accompanying PAM refers to evolutionary distanced. Larger number represent greater evolutionary distance.  PAM 250 is widely used. o BLOSUM matrices are based on local alignments. o Smaller number corresponds to greater evolutionary distant sequences. o BLOSUM 62 is widely used
  • 14. Pre processing of the query:- Quickly locate ungapped similarity between query sequence and sequence from database. All words of length ‘W’, of the query are compared with database sequences. Generation of hits:- Hit is made with one or several successive pairs of similar words, and characterised by its positon in each of two sequences. All the possible hits between query and database are calculated
  • 15.  Extension of the hits:- every hit is now extended, without gaps, inorder to determine whether this hits may be part of a larger segment of similarity. every extended segment pair that scores the same or better than S (set as parameter of program) is kept and called as HSP( high scoring segment pair).
  • 16.
  • 17.  Standard BLAST are of five types:  BLASTp  BLASTn  BLASTx  tBLASTn  tBLASTx o Other class include:  MegaBLAST  PSI BLAST  PHI BLAST
  • 18.  BLASTp – this program compares an amino acid query sequence against a protein sequence database.  BLASTn – it compares a nucleotide query sequence against a nucleotide sequence database.  BLASTx – it searches the six frame translation products of a nucleotide sequence against a protein database.  tBLASTn – it searches a protein sequence against translated nucleotide sequence in the database.  tBLASTx – it compares the six frame translations of a nucleotide query sequence against six frame translations of database.
  • 19.
  • 20.  Mega BLAST – it is a program optimized for aligning long sequences. It can only work with DNA sequences.  PSI BLAST – it stands for position specific iterated BLAST. It is useful for protein similarity search.  PHI BLAST – pattern hit initiated BLAST, it can be used to search for a specific pattern or motif
  • 21.  It’s a sequence analysis tool, similar to BLAST.  It was developed by W.R. Pearson and Lipman and this algorithm can be accessed from EBI site.  Fast A gives better results for nucleotide sequences than protein.  FastP is for protein sequences.
  • 22.  finds regions of similarity by first breaking the sequence into short subsequences, then searching for diagonals with highest density of words that match.  The alignment in diagonals is then refined.  Its fast but is not guaranteed to find the best alignment, it may miss matches.
  • 23.  First FASTA prepares a list of words from the pair of sequences to be matched. Words can be 3-6 nucleotides or 1or 2 amino acids.  It uses non overlapping words, it matches the words and makes a count of it.  It creates the word diagonal and finds a high scoring match. The output is labeled as unit1  Only if score is sizable it proceeds to the second level.  In the second level, for every best hit of words, it looks for neighboring approximate hits  If the score value is good, and prepares a larger dot matrix diagonal.
  • 24.  The best score from this second level scoring is called initin,  The initin scores are saved for each comparison of a query sequence with database sequence.
  • 25.
  • 26.  Different programs in FASTA include  FASTP (protein sequence).  TFASTA (compares a query protein sequence to a DNA sequence database).  FASTF( compares a set of ordered peptide fragments obtained from analysis of protein by cleavage and sequencing of protein bands resolved by electrophoresis against a protein database).  TFASTF( compares a set of ordered peptide fragments against a DNA database).