SlideShare ist ein Scribd-Unternehmen logo
1 von 20
INTRODUCTION TO
HMMER
Biosequence Analysis
Using Profile
Hidden Markov Models

Anaxagoras Fotopoulos | 2014
Course: Algorithms in Molecular Biology
A brief History
Sean Eddy
 HMMER 1.8, the first public release of HMMER, came in April 1995

 “Far too much of HMMER was written in coffee shops, airport lounges, transoceanic flights, and
Graeme Mitchison’s kitchen”
 “If the world worked as I hoped, the combination of the book Biological Sequence Analysis and
the existence of HMMER2 as a widely-used proof of principle should have motivated the
widespread adoption of probabilistic modeling methods for sequence analysis.”
 “BLAST continued to be the most widely used search program. HMMs widely considered as a
mysterious and orthogonal black box.”
 “NCBI, seemed to be slow to adopt or even understand HMM methods. This nagged at me; the
revolution was unfinished!”

 “In 2006 we moved the lab and I decided that we should aim to replace BLAST with an entirely
new generation of software. The result is the HMMER3 project.”
Usage

 HMMER is used to search for homologs of protein or DNA sequences to sequence
databases or to single sequences by comparing a profile-HMM
 Able to make sequence alignments.
 Powerful when the query is an alignment of multiple instances of a sequence family.
 Automated construction and maintenance of large multiple alignment databases. Useful
to organize sequences into evolutionarily related families
 Automated annotation of the domain structure of proteins by searching in protein family
databases such as Pfam and InterPro
How it works

HMMER makes a
profile-HMM from a
multiple sequence
alignment

A query is created
that assigns a positionspecific scoring system
for substitutions,
insertions and
deletions.

HMMER3 uses Forward
scores rather than
Viterbi scores, which
improves sensitivity.
Forward scores are
better for detecting
distant homologs

Sequences that score
significantly better to
the profile-HMM
compared to a null
model are considered
to be homologous
Posterior probabilities
of alignment are
reported, enabling
assessments on a
residue-by-residue
basis.
HMMER3 also makes extensive use of parallel
distribution commands for increasing computational
speed based on a significant acceleration of
the Smith-Waterman algorithm for aligning two
sequences (Farrar M, 2007)
Index of Commands (1/4)

Build models and align sequences (DNA or protein)
hmmbuild

Build a profile HMM from an input multiple alignment.

hmmalign

Make a multiple alignment of many sequences to a common profile
HMM.
Index of Commands (2/4)
Search protein queries to protein databases
phmmer

Search a single protein sequence to a protein sequence database

Like
BLASTP

jackhmmer

Iteratively search a protein sequence to a protein sequence database

Like
PSIBLAST

hmmsearch

Search a protein profile HMM against a protein sequence database.

hmmscan

Search a protein sequence against a protein profile HMM database.

hmmpgmd

Search daemon used for hmmer.org website.
Index of Commands (3/4)

Search DNA queries to DNA databases
nhmmer

Search DNA queries against DNA database

nhmmscan

Search a DNA sequence against a DNA profile HMM
database

Like
BLASTN
Index of Commands (4/4)
alimask

Modify alignment file to mask column ranges.

hmmconvert

Convert profile formats to/from HMMER3 format.

hmmemit

Generate (sample) sequences from a profile HMM.

hmmfetch

Get a profile HMM by name or accession from an HMM database.

hmmpress

Format an HMM database into a binary format for hmmscan

hmmstat

Show summary statistics for each profile in an HMM database

Other Utilities
Basic
Examples
with HMMER

hmmbuild [options] <hmmfile out> <multiple sequence alignment file>

> hmmbuild globins4.hmm tutorial/globins4.sto

Most Used Options
-o <f> Direct the summary output to file <f>, rather
than to stdout.
-O <f> Resave annotated modified source
alignments to a file <f> in Stockholm format.
--amino Specify that all sequences in msafile are
proteins.
--dna Specify that all sequences in msafile are
DNAs.
--rna Specify that all sequences in msafile are RNAs.
--pnone Don’t use any priors. Probability
parameters will simply be the observed frequencies,
after relative sequence weighting.
--plaplace Use a Laplace +1 prior in place of the
default mixture Dirichlet prior.
Basic
Examples
with HMMER

hmmbuild [options] <hmmfile out> <multiple sequence alignment file>

> hmmbuild globins4.hmm tutorial/globins4.sto
Internal Use!
Basic
Examples
with HMMER

hmmsearch [options] <hmmfile> <seqdb>

Search a protein profile HMM
against a protein sequence
database.

> hmmsearch globins4.hmm uniprot sprot.fasta > globins4.out

Keynotes
hmmsearch accepts any FASTA file as target database
input. It also accepts EMBL/UniProt text format
-o <f> Direct the human-readable output to a file <f>
instead of the default stdout.
-A <f> Save a multiple alignment of all significant hits (those
satisfying inclusion thresholds) to the file <f>.
--tblout <f> Save a simple tabular (space-delimited) file
summarizing the per-target output, with one data line per
homologous target sequence found.
--domtblout <f> Save a simple tabular (space-delimited) file
summarizing the per-domain output, with one data line per
homologous domain detected in a query sequence for
each homologous model.

• The most important number here is
the sequence E-value
• The lower the E-value, the more
significant the hit
• if both E-values are significant (<< 1),
the sequence is likely to be
homologous to your query.
• if the full sequence E-value is
significant but the single best domain
E-value is not, the target sequence is
a multidomain remote homolog
Basic
Examples
with HMMER
•

•
•
•

phmmer [options] <seqfile> <seqdb>

search protein sequence(s)
against a protein sequence
database

> phmmer tutorial/HBB HUMAN uniprot sprot.fasta
jackhmmer [options] <seqfile> <seqdb>

Keynotes
phmmer works essentially just like
hmmsearch does, except you
provide a query sequence
instead of a query profile HMM.
The default score matrix is
BLOSUM62
Everything about the output is
essentially as previously
described for hmmsearch
jackhmmer is for searching a
single sequence query iteratively
against a sequence database,
(like PSI-BLAST)

Iterative protein searches

> jackhmmer tutorial/HBB HUMAN uniprot sprot.fasta

• The first round is identical to a phmmer search. All the
matches that pass the inclusion thresholds are put in a
multiple alignment.
• In the second (and subsequent) rounds, a profile is made
from these results, and the database is searched again
with the profile.
• Iterations continue either until no new sequences are
detected or the maximum number of iterations is
reached.
Basic
Examples
with HMMER

jackhmmer [options] <seqfile> <seqdb>

Iterative protein searches

> jackhmmer tutorial/HBB HUMAN uniprot sprot.fasta

• This is telling you that the new
alignment contains 936
sequences, your query plus 935
significant matches.
• For round two, it’s built a new
model from this alignment.
• After round 2, many more globin
sequences have been found
• After round five, the search ends
it reaches the default maximum
of five iterations
Basic
Examples
with HMMER

hmmalign [options] <hmmfile> <seqfile>

Creating multiple alignments

> hmmalign globins4.hmm tutorial/globins45.fasta

A file with 45
unaligned globin
sequences

Posterior Probability
Estimate
Smart(Hmm)er
Create a tiny database
> hmmpress minifam
> hmmscan minifam tutorial/7LESS DROME
> hmmsearch globins4.hmm uniprot sprot.fasta
> cat globins4.hmm | hmmsearch - uniprot sprot.fasta
> cat uniprot sprot.fasta | hmmsearch globins4.hmm -

Identical

> hmmfetch --index Pfam-A.hmm
> cat myqueries.list | hmmfetch -f Pfam.hmm - | hmmsearch - uniprot sprot.fasta
This takes a list of query profile names/accessions in myqueries.list, fetches them
one by one from Pfam, and does an hmmsearch with each of them against
UniProt
Latest Edition
Features
DNA sequence comparison. HMMER now includes tools that are specifically designed for DNA/DNA
comparison: nhmmer and nhmmscan. The most notable improvement over using HMMER3’s tools is the
ability to search long (e.g. chromosome length) target sequences.

More sequence input formats. HMMER now handles a wide variety of input sequence file formats, both
aligned (Stockholm, Aligned FASTA, Clustal, NCBI PSI-BLAST, PHYLIP, Selex, UCSC SAM A2M) and
unaligned (FASTA, EMBL, Genbank), usually with autodetection.
MSV stage of HMMER acceleration pipeline now even faster. Bjarne Knudsen, Chief Scientific Officer
of CLC bio in Denmark, contributed an important optimization of the MSV filter (the first stage in the
accelerated ”filter pipeline”) that increases overall HMMER3 speed by about two-fold. This speed
improvement has no impact on sensitivity.

Web implementation of hmmer
Available Online
phmmer
hmmscan
Hmmsearch
jackhammer

http://hmmer.janelia.org/search/hmmsearch
Advantages/Disadvantages

 The methods are consistent and
therefore highly automatable,
allowing us to make libraries of
hundreds of profile HMMs and
apply them on a very large scale
to whole genome analysis
 HMMER can be used as a search
tool for additional homologues

 One is that HMMs do not capture
any higher-order correlations. An
HMM assumes that the identity of a
particular position is independent
of the identity of all other positions.
 Profile HMMs are often not good
models of structural RNAs, for
instance, because an HMM cannot
describe base pairs.
More Information

http://hmmer.janelia.org

http://cryptogenomicon.org/
Thank you!

Algorithms in Molecular Biology
Information Technologies in Medicine and Biology
Technological Education
Institute of Athens
Department of Biomedical
Engineering

National & Kapodistrian
University of Athens
Department of Informatics
Biomedical Research
Foundation
Academy of Athens

20

Demokritos
National Center
for Scientific Research

Weitere ähnliche Inhalte

Was ist angesagt?

Gene mapping and DNA markers
Gene mapping and DNA markersGene mapping and DNA markers
Gene mapping and DNA markersAFSATH
 
Tertiary structure prediction- MODELLER, RASMOL
Tertiary structure prediction- MODELLER, RASMOLTertiary structure prediction- MODELLER, RASMOL
Tertiary structure prediction- MODELLER, RASMOLkaverinair1
 
Orthologs,Paralogs & Xenologs
 Orthologs,Paralogs & Xenologs  Orthologs,Paralogs & Xenologs
Orthologs,Paralogs & Xenologs OsamaZafar16
 
New generation sequencing equipments
New generation sequencing equipmentsNew generation sequencing equipments
New generation sequencing equipmentsKalaivani P
 
Functional annotation
Functional annotationFunctional annotation
Functional annotationRavi Gandham
 
Blast and fasta
Blast and fastaBlast and fasta
Blast and fastaALLIENU
 
Sequence Alignment In Bioinformatics
Sequence Alignment In BioinformaticsSequence Alignment In Bioinformatics
Sequence Alignment In BioinformaticsNikesh Narayanan
 
In situ hybridization
In situ hybridizationIn situ hybridization
In situ hybridizationneelmanayab
 
Distance based method
Distance based method Distance based method
Distance based method Adhena Lulli
 
Protien Structure Prediction
Protien Structure PredictionProtien Structure Prediction
Protien Structure PredictionSelimReza76
 
Protein structure
Protein structureProtein structure
Protein structurePooja Pawar
 
Mapping Techniques - Fluorescent in situ Hybridization(FISH) and Sequence Tag...
Mapping Techniques - Fluorescent in situ Hybridization(FISH) and Sequence Tag...Mapping Techniques - Fluorescent in situ Hybridization(FISH) and Sequence Tag...
Mapping Techniques - Fluorescent in situ Hybridization(FISH) and Sequence Tag...Girish Kumar K
 
Comparative genomics
Comparative genomicsComparative genomics
Comparative genomicsAthira RG
 
MULTIPLE SEQUENCE ALIGNMENT
MULTIPLE  SEQUENCE  ALIGNMENTMULTIPLE  SEQUENCE  ALIGNMENT
MULTIPLE SEQUENCE ALIGNMENTMariya Raju
 

Was ist angesagt? (20)

OMIM Database
OMIM DatabaseOMIM Database
OMIM Database
 
Genomic databases
Genomic databasesGenomic databases
Genomic databases
 
Gene mapping and DNA markers
Gene mapping and DNA markersGene mapping and DNA markers
Gene mapping and DNA markers
 
Motif andpatterndatabase
Motif andpatterndatabaseMotif andpatterndatabase
Motif andpatterndatabase
 
Tertiary structure prediction- MODELLER, RASMOL
Tertiary structure prediction- MODELLER, RASMOLTertiary structure prediction- MODELLER, RASMOL
Tertiary structure prediction- MODELLER, RASMOL
 
Orthologs,Paralogs & Xenologs
 Orthologs,Paralogs & Xenologs  Orthologs,Paralogs & Xenologs
Orthologs,Paralogs & Xenologs
 
Maximum parsimony
Maximum parsimonyMaximum parsimony
Maximum parsimony
 
New generation sequencing equipments
New generation sequencing equipmentsNew generation sequencing equipments
New generation sequencing equipments
 
Functional annotation
Functional annotationFunctional annotation
Functional annotation
 
Blast and fasta
Blast and fastaBlast and fasta
Blast and fasta
 
Sequence Alignment In Bioinformatics
Sequence Alignment In BioinformaticsSequence Alignment In Bioinformatics
Sequence Alignment In Bioinformatics
 
In situ hybridization
In situ hybridizationIn situ hybridization
In situ hybridization
 
Distance based method
Distance based method Distance based method
Distance based method
 
Protien Structure Prediction
Protien Structure PredictionProtien Structure Prediction
Protien Structure Prediction
 
Cath
CathCath
Cath
 
Protein structure
Protein structureProtein structure
Protein structure
 
Mapping Techniques - Fluorescent in situ Hybridization(FISH) and Sequence Tag...
Mapping Techniques - Fluorescent in situ Hybridization(FISH) and Sequence Tag...Mapping Techniques - Fluorescent in situ Hybridization(FISH) and Sequence Tag...
Mapping Techniques - Fluorescent in situ Hybridization(FISH) and Sequence Tag...
 
Comparative genomics
Comparative genomicsComparative genomics
Comparative genomics
 
Scop database
Scop databaseScop database
Scop database
 
MULTIPLE SEQUENCE ALIGNMENT
MULTIPLE  SEQUENCE  ALIGNMENTMULTIPLE  SEQUENCE  ALIGNMENT
MULTIPLE SEQUENCE ALIGNMENT
 

Ähnlich wie Introduction to HMMER - A biosequence analysis tool with Hidden Markov Models

BC-Cancer ChimeraScan Presentation
BC-Cancer ChimeraScan PresentationBC-Cancer ChimeraScan Presentation
BC-Cancer ChimeraScan PresentationElijah Willie
 
Phylogenetic prediction - maximum parsimony method
Phylogenetic prediction - maximum parsimony methodPhylogenetic prediction - maximum parsimony method
Phylogenetic prediction - maximum parsimony methodAfnan Zuiter
 
Comparison Study of Lossless Data Compression Algorithms for Text Data
Comparison Study of Lossless Data Compression Algorithms for Text DataComparison Study of Lossless Data Compression Algorithms for Text Data
Comparison Study of Lossless Data Compression Algorithms for Text DataIOSR Journals
 
thesis-defense-animation
thesis-defense-animationthesis-defense-animation
thesis-defense-animationMd Pavel Mahmud
 
Bioinformatics_1_ChenS.pptx
Bioinformatics_1_ChenS.pptxBioinformatics_1_ChenS.pptx
Bioinformatics_1_ChenS.pptxxRowlet
 
RNA-seq differential expression analysis
RNA-seq differential expression analysisRNA-seq differential expression analysis
RNA-seq differential expression analysismikaelhuss
 
RSEM and DE packages
RSEM and DE packagesRSEM and DE packages
RSEM and DE packagesRavi Gandham
 
B.sc biochem i bobi u 3.2 algorithm + blast
B.sc biochem i bobi u 3.2 algorithm + blastB.sc biochem i bobi u 3.2 algorithm + blast
B.sc biochem i bobi u 3.2 algorithm + blastRai University
 
B.sc biochem i bobi u 3.2 algorithm + blast
B.sc biochem i bobi u 3.2 algorithm + blastB.sc biochem i bobi u 3.2 algorithm + blast
B.sc biochem i bobi u 3.2 algorithm + blastRai University
 
Meta Machine Learning: Hyperparameter Optimization
Meta Machine Learning: Hyperparameter OptimizationMeta Machine Learning: Hyperparameter Optimization
Meta Machine Learning: Hyperparameter OptimizationPriyatham Bollimpalli
 
Lecture 5.pptx
Lecture 5.pptxLecture 5.pptx
Lecture 5.pptxericndunek
 
XabTracker & SeqAgent: Integrated LIMS & Sequence Analysis Tools for Antibody...
XabTracker & SeqAgent: Integrated LIMS & Sequence Analysis Tools for Antibody...XabTracker & SeqAgent: Integrated LIMS & Sequence Analysis Tools for Antibody...
XabTracker & SeqAgent: Integrated LIMS & Sequence Analysis Tools for Antibody...Mark Evans
 
A file in fasta format is probably the most common way to store sequence info...
A file in fasta format is probably the most common way to store sequence info...A file in fasta format is probably the most common way to store sequence info...
A file in fasta format is probably the most common way to store sequence info...hwbloom42
 
Multiple Sequence Alignment by Shubham Kaushik
Multiple Sequence Alignment by Shubham KaushikMultiple Sequence Alignment by Shubham Kaushik
Multiple Sequence Alignment by Shubham KaushikShubham Kaushik
 

Ähnlich wie Introduction to HMMER - A biosequence analysis tool with Hidden Markov Models (20)

HPC_HMMER.pptx
HPC_HMMER.pptxHPC_HMMER.pptx
HPC_HMMER.pptx
 
JGI_HMMER.pptx
JGI_HMMER.pptxJGI_HMMER.pptx
JGI_HMMER.pptx
 
MAKER2
MAKER2MAKER2
MAKER2
 
BC-Cancer ChimeraScan Presentation
BC-Cancer ChimeraScan PresentationBC-Cancer ChimeraScan Presentation
BC-Cancer ChimeraScan Presentation
 
Phylogenetic prediction - maximum parsimony method
Phylogenetic prediction - maximum parsimony methodPhylogenetic prediction - maximum parsimony method
Phylogenetic prediction - maximum parsimony method
 
Comparison Study of Lossless Data Compression Algorithms for Text Data
Comparison Study of Lossless Data Compression Algorithms for Text DataComparison Study of Lossless Data Compression Algorithms for Text Data
Comparison Study of Lossless Data Compression Algorithms for Text Data
 
thesis-defense-animation
thesis-defense-animationthesis-defense-animation
thesis-defense-animation
 
Example of force fields
Example of force fieldsExample of force fields
Example of force fields
 
Bioinformatics_1_ChenS.pptx
Bioinformatics_1_ChenS.pptxBioinformatics_1_ChenS.pptx
Bioinformatics_1_ChenS.pptx
 
patterndat.pdf
patterndat.pdfpatterndat.pdf
patterndat.pdf
 
RNA-seq differential expression analysis
RNA-seq differential expression analysisRNA-seq differential expression analysis
RNA-seq differential expression analysis
 
RSEM and DE packages
RSEM and DE packagesRSEM and DE packages
RSEM and DE packages
 
50320130403003 2
50320130403003 250320130403003 2
50320130403003 2
 
B.sc biochem i bobi u 3.2 algorithm + blast
B.sc biochem i bobi u 3.2 algorithm + blastB.sc biochem i bobi u 3.2 algorithm + blast
B.sc biochem i bobi u 3.2 algorithm + blast
 
B.sc biochem i bobi u 3.2 algorithm + blast
B.sc biochem i bobi u 3.2 algorithm + blastB.sc biochem i bobi u 3.2 algorithm + blast
B.sc biochem i bobi u 3.2 algorithm + blast
 
Meta Machine Learning: Hyperparameter Optimization
Meta Machine Learning: Hyperparameter OptimizationMeta Machine Learning: Hyperparameter Optimization
Meta Machine Learning: Hyperparameter Optimization
 
Lecture 5.pptx
Lecture 5.pptxLecture 5.pptx
Lecture 5.pptx
 
XabTracker & SeqAgent: Integrated LIMS & Sequence Analysis Tools for Antibody...
XabTracker & SeqAgent: Integrated LIMS & Sequence Analysis Tools for Antibody...XabTracker & SeqAgent: Integrated LIMS & Sequence Analysis Tools for Antibody...
XabTracker & SeqAgent: Integrated LIMS & Sequence Analysis Tools for Antibody...
 
A file in fasta format is probably the most common way to store sequence info...
A file in fasta format is probably the most common way to store sequence info...A file in fasta format is probably the most common way to store sequence info...
A file in fasta format is probably the most common way to store sequence info...
 
Multiple Sequence Alignment by Shubham Kaushik
Multiple Sequence Alignment by Shubham KaushikMultiple Sequence Alignment by Shubham Kaushik
Multiple Sequence Alignment by Shubham Kaushik
 

Mehr von Anax Fotopoulos

Tzitzikosta message for the world heritage monuments exhibition
Tzitzikosta message for the world heritage monuments exhibitionTzitzikosta message for the world heritage monuments exhibition
Tzitzikosta message for the world heritage monuments exhibitionAnax Fotopoulos
 
Acropoils & other hellenic world monuments
Acropoils & other hellenic world monumentsAcropoils & other hellenic world monuments
Acropoils & other hellenic world monumentsAnax Fotopoulos
 
Architecture of the human regulatory network derived from encode data
Architecture of the human regulatory network derived from encode dataArchitecture of the human regulatory network derived from encode data
Architecture of the human regulatory network derived from encode dataAnax Fotopoulos
 
From Smart Homes to Smart Cities: An approach based on Internet-of-Things
From Smart Homes to Smart Cities: An approach based on Internet-of-ThingsFrom Smart Homes to Smart Cities: An approach based on Internet-of-Things
From Smart Homes to Smart Cities: An approach based on Internet-of-ThingsAnax Fotopoulos
 
The social aspect of Smart Wearable Systems in the era of Internet-of-Things
The social aspect of Smart Wearable Systems in the era of Internet-of-ThingsThe social aspect of Smart Wearable Systems in the era of Internet-of-Things
The social aspect of Smart Wearable Systems in the era of Internet-of-ThingsAnax Fotopoulos
 
TIS prediction in human cDNAs with high accuracy
TIS prediction in human cDNAs with high accuracyTIS prediction in human cDNAs with high accuracy
TIS prediction in human cDNAs with high accuracyAnax Fotopoulos
 
Wef the future role of civil society report 2013
Wef the future role of civil society report 2013Wef the future role of civil society report 2013
Wef the future role of civil society report 2013Anax Fotopoulos
 
UNESCO’s Division for Freedom of Expression, Democracy and Peace Report
UNESCO’s Division for Freedom of  Expression, Democracy and Peace ReportUNESCO’s Division for Freedom of  Expression, Democracy and Peace Report
UNESCO’s Division for Freedom of Expression, Democracy and Peace ReportAnax Fotopoulos
 
Europa Nostra Athens Congress - Registration fees
Europa Nostra Athens Congress - Registration feesEuropa Nostra Athens Congress - Registration fees
Europa Nostra Athens Congress - Registration feesAnax Fotopoulos
 
Europa Nostra Congress Athens 2013 - Programme
Europa Nostra Congress Athens 2013 - ProgrammeEuropa Nostra Congress Athens 2013 - Programme
Europa Nostra Congress Athens 2013 - ProgrammeAnax Fotopoulos
 
A new approach in specifying the inverse quadratic matrix in modulo-2 for con...
A new approach in specifying the inverse quadratic matrix in modulo-2 for con...A new approach in specifying the inverse quadratic matrix in modulo-2 for con...
A new approach in specifying the inverse quadratic matrix in modulo-2 for con...Anax Fotopoulos
 
Συστήματα ανίχνευσης εισβολών με νευρωνικά δίκτυα
Συστήματα ανίχνευσης εισβολών με νευρωνικά δίκτυαΣυστήματα ανίχνευσης εισβολών με νευρωνικά δίκτυα
Συστήματα ανίχνευσης εισβολών με νευρωνικά δίκτυαAnax Fotopoulos
 
Introduction to Tempus Programme (5th Call)
Introduction to Tempus Programme (5th Call)Introduction to Tempus Programme (5th Call)
Introduction to Tempus Programme (5th Call)Anax Fotopoulos
 
TEI Piraeus IEEE Student Branch Actions 2011-2012
TEI Piraeus IEEE Student Branch  Actions 2011-2012 TEI Piraeus IEEE Student Branch  Actions 2011-2012
TEI Piraeus IEEE Student Branch Actions 2011-2012 Anax Fotopoulos
 
Η ΣΚΟΤΕΙΝΗ ΠΛΕΥΡΑ ΤΟΥ ΔΙΑΔΙΚΤΥΟΥ - ΠΑΡΟΥΣΙΑΣΗ ΤΩΝ ΠΡΟΒΛΗΜΑΤΩΝ & ΤΩΝ ΜΕΤΡΩΝ Π...
Η ΣΚΟΤΕΙΝΗ ΠΛΕΥΡΑ ΤΟΥ ΔΙΑΔΙΚΤΥΟΥ - ΠΑΡΟΥΣΙΑΣΗ ΤΩΝ ΠΡΟΒΛΗΜΑΤΩΝ &  ΤΩΝ ΜΕΤΡΩΝ Π...Η ΣΚΟΤΕΙΝΗ ΠΛΕΥΡΑ ΤΟΥ ΔΙΑΔΙΚΤΥΟΥ - ΠΑΡΟΥΣΙΑΣΗ ΤΩΝ ΠΡΟΒΛΗΜΑΤΩΝ &  ΤΩΝ ΜΕΤΡΩΝ Π...
Η ΣΚΟΤΕΙΝΗ ΠΛΕΥΡΑ ΤΟΥ ΔΙΑΔΙΚΤΥΟΥ - ΠΑΡΟΥΣΙΑΣΗ ΤΩΝ ΠΡΟΒΛΗΜΑΤΩΝ & ΤΩΝ ΜΕΤΡΩΝ Π...Anax Fotopoulos
 
Measuring the EMF of various widely used electronic devices and their possibl...
Measuring the EMF of various widely used electronic devices and their possibl...Measuring the EMF of various widely used electronic devices and their possibl...
Measuring the EMF of various widely used electronic devices and their possibl...Anax Fotopoulos
 
Eισήγηση στα χαοτικα τεχνητα νευρωνικα δικτυα
Eισήγηση στα χαοτικα τεχνητα νευρωνικα δικτυαEισήγηση στα χαοτικα τεχνητα νευρωνικα δικτυα
Eισήγηση στα χαοτικα τεχνητα νευρωνικα δικτυαAnax Fotopoulos
 

Mehr von Anax Fotopoulos (20)

AFMM Manual
AFMM ManualAFMM Manual
AFMM Manual
 
Tzitzikosta message for the world heritage monuments exhibition
Tzitzikosta message for the world heritage monuments exhibitionTzitzikosta message for the world heritage monuments exhibition
Tzitzikosta message for the world heritage monuments exhibition
 
Acropoils & other hellenic world monuments
Acropoils & other hellenic world monumentsAcropoils & other hellenic world monuments
Acropoils & other hellenic world monuments
 
Architecture of the human regulatory network derived from encode data
Architecture of the human regulatory network derived from encode dataArchitecture of the human regulatory network derived from encode data
Architecture of the human regulatory network derived from encode data
 
Ret protooncogene
Ret protooncogeneRet protooncogene
Ret protooncogene
 
From Smart Homes to Smart Cities: An approach based on Internet-of-Things
From Smart Homes to Smart Cities: An approach based on Internet-of-ThingsFrom Smart Homes to Smart Cities: An approach based on Internet-of-Things
From Smart Homes to Smart Cities: An approach based on Internet-of-Things
 
The social aspect of Smart Wearable Systems in the era of Internet-of-Things
The social aspect of Smart Wearable Systems in the era of Internet-of-ThingsThe social aspect of Smart Wearable Systems in the era of Internet-of-Things
The social aspect of Smart Wearable Systems in the era of Internet-of-Things
 
TIS prediction in human cDNAs with high accuracy
TIS prediction in human cDNAs with high accuracyTIS prediction in human cDNAs with high accuracy
TIS prediction in human cDNAs with high accuracy
 
Wef the future role of civil society report 2013
Wef the future role of civil society report 2013Wef the future role of civil society report 2013
Wef the future role of civil society report 2013
 
UNESCO’s Division for Freedom of Expression, Democracy and Peace Report
UNESCO’s Division for Freedom of  Expression, Democracy and Peace ReportUNESCO’s Division for Freedom of  Expression, Democracy and Peace Report
UNESCO’s Division for Freedom of Expression, Democracy and Peace Report
 
Europa Nostra Athens Congress - Registration fees
Europa Nostra Athens Congress - Registration feesEuropa Nostra Athens Congress - Registration fees
Europa Nostra Athens Congress - Registration fees
 
Europa Nostra Congress Athens 2013 - Programme
Europa Nostra Congress Athens 2013 - ProgrammeEuropa Nostra Congress Athens 2013 - Programme
Europa Nostra Congress Athens 2013 - Programme
 
RMCEF
RMCEFRMCEF
RMCEF
 
A new approach in specifying the inverse quadratic matrix in modulo-2 for con...
A new approach in specifying the inverse quadratic matrix in modulo-2 for con...A new approach in specifying the inverse quadratic matrix in modulo-2 for con...
A new approach in specifying the inverse quadratic matrix in modulo-2 for con...
 
Συστήματα ανίχνευσης εισβολών με νευρωνικά δίκτυα
Συστήματα ανίχνευσης εισβολών με νευρωνικά δίκτυαΣυστήματα ανίχνευσης εισβολών με νευρωνικά δίκτυα
Συστήματα ανίχνευσης εισβολών με νευρωνικά δίκτυα
 
Introduction to Tempus Programme (5th Call)
Introduction to Tempus Programme (5th Call)Introduction to Tempus Programme (5th Call)
Introduction to Tempus Programme (5th Call)
 
TEI Piraeus IEEE Student Branch Actions 2011-2012
TEI Piraeus IEEE Student Branch  Actions 2011-2012 TEI Piraeus IEEE Student Branch  Actions 2011-2012
TEI Piraeus IEEE Student Branch Actions 2011-2012
 
Η ΣΚΟΤΕΙΝΗ ΠΛΕΥΡΑ ΤΟΥ ΔΙΑΔΙΚΤΥΟΥ - ΠΑΡΟΥΣΙΑΣΗ ΤΩΝ ΠΡΟΒΛΗΜΑΤΩΝ & ΤΩΝ ΜΕΤΡΩΝ Π...
Η ΣΚΟΤΕΙΝΗ ΠΛΕΥΡΑ ΤΟΥ ΔΙΑΔΙΚΤΥΟΥ - ΠΑΡΟΥΣΙΑΣΗ ΤΩΝ ΠΡΟΒΛΗΜΑΤΩΝ &  ΤΩΝ ΜΕΤΡΩΝ Π...Η ΣΚΟΤΕΙΝΗ ΠΛΕΥΡΑ ΤΟΥ ΔΙΑΔΙΚΤΥΟΥ - ΠΑΡΟΥΣΙΑΣΗ ΤΩΝ ΠΡΟΒΛΗΜΑΤΩΝ &  ΤΩΝ ΜΕΤΡΩΝ Π...
Η ΣΚΟΤΕΙΝΗ ΠΛΕΥΡΑ ΤΟΥ ΔΙΑΔΙΚΤΥΟΥ - ΠΑΡΟΥΣΙΑΣΗ ΤΩΝ ΠΡΟΒΛΗΜΑΤΩΝ & ΤΩΝ ΜΕΤΡΩΝ Π...
 
Measuring the EMF of various widely used electronic devices and their possibl...
Measuring the EMF of various widely used electronic devices and their possibl...Measuring the EMF of various widely used electronic devices and their possibl...
Measuring the EMF of various widely used electronic devices and their possibl...
 
Eισήγηση στα χαοτικα τεχνητα νευρωνικα δικτυα
Eισήγηση στα χαοτικα τεχνητα νευρωνικα δικτυαEισήγηση στα χαοτικα τεχνητα νευρωνικα δικτυα
Eισήγηση στα χαοτικα τεχνητα νευρωνικα δικτυα
 

Kürzlich hochgeladen

Models Call Girls In Hyderabad 9630942363 Hyderabad Call Girl & Hyderabad Esc...
Models Call Girls In Hyderabad 9630942363 Hyderabad Call Girl & Hyderabad Esc...Models Call Girls In Hyderabad 9630942363 Hyderabad Call Girl & Hyderabad Esc...
Models Call Girls In Hyderabad 9630942363 Hyderabad Call Girl & Hyderabad Esc...GENUINE ESCORT AGENCY
 
Call Girls Kolkata Kalikapur 💯Call Us 🔝 8005736733 🔝 💃 Top Class Call Girl Se...
Call Girls Kolkata Kalikapur 💯Call Us 🔝 8005736733 🔝 💃 Top Class Call Girl Se...Call Girls Kolkata Kalikapur 💯Call Us 🔝 8005736733 🔝 💃 Top Class Call Girl Se...
Call Girls Kolkata Kalikapur 💯Call Us 🔝 8005736733 🔝 💃 Top Class Call Girl Se...Namrata Singh
 
Coimbatore Call Girls in Thudiyalur : 7427069034 High Profile Model Escorts |...
Coimbatore Call Girls in Thudiyalur : 7427069034 High Profile Model Escorts |...Coimbatore Call Girls in Thudiyalur : 7427069034 High Profile Model Escorts |...
Coimbatore Call Girls in Thudiyalur : 7427069034 High Profile Model Escorts |...chennailover
 
Call Girls Hyderabad Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Hyderabad Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Hyderabad Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Hyderabad Just Call 8250077686 Top Class Call Girl Service AvailableDipal Arora
 
Top Rated Pune Call Girls (DIPAL) ⟟ 8250077686 ⟟ Call Me For Genuine Sex Serv...
Top Rated Pune Call Girls (DIPAL) ⟟ 8250077686 ⟟ Call Me For Genuine Sex Serv...Top Rated Pune Call Girls (DIPAL) ⟟ 8250077686 ⟟ Call Me For Genuine Sex Serv...
Top Rated Pune Call Girls (DIPAL) ⟟ 8250077686 ⟟ Call Me For Genuine Sex Serv...Dipal Arora
 
Call Girls Rishikesh Just Call 9667172968 Top Class Call Girl Service Available
Call Girls Rishikesh Just Call 9667172968 Top Class Call Girl Service AvailableCall Girls Rishikesh Just Call 9667172968 Top Class Call Girl Service Available
Call Girls Rishikesh Just Call 9667172968 Top Class Call Girl Service Availableperfect solution
 
Premium Call Girls In Jaipur {8445551418} ❤️VVIP SEEMA Call Girl in Jaipur Ra...
Premium Call Girls In Jaipur {8445551418} ❤️VVIP SEEMA Call Girl in Jaipur Ra...Premium Call Girls In Jaipur {8445551418} ❤️VVIP SEEMA Call Girl in Jaipur Ra...
Premium Call Girls In Jaipur {8445551418} ❤️VVIP SEEMA Call Girl in Jaipur Ra...parulsinha
 
Call Girls Mysore Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Mysore Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Mysore Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Mysore Just Call 8250077686 Top Class Call Girl Service AvailableDipal Arora
 
Top Rated Hyderabad Call Girls Chintal ⟟ 9332606886 ⟟ Call Me For Genuine Se...
Top Rated  Hyderabad Call Girls Chintal ⟟ 9332606886 ⟟ Call Me For Genuine Se...Top Rated  Hyderabad Call Girls Chintal ⟟ 9332606886 ⟟ Call Me For Genuine Se...
Top Rated Hyderabad Call Girls Chintal ⟟ 9332606886 ⟟ Call Me For Genuine Se...chandars293
 
Call Girls Coimbatore Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Coimbatore Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Coimbatore Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Coimbatore Just Call 8250077686 Top Class Call Girl Service AvailableDipal Arora
 
Dehradun Call Girls Service {8854095900} ❤️VVIP ROCKY Call Girl in Dehradun U...
Dehradun Call Girls Service {8854095900} ❤️VVIP ROCKY Call Girl in Dehradun U...Dehradun Call Girls Service {8854095900} ❤️VVIP ROCKY Call Girl in Dehradun U...
Dehradun Call Girls Service {8854095900} ❤️VVIP ROCKY Call Girl in Dehradun U...Sheetaleventcompany
 
Call Girls in Lucknow Just Call 👉👉7877925207 Top Class Call Girl Service Avai...
Call Girls in Lucknow Just Call 👉👉7877925207 Top Class Call Girl Service Avai...Call Girls in Lucknow Just Call 👉👉7877925207 Top Class Call Girl Service Avai...
Call Girls in Lucknow Just Call 👉👉7877925207 Top Class Call Girl Service Avai...adilkhan87451
 
Call Girls Amritsar Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Amritsar Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Amritsar Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Amritsar Just Call 8250077686 Top Class Call Girl Service AvailableDipal Arora
 
Premium Bangalore Call Girls Jigani Dail 6378878445 Escort Service For Hot Ma...
Premium Bangalore Call Girls Jigani Dail 6378878445 Escort Service For Hot Ma...Premium Bangalore Call Girls Jigani Dail 6378878445 Escort Service For Hot Ma...
Premium Bangalore Call Girls Jigani Dail 6378878445 Escort Service For Hot Ma...tanya dube
 
(Low Rate RASHMI ) Rate Of Call Girls Jaipur ❣ 8445551418 ❣ Elite Models & Ce...
(Low Rate RASHMI ) Rate Of Call Girls Jaipur ❣ 8445551418 ❣ Elite Models & Ce...(Low Rate RASHMI ) Rate Of Call Girls Jaipur ❣ 8445551418 ❣ Elite Models & Ce...
(Low Rate RASHMI ) Rate Of Call Girls Jaipur ❣ 8445551418 ❣ Elite Models & Ce...parulsinha
 
Call Girls Mumbai Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Mumbai Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Mumbai Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Mumbai Just Call 8250077686 Top Class Call Girl Service AvailableDipal Arora
 
Call Girls Service Jaipur {8445551418} ❤️VVIP BHAWNA Call Girl in Jaipur Raja...
Call Girls Service Jaipur {8445551418} ❤️VVIP BHAWNA Call Girl in Jaipur Raja...Call Girls Service Jaipur {8445551418} ❤️VVIP BHAWNA Call Girl in Jaipur Raja...
Call Girls Service Jaipur {8445551418} ❤️VVIP BHAWNA Call Girl in Jaipur Raja...parulsinha
 
Andheri East ) Call Girls in Mumbai Phone No 9004268417 Elite Escort Service ...
Andheri East ) Call Girls in Mumbai Phone No 9004268417 Elite Escort Service ...Andheri East ) Call Girls in Mumbai Phone No 9004268417 Elite Escort Service ...
Andheri East ) Call Girls in Mumbai Phone No 9004268417 Elite Escort Service ...Anamika Rawat
 
Call Girl In Pune 👉 Just CALL ME: 9352988975 💋 Call Out Call Both With High p...
Call Girl In Pune 👉 Just CALL ME: 9352988975 💋 Call Out Call Both With High p...Call Girl In Pune 👉 Just CALL ME: 9352988975 💋 Call Out Call Both With High p...
Call Girl In Pune 👉 Just CALL ME: 9352988975 💋 Call Out Call Both With High p...chetankumar9855
 
Russian Call Girls Lucknow Just Call 👉👉7877925207 Top Class Call Girl Service...
Russian Call Girls Lucknow Just Call 👉👉7877925207 Top Class Call Girl Service...Russian Call Girls Lucknow Just Call 👉👉7877925207 Top Class Call Girl Service...
Russian Call Girls Lucknow Just Call 👉👉7877925207 Top Class Call Girl Service...adilkhan87451
 

Kürzlich hochgeladen (20)

Models Call Girls In Hyderabad 9630942363 Hyderabad Call Girl & Hyderabad Esc...
Models Call Girls In Hyderabad 9630942363 Hyderabad Call Girl & Hyderabad Esc...Models Call Girls In Hyderabad 9630942363 Hyderabad Call Girl & Hyderabad Esc...
Models Call Girls In Hyderabad 9630942363 Hyderabad Call Girl & Hyderabad Esc...
 
Call Girls Kolkata Kalikapur 💯Call Us 🔝 8005736733 🔝 💃 Top Class Call Girl Se...
Call Girls Kolkata Kalikapur 💯Call Us 🔝 8005736733 🔝 💃 Top Class Call Girl Se...Call Girls Kolkata Kalikapur 💯Call Us 🔝 8005736733 🔝 💃 Top Class Call Girl Se...
Call Girls Kolkata Kalikapur 💯Call Us 🔝 8005736733 🔝 💃 Top Class Call Girl Se...
 
Coimbatore Call Girls in Thudiyalur : 7427069034 High Profile Model Escorts |...
Coimbatore Call Girls in Thudiyalur : 7427069034 High Profile Model Escorts |...Coimbatore Call Girls in Thudiyalur : 7427069034 High Profile Model Escorts |...
Coimbatore Call Girls in Thudiyalur : 7427069034 High Profile Model Escorts |...
 
Call Girls Hyderabad Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Hyderabad Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Hyderabad Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Hyderabad Just Call 8250077686 Top Class Call Girl Service Available
 
Top Rated Pune Call Girls (DIPAL) ⟟ 8250077686 ⟟ Call Me For Genuine Sex Serv...
Top Rated Pune Call Girls (DIPAL) ⟟ 8250077686 ⟟ Call Me For Genuine Sex Serv...Top Rated Pune Call Girls (DIPAL) ⟟ 8250077686 ⟟ Call Me For Genuine Sex Serv...
Top Rated Pune Call Girls (DIPAL) ⟟ 8250077686 ⟟ Call Me For Genuine Sex Serv...
 
Call Girls Rishikesh Just Call 9667172968 Top Class Call Girl Service Available
Call Girls Rishikesh Just Call 9667172968 Top Class Call Girl Service AvailableCall Girls Rishikesh Just Call 9667172968 Top Class Call Girl Service Available
Call Girls Rishikesh Just Call 9667172968 Top Class Call Girl Service Available
 
Premium Call Girls In Jaipur {8445551418} ❤️VVIP SEEMA Call Girl in Jaipur Ra...
Premium Call Girls In Jaipur {8445551418} ❤️VVIP SEEMA Call Girl in Jaipur Ra...Premium Call Girls In Jaipur {8445551418} ❤️VVIP SEEMA Call Girl in Jaipur Ra...
Premium Call Girls In Jaipur {8445551418} ❤️VVIP SEEMA Call Girl in Jaipur Ra...
 
Call Girls Mysore Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Mysore Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Mysore Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Mysore Just Call 8250077686 Top Class Call Girl Service Available
 
Top Rated Hyderabad Call Girls Chintal ⟟ 9332606886 ⟟ Call Me For Genuine Se...
Top Rated  Hyderabad Call Girls Chintal ⟟ 9332606886 ⟟ Call Me For Genuine Se...Top Rated  Hyderabad Call Girls Chintal ⟟ 9332606886 ⟟ Call Me For Genuine Se...
Top Rated Hyderabad Call Girls Chintal ⟟ 9332606886 ⟟ Call Me For Genuine Se...
 
Call Girls Coimbatore Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Coimbatore Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Coimbatore Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Coimbatore Just Call 8250077686 Top Class Call Girl Service Available
 
Dehradun Call Girls Service {8854095900} ❤️VVIP ROCKY Call Girl in Dehradun U...
Dehradun Call Girls Service {8854095900} ❤️VVIP ROCKY Call Girl in Dehradun U...Dehradun Call Girls Service {8854095900} ❤️VVIP ROCKY Call Girl in Dehradun U...
Dehradun Call Girls Service {8854095900} ❤️VVIP ROCKY Call Girl in Dehradun U...
 
Call Girls in Lucknow Just Call 👉👉7877925207 Top Class Call Girl Service Avai...
Call Girls in Lucknow Just Call 👉👉7877925207 Top Class Call Girl Service Avai...Call Girls in Lucknow Just Call 👉👉7877925207 Top Class Call Girl Service Avai...
Call Girls in Lucknow Just Call 👉👉7877925207 Top Class Call Girl Service Avai...
 
Call Girls Amritsar Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Amritsar Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Amritsar Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Amritsar Just Call 8250077686 Top Class Call Girl Service Available
 
Premium Bangalore Call Girls Jigani Dail 6378878445 Escort Service For Hot Ma...
Premium Bangalore Call Girls Jigani Dail 6378878445 Escort Service For Hot Ma...Premium Bangalore Call Girls Jigani Dail 6378878445 Escort Service For Hot Ma...
Premium Bangalore Call Girls Jigani Dail 6378878445 Escort Service For Hot Ma...
 
(Low Rate RASHMI ) Rate Of Call Girls Jaipur ❣ 8445551418 ❣ Elite Models & Ce...
(Low Rate RASHMI ) Rate Of Call Girls Jaipur ❣ 8445551418 ❣ Elite Models & Ce...(Low Rate RASHMI ) Rate Of Call Girls Jaipur ❣ 8445551418 ❣ Elite Models & Ce...
(Low Rate RASHMI ) Rate Of Call Girls Jaipur ❣ 8445551418 ❣ Elite Models & Ce...
 
Call Girls Mumbai Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Mumbai Just Call 8250077686 Top Class Call Girl Service AvailableCall Girls Mumbai Just Call 8250077686 Top Class Call Girl Service Available
Call Girls Mumbai Just Call 8250077686 Top Class Call Girl Service Available
 
Call Girls Service Jaipur {8445551418} ❤️VVIP BHAWNA Call Girl in Jaipur Raja...
Call Girls Service Jaipur {8445551418} ❤️VVIP BHAWNA Call Girl in Jaipur Raja...Call Girls Service Jaipur {8445551418} ❤️VVIP BHAWNA Call Girl in Jaipur Raja...
Call Girls Service Jaipur {8445551418} ❤️VVIP BHAWNA Call Girl in Jaipur Raja...
 
Andheri East ) Call Girls in Mumbai Phone No 9004268417 Elite Escort Service ...
Andheri East ) Call Girls in Mumbai Phone No 9004268417 Elite Escort Service ...Andheri East ) Call Girls in Mumbai Phone No 9004268417 Elite Escort Service ...
Andheri East ) Call Girls in Mumbai Phone No 9004268417 Elite Escort Service ...
 
Call Girl In Pune 👉 Just CALL ME: 9352988975 💋 Call Out Call Both With High p...
Call Girl In Pune 👉 Just CALL ME: 9352988975 💋 Call Out Call Both With High p...Call Girl In Pune 👉 Just CALL ME: 9352988975 💋 Call Out Call Both With High p...
Call Girl In Pune 👉 Just CALL ME: 9352988975 💋 Call Out Call Both With High p...
 
Russian Call Girls Lucknow Just Call 👉👉7877925207 Top Class Call Girl Service...
Russian Call Girls Lucknow Just Call 👉👉7877925207 Top Class Call Girl Service...Russian Call Girls Lucknow Just Call 👉👉7877925207 Top Class Call Girl Service...
Russian Call Girls Lucknow Just Call 👉👉7877925207 Top Class Call Girl Service...
 

Introduction to HMMER - A biosequence analysis tool with Hidden Markov Models

  • 1. INTRODUCTION TO HMMER Biosequence Analysis Using Profile Hidden Markov Models Anaxagoras Fotopoulos | 2014 Course: Algorithms in Molecular Biology
  • 2. A brief History Sean Eddy  HMMER 1.8, the first public release of HMMER, came in April 1995  “Far too much of HMMER was written in coffee shops, airport lounges, transoceanic flights, and Graeme Mitchison’s kitchen”  “If the world worked as I hoped, the combination of the book Biological Sequence Analysis and the existence of HMMER2 as a widely-used proof of principle should have motivated the widespread adoption of probabilistic modeling methods for sequence analysis.”  “BLAST continued to be the most widely used search program. HMMs widely considered as a mysterious and orthogonal black box.”  “NCBI, seemed to be slow to adopt or even understand HMM methods. This nagged at me; the revolution was unfinished!”  “In 2006 we moved the lab and I decided that we should aim to replace BLAST with an entirely new generation of software. The result is the HMMER3 project.”
  • 3. Usage  HMMER is used to search for homologs of protein or DNA sequences to sequence databases or to single sequences by comparing a profile-HMM  Able to make sequence alignments.  Powerful when the query is an alignment of multiple instances of a sequence family.  Automated construction and maintenance of large multiple alignment databases. Useful to organize sequences into evolutionarily related families  Automated annotation of the domain structure of proteins by searching in protein family databases such as Pfam and InterPro
  • 4. How it works HMMER makes a profile-HMM from a multiple sequence alignment A query is created that assigns a positionspecific scoring system for substitutions, insertions and deletions. HMMER3 uses Forward scores rather than Viterbi scores, which improves sensitivity. Forward scores are better for detecting distant homologs Sequences that score significantly better to the profile-HMM compared to a null model are considered to be homologous Posterior probabilities of alignment are reported, enabling assessments on a residue-by-residue basis. HMMER3 also makes extensive use of parallel distribution commands for increasing computational speed based on a significant acceleration of the Smith-Waterman algorithm for aligning two sequences (Farrar M, 2007)
  • 5. Index of Commands (1/4) Build models and align sequences (DNA or protein) hmmbuild Build a profile HMM from an input multiple alignment. hmmalign Make a multiple alignment of many sequences to a common profile HMM.
  • 6. Index of Commands (2/4) Search protein queries to protein databases phmmer Search a single protein sequence to a protein sequence database Like BLASTP jackhmmer Iteratively search a protein sequence to a protein sequence database Like PSIBLAST hmmsearch Search a protein profile HMM against a protein sequence database. hmmscan Search a protein sequence against a protein profile HMM database. hmmpgmd Search daemon used for hmmer.org website.
  • 7. Index of Commands (3/4) Search DNA queries to DNA databases nhmmer Search DNA queries against DNA database nhmmscan Search a DNA sequence against a DNA profile HMM database Like BLASTN
  • 8. Index of Commands (4/4) alimask Modify alignment file to mask column ranges. hmmconvert Convert profile formats to/from HMMER3 format. hmmemit Generate (sample) sequences from a profile HMM. hmmfetch Get a profile HMM by name or accession from an HMM database. hmmpress Format an HMM database into a binary format for hmmscan hmmstat Show summary statistics for each profile in an HMM database Other Utilities
  • 9. Basic Examples with HMMER hmmbuild [options] <hmmfile out> <multiple sequence alignment file> > hmmbuild globins4.hmm tutorial/globins4.sto Most Used Options -o <f> Direct the summary output to file <f>, rather than to stdout. -O <f> Resave annotated modified source alignments to a file <f> in Stockholm format. --amino Specify that all sequences in msafile are proteins. --dna Specify that all sequences in msafile are DNAs. --rna Specify that all sequences in msafile are RNAs. --pnone Don’t use any priors. Probability parameters will simply be the observed frequencies, after relative sequence weighting. --plaplace Use a Laplace +1 prior in place of the default mixture Dirichlet prior.
  • 10. Basic Examples with HMMER hmmbuild [options] <hmmfile out> <multiple sequence alignment file> > hmmbuild globins4.hmm tutorial/globins4.sto Internal Use!
  • 11. Basic Examples with HMMER hmmsearch [options] <hmmfile> <seqdb> Search a protein profile HMM against a protein sequence database. > hmmsearch globins4.hmm uniprot sprot.fasta > globins4.out Keynotes hmmsearch accepts any FASTA file as target database input. It also accepts EMBL/UniProt text format -o <f> Direct the human-readable output to a file <f> instead of the default stdout. -A <f> Save a multiple alignment of all significant hits (those satisfying inclusion thresholds) to the file <f>. --tblout <f> Save a simple tabular (space-delimited) file summarizing the per-target output, with one data line per homologous target sequence found. --domtblout <f> Save a simple tabular (space-delimited) file summarizing the per-domain output, with one data line per homologous domain detected in a query sequence for each homologous model. • The most important number here is the sequence E-value • The lower the E-value, the more significant the hit • if both E-values are significant (<< 1), the sequence is likely to be homologous to your query. • if the full sequence E-value is significant but the single best domain E-value is not, the target sequence is a multidomain remote homolog
  • 12. Basic Examples with HMMER • • • • phmmer [options] <seqfile> <seqdb> search protein sequence(s) against a protein sequence database > phmmer tutorial/HBB HUMAN uniprot sprot.fasta jackhmmer [options] <seqfile> <seqdb> Keynotes phmmer works essentially just like hmmsearch does, except you provide a query sequence instead of a query profile HMM. The default score matrix is BLOSUM62 Everything about the output is essentially as previously described for hmmsearch jackhmmer is for searching a single sequence query iteratively against a sequence database, (like PSI-BLAST) Iterative protein searches > jackhmmer tutorial/HBB HUMAN uniprot sprot.fasta • The first round is identical to a phmmer search. All the matches that pass the inclusion thresholds are put in a multiple alignment. • In the second (and subsequent) rounds, a profile is made from these results, and the database is searched again with the profile. • Iterations continue either until no new sequences are detected or the maximum number of iterations is reached.
  • 13. Basic Examples with HMMER jackhmmer [options] <seqfile> <seqdb> Iterative protein searches > jackhmmer tutorial/HBB HUMAN uniprot sprot.fasta • This is telling you that the new alignment contains 936 sequences, your query plus 935 significant matches. • For round two, it’s built a new model from this alignment. • After round 2, many more globin sequences have been found • After round five, the search ends it reaches the default maximum of five iterations
  • 14. Basic Examples with HMMER hmmalign [options] <hmmfile> <seqfile> Creating multiple alignments > hmmalign globins4.hmm tutorial/globins45.fasta A file with 45 unaligned globin sequences Posterior Probability Estimate
  • 15. Smart(Hmm)er Create a tiny database > hmmpress minifam > hmmscan minifam tutorial/7LESS DROME > hmmsearch globins4.hmm uniprot sprot.fasta > cat globins4.hmm | hmmsearch - uniprot sprot.fasta > cat uniprot sprot.fasta | hmmsearch globins4.hmm - Identical > hmmfetch --index Pfam-A.hmm > cat myqueries.list | hmmfetch -f Pfam.hmm - | hmmsearch - uniprot sprot.fasta This takes a list of query profile names/accessions in myqueries.list, fetches them one by one from Pfam, and does an hmmsearch with each of them against UniProt
  • 16. Latest Edition Features DNA sequence comparison. HMMER now includes tools that are specifically designed for DNA/DNA comparison: nhmmer and nhmmscan. The most notable improvement over using HMMER3’s tools is the ability to search long (e.g. chromosome length) target sequences. More sequence input formats. HMMER now handles a wide variety of input sequence file formats, both aligned (Stockholm, Aligned FASTA, Clustal, NCBI PSI-BLAST, PHYLIP, Selex, UCSC SAM A2M) and unaligned (FASTA, EMBL, Genbank), usually with autodetection. MSV stage of HMMER acceleration pipeline now even faster. Bjarne Knudsen, Chief Scientific Officer of CLC bio in Denmark, contributed an important optimization of the MSV filter (the first stage in the accelerated ”filter pipeline”) that increases overall HMMER3 speed by about two-fold. This speed improvement has no impact on sensitivity. Web implementation of hmmer
  • 18. Advantages/Disadvantages  The methods are consistent and therefore highly automatable, allowing us to make libraries of hundreds of profile HMMs and apply them on a very large scale to whole genome analysis  HMMER can be used as a search tool for additional homologues  One is that HMMs do not capture any higher-order correlations. An HMM assumes that the identity of a particular position is independent of the identity of all other positions.  Profile HMMs are often not good models of structural RNAs, for instance, because an HMM cannot describe base pairs.
  • 20. Thank you! Algorithms in Molecular Biology Information Technologies in Medicine and Biology Technological Education Institute of Athens Department of Biomedical Engineering National & Kapodistrian University of Athens Department of Informatics Biomedical Research Foundation Academy of Athens 20 Demokritos National Center for Scientific Research