SlideShare a Scribd company logo
1 of 54
Download to read offline
February 4th, 2015
Mariam Quiñones, PhD
Computational Molecular Biology Specialist
Bioinformatics and Computational Biosciences Branch
OCICB/OSMO/OD/NIAID/NIH
BCBB: A Branch Devoted to Bioinformatics and
Computational Biosciences
  Researchers’ time is increasingly important
  BCBB saves our collaborators time and effort
  Researchers speed projects to completion using
BCBB consultation and development services
  No need to hire extra post docs or use external
consultants or developers
What makes us different?
Software DevelopersComputational
Biologists
PMs and Analysts
2
BCBB
  “NIH Users: Access a menu of
BCBB services on the NIAID
Intranet:
•  http://bioinformatics.niaid.nih.gov/
  Outside of NIH –
•  search “BCBB” on the NIAID
Public Internet Page:
www.niaid.nih.gov
  Email us at:
•  ScienceApps@niaid.nih.gov
3
Remember Sanger?
•  Sanger introduced the “dideoxy method” (also known as Sanger
sequencing) in December 1977
Alignment of reads using tools such as ‘Sequencher’
IMAGE: http://www.lifetechnologies.com
4
Understanding file
formats
@F29EPBU01CZU4O
GCTCCGTCGTAAAAGGGG
+
24469:666811//..,,
@F29EPBU01D60ZF
CTCGTTCTTGATTAATGAAACATTCTTGGCAAA
TGCTTTCGCTCTGGTCCGTCTTGCGCCGGTCCA
AGAATTTCACCTCTAGCGGCGCAATACGAATG
CCCAAACACACCCAACACACCA
+
G???HHIIIIIIIIIBG555?
=IIIIIIIIHHGHHIHHHIIIIIIHHHIIHHHIIIIIIIIIH99;;CB
BCCEI???DEIIIIII??;;;IIGDBCEA?
9944215BB@>>@A=BEIEEE
@F29EPBU01EIPCX
TTAATGATTGGAGTCTTGGAAGCTTGACTACCC
TACGTTCTCCTACAAATGGACCTTGAGAGCTTG
TTTGGAGGTTCTAGCAGGGGAGCGCATCTCCC
CAAACACACCCAACACACCA
+
IIIIIIIIIIIIIIIIIIIIIIHHHHIIIIHHHIIIIIIIIIIIIIHHHIIIIIIIIIIIIIIIIIH
HHIIIIIIIIEIIB94422=4GEEEEEIBBBBHHHFIH??
?CII=?AEEEE
@F29EPBU01DER7Q
TGACGTGCAAATCGGTCGTCCGACCTCGGTAT
AGGGGCGAAGACTAATCGAACCATCTAGTAGC
5
File formats for aligned reads
  SAM (sequence alignment map)
CTTGGGCTGCGTCGTGTCTTCGCTTCACACCCGCGACGAGCGCGGCTTCT
CTTGGGCTGCGTCGTGTCTTCGCTTCACACC
Chr_ start end
Chr2 100000 100050
Chr_ start end
Chr2 50000 50050
6
Most commonly used alignment file formats
  SAM (sequence alignment map)
Unified format for storing alignments to a reference genome
  BAM (binary version of SAM) – used commonly to deliver data
Compressed SAM file, is normally indexed
  BED
Commonly used to report features described by chrom, start, end, name,
score, and strand.
For example:
chr1 11873 14409 uc001aaa.3 0 +
7
Variant Analysis – Class Topics
Introduction
Variant calling,
filtering and
annotation
Overview of
downstream
analyses
8
Efforts at creating databases of variants:
•  Project that started on 2002 with the goal of describing patterns of human
genetic variation and create a haplotype map using SNPs present in at
least 1% of the population, which were deposited in dbSNPs.
1000 Genomes
•  Started in 2008 with a goal of using at least 1000 individuals (about
2,500 samples at 4X coverage), interrogate 1000 gene regions in 900
samples (exome analysis), find most genetic variants with allele
frequencies above 1% and to a 0.1% if in coding regions as well as
Indels and structural variants
•  Make data available to the public ftp://ftp-trace.ncbi.nih.gov/1000genomes/ftp/
or via Amazon Cloud http://s3.amazonaws.com/1000genomes
9
Variants are not only found in coding sequences
Main Goal:
•  Find all functional elements in the genome
10
Read
alignment
•  Mapping reads to reference
genome, processing to improve
alignment and mark PCR duplicates
Variant
identification
•  Variant calling and
genotyping
Annotation
and Filtering
•  Removing likely false
positive variants
Visualization
and
downstream
analyses
•  (e.g.
association
studies)
A typical variant calling pipeline
11
Mapping reads to reference
Whole Genome Exome-Seq
  Useful for identifying
SNPs but also structural
variants in any genomic
region.
  Interrogates variants in
specific genomic regions,
usually coding sequences.
  Cheaper and provides high
coverage
Read
alignment
Recommended alignment tools: BWA-MEM, Bowtie2, ssaha2, novoalign.
See more tools:
•  Seq Answers Forum: http://seqanswers.com/wiki/Software/list
12
How to identify structural variants?
http://www.sciencedirect.com/science/article/pii/S0168952511001685
Methods and SV tools
1- Read Pair – use pair ends.
GASVPro (Sindi 2012),
BreakDancer (Chen 2009)
2- Read depth – CNVnator
(Abyzov, 2010)
3- Split read – PinDEL (Ye
2009)
4- Denovo assembly
Learn more:
http://bit.ly/16A8FKR
Also see references:
http://bit.ly/1z7xnol - SV
http://bit.ly/qin294 - CNV
http://bit.ly/rLB7jc
http://bit.ly/17fdZTc
13
Exome-Seq
Targeted exome capture
  targets ~20,000 variants
near coding sequences
and a few rare missense or
loss of function variants
  Provides high depth of
coverage for more accurate
variant calling
  It is starting to be used as a
diagnostic tool
Ann Neurol. 2012 Jan;71(1):5-14.
-Nimblegen
-Agilent
-Illumina
14
Analysis
Workflow 
15
Mapping
subject and
family
sequence
data with
BWA
(paired end)
Variants
called with
SAMtools
Filtering out
common
variants in 1000
genomes (>0.05
allele freq)
500K variants
Annotation
using
ANNOVAR*
576 non-
synonymous
filtered
variants
Visualization
of each gene
Whole-exome sequencing reveals a heterozygous LRP5 mutation in a 6-
year-old boy with vertebral compression fractures and low trabecular bone
density Fahiminiya S, Majewski J, Roughley P, Roschger P, Klaushofer K, Rauch F. Bone: July 23, 2013
*Annovar annotated: the type of mutations, presence in
dbSNP132, minor allele frequency in the 1000 Genomes
project, SIFT, Polyphen-2 and PHASTCONS scores
16
Exome-seq
- Also used for finding somatic mutations
Exome sequencing of serous endometrial tumors identifies recurrent somatic
mutations in chromatin- remodeling and ubiquitin ligase complex genes
VOLUME 44 | NUMBER 12 | DECEMBER 2012 Nature Genetics
Figure 1: Somatic mutations
in CHD4, FBXW7 and SPOP
cluster within important
functional domains of the
encoded proteins.
17
Variant Analysis – Class Topics
Introduction
Variant
calling,
filtering and
annotation
Overview of
downstream
analyses
18
Variant
identification
Goals:
•  Identify variant bases, genotype likelihood and
allele frequency while avoiding instrument noise.
•  Generate an output file in vcf format (variant call
format) with genotypes assigned to each sample
19
Challenges of finding variants using NGS
data
  Base calling errors
•  Different types of errors that vary by technology, sequence
cycle and sequence context
 Low coverage sequencing
•  Lack of sequence from two chromosomes of a diploid
individual at a site
  Inaccurate mapping
•  Aligned reads should be reported with mapping quality score
20
Pre-Processing…
21
Processing reads for Variant Analysis
  Trimming:
•  Unless quality of read data is poor, low quality end trimming of short
reads (e.g. Illumina) prior to mapping is usually not required.
•  If adapters are present in a high number of reads, these could be
trimmed to improve mapping.
–  Recommended tools: Prinseq, Btrim64, FastQC
  Marking duplicates:
•  It is not required to remove duplicate reads prior to mapping but
instead it is recommended to mark duplicates after the alignment.
–  Recommended tool: Picard.
•  A library that is composed mainly of PCR duplicates could produce
inaccurate variant calling.
http://www.biomedcentral.com/1471-2164/13/S8/S8
Clip: http://bestclipartblog.com 22
Picard Tools (integrates with GATK)
AddOrReplaceReadGroups.jar
BamIndexStats.jar
BamToBfq.jar
BuildBamIndex.jar
CalculateHsMetrics.jar
CleanSam.jar
CollectAlignmentSummaryMetrics.jar
CollectCDnaMetrics.jar
CollectGcBiasMetrics.jar
CollectInsertSizeMetrics.jar
CollectMultipleMetrics.jar
CompareSAMs.jar
CreateSequenceDictionary.jar
EstimateLibraryComplexity.jar
ExtractIlluminaBarcodes.jar
ExtractSequences.jar
FastqToSam.jar
FixMateInformation.jar
IlluminaBasecallsToSam.jar
MarkDuplicates.jar
MeanQualityByCycle.jar
MergeBamAlignment.jar
MergeSamFiles.jar
NormalizeFasta.jar
picard-1.45.jar
QualityScoreDistribution.jar
ReorderSam.jar
ReplaceSamHeader.jar
RevertSam.jar
sam-1.45.jar
SamFormatConverter.jar
SamToFastq.jar
SortSam.jar
ValidateSamFile.jar
ViewSam.jar
http://picard.sourceforge.net/command-line-overview.shtml
java -jar QualityScoreDistribution.jar I=file.bam CHART=file.pdf
23
SNP Calling Methods
Early SNP callers and some commercial packages use a simple method
of counting reads for each allele that have passed a mapping quality
threshold. ** This is not good enough in particular when coverage is
low.
It is best to use advanced SNP callers which add more statistics for more
accurate variant calling of low coverage datasets and indels.
-e.g. GATK
24
SNP and Genotype calling
http://bib.oxfordjournals.org/content/early/2013/01/21/bib.bbs086/T1.expansion.html
Germline Variant Callers
Somatic Variant Callers
•  Varscan, MuTEC
Samtools: https://github.com/samtools/bcftools/wiki/HOWTOs 25
VCF format (version 4.0)
  Format used to report information about a position in the genome
  Use by 1000 genomes to report all variants
26
VCF format
http://www.broadinstitute.org/gsa/wiki/index.php/Understanding_the_Unified_Genotyper's_VCF_files
27
GATK pipeline (BROAD) for variant calling
http://www.broadinstitute.org/gatk/guide/topic?name=methods-and-workflows
28
GATK Haplotype Caller shows improvements on detecting
misalignments around gaps and reducing false positives
29
GATK uses a Base Quality Recalibration method
http://www.nature.com/ng/journal/v43/n5/full/ng.806.html
Covariates
•  the raw quality score
•  the position of the base in the read
•  the dinucleotide context and the read group
30
GATK uses a bayesian model
http://www.broadinstitute.org/gatk//events/2038/GATKwh0-BP-5-Variant_calling.pdf
•  It determines possible SNP and indel alleles
•  Computes, for each sample, for each genotype, likelihoods of data given
genotypes
•  Computes the allele frequency distribution to determine most likely allele
count, and emit a variant call if determined
– When it reports a variant, it assign a genotype to each sample
31
From the output of thousands of variants,
which ones should you consider?
  Various important considerations
•  Is the variant call of good quality?
•  If you expect a rare mutation, is the variant
commonly found in the general population?
•  What is the predicted effect of the variant?
–  Non-synonymous
–  Detrimental for function
32
Read
alignment
•  Mapping reads to reference
genome, processing to improve
alignment and mark pcr duplicates
Variant
identification
•  Variant calling and
genotyping
Annotation
and Filtering
•  Removing likely false
positive variants
Visualization
and
downstream
analyses
•  (e.g.
association
studies)
A typical variant calling pipeline
33
Filtering variants
  The initial set of variants is
usually filtered extensively in
hopes of removing false
positives.
  More filtering can include public
data or custom filters based on
in-house data
2 novel in chr10
In house
exome
dbSNPs
1000
genomes
17,687 SNPs
PLoS One. 2012;7(1):e29708 34
Removing the common and low frequency to get
the novel SNPs
http://www.cardiovasculairegeneeskunde.nl/bestanden/Kathiresan.pdf
35
Filtering variants
  The initial set of variants is usually filtered extensively
in hopes of removing false positives.
  More filtering can include public data or custom filters
based on in-house data
  Most exome studies will then filter common variants
(>1%) such as those in dbSNP database
–  Good tools for filtering and annotation: Annovar, SNPeff
–  Reports genes at or near variants as well as the type (non-
synonymous coding, UTR, splicing, etc.)
36
Filtering variants
  The initial set of variants is usually filtered extensively in
hopes of removing false positives.
  More filtering can include public data or custom filters
based on in-house data
  Most exome studies will then filter common variants (>1%)
such as those in dbSNP database
–  Good tools for filtering and annotation: Annovar, SNPeff
–  Reports genes at or near variants as well as the type (non-
synonymous coding, UTR, splicing, etc.)
  To filter by variant consequence, use SIFT and Polyphen2.
These are available via Annovar or ENSEMBL VEP
http://www.ensembl.org/Homo_sapiens/Tools/VEP
  For a more flexible annotation workflow, explore GEMINI
http://gemini.readthedocs.org/en/latest/
37
Evaluating Variant Consequence
SIFT predictions - SIFT predicts whether an amino acid substitution affects
protein function based on sequence homology and the physical properties of
amino acids.
PolyPhen predictions - PolyPhen is a tool which predicts possible impact of
an amino acid substitution on the structure and function of a human protein
using straightforward physical and comparative considerations.
Condel consensus predictions - Condel computes a weighed average of the
scores (WAS) of several computational tools aimed at classifying missense
mutations as likely deleterious or likely neutral. The VEP currently presents a
Condel WAS from SIFT and PolyPhen.
38
Read
alignment
•  Mapping reads to reference
genome, processing to improve
alignment and mark pcr duplicates
Variant
identification
•  Variant calling and
genotyping
Annotation
and Filtering
•  Removing likely false
positive variants
Visualization
and
downstream
analyses
•  (e.g.
association
studies)
A typical variant calling pipeline
39
Viewing reads in browser
  If your genome is available via the UCSC genome
browser http://genome.ucsc.edu/, import bam format
file to the UCSC genome browser by hosting the file on
a server and providing the link.
  If your genome is not in UCSC, use another browser
such as IGV http://www.broadinstitute.org/igv/ , or IGB
http://bioviz.org/igb/
•  Import genome (fasta)
•  Import annotations (gff3 or bed format)
•  Import data (bam)
40
Variant Analysis – Class Topics
Introduction
Variant
calling,
filtering and
annotation
Overview of
downstream
analyses
41
Before exome-seq there was GWAS
GWAS – Genome wide association study
  Examination of common genetic variants in individuals
and their association with a trait
  Analysis is usually association to disease (Case/control)
Genome-wide association
study of systemic sclerosis
identifies CD247 as a new
susceptibility locus
Nature Genetics 42, 426–429
(2010)
Manhatan Plot – each
dot is a SNP, Y-axis
shows association level
42
GWAS Association studies
  A typical analysis:
•  Identify SNPs
where one allele
is significantly
more common in
cases than
controls
•  Hardy-Weinberg
Chi Square
http://en.wikipedia.org/wiki/Genome-wide_association_study 43
Analysis Tools for genotype-phenotype association
from sequencing data
  Plink-seq - http://atgu.mgh.harvard.edu/plinkseq/
  EPACTS - http://genome.sph.umich.edu/wiki/EPACTS
  SNPTestv2 / GRANVIL - http://www.well.ox.ac.uk/GRANVIL/
44
Consider a more integrative
approach, which could
include adding more SNP or
exome data, biological
function, pedigree, gene
exprssion network and more.
Science 2002 Oltvai et al., pp. 763 - 764
45
A more integrative approach
http://www.genome.gov/Multimedia/
Slides/SequenceVariants2012/
Day2_IntegratedApproachWG.pdf
PLoS Genet. 2011 Jan
13;7(1):e1001273
46
Pathways Analysis
With pathways analysis
we can study:
• How genes and
molecules communicate
• The effect of a
disruption to a pathway
in relation to the
associated phenotype or
disease
• Which pathways are
likely to be affected an
affected individual
0 1 2 3 4 5
Reference
Test sample1
Test sample2
DNA damage Apoptosis
Interferon signalling
Enrichment and Network
47
Networks Analysis
  Encore: Genetic Association Interaction Network Centrality Pipeline
and Application to SLE Exome Data
Nicholas A. Davis1,†,‡, Caleb A. Lareau2,3,‡, Bill C. White1, Ahwan Pandey1, Graham Wiley3,
Courtney G. Montgomery3, Patrick M. Gaffney3, B. A. McKinney1,2,*
Article first published online: 5 JUN 2013
•  open source network analysis pipeline for genome-wide association
studies and rare variant data
48
Visualization
  Browsers
•  IGV - http://www.broadinstitute.org/igv/ - see slide 31
•  UCSC Genome browser - http://genome.ucsc.edu/
  Other
•  Cytoscape – can be used for example to visualize
variants in the context of affected genes
49
Other applications of variant calling in
Deep Sequence: Virus evolution
Deep Sequencing detects early variants in HIV evolution
http://www.broadinstitute.org/scientific-community/science/projects/viral-genomics/v-phaser
http://www.plospathogens.org/article/info%3Adoi%2F10.1371%2Fjournal.ppat.1002529 50
Quasispecies evolution
Whole Genome Deep
Sequencing of HIV-1 Reveals
the Impact of Early Minor
Variants Upon Immune
Recognition During Acute
Infection
  They concluded that the early
control of HIV-1 replication by
immunodominant CD8+ T cell
responses may be substantially
influenced by rapid, low
frequency viral adaptations not
detected by conventional
sequencing approaches, which
warrants further investigation.
http://www.plospathogens.org/article/info%3Adoi%2F10.1371%2Fjournal.ppat.1002529
51
Other applications of variant calling in
Deep Sequence: Fast genotyping
Outbreak investigation using high-throughput genome sequencing
within a diagnostic microbiology laboratory. J Clin Microbiol. 2013 Feb 13
Ion
Torrent
was used!
52
Links for variant calling and filtering tools
  Variant Annotation
-  Annovar http://www.openbioinformatics.org/annovar/
-  snpEff http://snpeff.sourceforge.net
-  SeattleSeq Annotation
http://snp.gs.washington.edu/SeattleSeqAnnotation137/
  Variant Consequence
-  SIFT: http://sift.jcvi.org/
-  Polyphen-2: http://genetics.bwh.harvard.edu/pph2/
  Multiple tools for VCF file manipulation, variant calling,
phenotype association
- Galaxy - https://main.g2.bx.psu.edu/root
53
Thank You
Question or Comments please contact:
quinonesm@niaid.nih.gov
ScienceApps@niaid.nih.gov
54

More Related Content

What's hot

Introduction to RNA-seq and RNA-seq Data Analysis (UEB-UAT Bioinformatics Cou...
Introduction to RNA-seq and RNA-seq Data Analysis (UEB-UAT Bioinformatics Cou...Introduction to RNA-seq and RNA-seq Data Analysis (UEB-UAT Bioinformatics Cou...
Introduction to RNA-seq and RNA-seq Data Analysis (UEB-UAT Bioinformatics Cou...VHIR Vall d’Hebron Institut de Recerca
 
NGS Data Preprocessing
NGS Data PreprocessingNGS Data Preprocessing
NGS Data PreprocessingcursoNGS
 
Third Generation Sequencing
Third Generation Sequencing Third Generation Sequencing
Third Generation Sequencing priyanka raviraj
 
BITS: Basics of Sequence similarity
BITS: Basics of Sequence similarityBITS: Basics of Sequence similarity
BITS: Basics of Sequence similarityBITS
 
RNA-seq Data Analysis Overview
RNA-seq Data Analysis OverviewRNA-seq Data Analysis Overview
RNA-seq Data Analysis OverviewSean Davis
 
Comparative transcriptomics
Comparative transcriptomicsComparative transcriptomics
Comparative transcriptomicsSayak Ghosh
 
De novo genome assembly - T.Seemann - IMB winter school 2016 - brisbane, au ...
De novo genome assembly  - T.Seemann - IMB winter school 2016 - brisbane, au ...De novo genome assembly  - T.Seemann - IMB winter school 2016 - brisbane, au ...
De novo genome assembly - T.Seemann - IMB winter school 2016 - brisbane, au ...Torsten Seemann
 
Distance based method
Distance based method Distance based method
Distance based method Adhena Lulli
 
Introduction to NGS Variant Calling Analysis (UEB-UAT Bioinformatics Course -...
Introduction to NGS Variant Calling Analysis (UEB-UAT Bioinformatics Course -...Introduction to NGS Variant Calling Analysis (UEB-UAT Bioinformatics Course -...
Introduction to NGS Variant Calling Analysis (UEB-UAT Bioinformatics Course -...VHIR Vall d’Hebron Institut de Recerca
 
Expressed sequence tag (EST), molecular marker
Expressed sequence tag (EST), molecular markerExpressed sequence tag (EST), molecular marker
Expressed sequence tag (EST), molecular markerKAUSHAL SAHU
 
Next Generation Sequencing
Next Generation SequencingNext Generation Sequencing
Next Generation SequencingSajad Rafatiyan
 

What's hot (20)

Introduction to RNA-seq and RNA-seq Data Analysis (UEB-UAT Bioinformatics Cou...
Introduction to RNA-seq and RNA-seq Data Analysis (UEB-UAT Bioinformatics Cou...Introduction to RNA-seq and RNA-seq Data Analysis (UEB-UAT Bioinformatics Cou...
Introduction to RNA-seq and RNA-seq Data Analysis (UEB-UAT Bioinformatics Cou...
 
Genome analysis2
Genome analysis2Genome analysis2
Genome analysis2
 
Genome Assembly
Genome AssemblyGenome Assembly
Genome Assembly
 
Exome Sequencing
Exome SequencingExome Sequencing
Exome Sequencing
 
Introduction to next generation sequencing
Introduction to next generation sequencingIntroduction to next generation sequencing
Introduction to next generation sequencing
 
NGS Data Preprocessing
NGS Data PreprocessingNGS Data Preprocessing
NGS Data Preprocessing
 
Gemome annotation
Gemome annotationGemome annotation
Gemome annotation
 
Genome Assembly 2018
Genome Assembly 2018Genome Assembly 2018
Genome Assembly 2018
 
Third Generation Sequencing
Third Generation Sequencing Third Generation Sequencing
Third Generation Sequencing
 
BITS: Basics of Sequence similarity
BITS: Basics of Sequence similarityBITS: Basics of Sequence similarity
BITS: Basics of Sequence similarity
 
Introduction to databases.pptx
Introduction to databases.pptxIntroduction to databases.pptx
Introduction to databases.pptx
 
RNA-seq Data Analysis Overview
RNA-seq Data Analysis OverviewRNA-seq Data Analysis Overview
RNA-seq Data Analysis Overview
 
Comparative transcriptomics
Comparative transcriptomicsComparative transcriptomics
Comparative transcriptomics
 
NGS: Mapping and de novo assembly
NGS: Mapping and de novo assemblyNGS: Mapping and de novo assembly
NGS: Mapping and de novo assembly
 
Network components and biological network construction methods
Network components and biological network construction methodsNetwork components and biological network construction methods
Network components and biological network construction methods
 
De novo genome assembly - T.Seemann - IMB winter school 2016 - brisbane, au ...
De novo genome assembly  - T.Seemann - IMB winter school 2016 - brisbane, au ...De novo genome assembly  - T.Seemann - IMB winter school 2016 - brisbane, au ...
De novo genome assembly - T.Seemann - IMB winter school 2016 - brisbane, au ...
 
Distance based method
Distance based method Distance based method
Distance based method
 
Introduction to NGS Variant Calling Analysis (UEB-UAT Bioinformatics Course -...
Introduction to NGS Variant Calling Analysis (UEB-UAT Bioinformatics Course -...Introduction to NGS Variant Calling Analysis (UEB-UAT Bioinformatics Course -...
Introduction to NGS Variant Calling Analysis (UEB-UAT Bioinformatics Course -...
 
Expressed sequence tag (EST), molecular marker
Expressed sequence tag (EST), molecular markerExpressed sequence tag (EST), molecular marker
Expressed sequence tag (EST), molecular marker
 
Next Generation Sequencing
Next Generation SequencingNext Generation Sequencing
Next Generation Sequencing
 

Similar to Variant analysis and whole exome sequencing

Genome in a Bottle - Towards new benchmarks for the “dark matter” of the huma...
Genome in a Bottle - Towards new benchmarks for the “dark matter” of the huma...Genome in a Bottle - Towards new benchmarks for the “dark matter” of the huma...
Genome in a Bottle - Towards new benchmarks for the “dark matter” of the huma...GenomeInABottle
 
Giab for jax long read 190917
Giab for jax long read 190917Giab for jax long read 190917
Giab for jax long read 190917GenomeInABottle
 
Development of FDA MicroDB: A Regulatory-Grade Microbial Reference Database
Development of FDA MicroDB: A Regulatory-Grade Microbial Reference DatabaseDevelopment of FDA MicroDB: A Regulatory-Grade Microbial Reference Database
Development of FDA MicroDB: A Regulatory-Grade Microbial Reference Databasenist-spin
 
Giab jan2016 intro and update 160128
Giab jan2016 intro and update 160128Giab jan2016 intro and update 160128
Giab jan2016 intro and update 160128GenomeInABottle
 
Development of FDA MicroDB: A Regulatory-Grade Microbial Reference Database
Development of FDA MicroDB: A Regulatory-Grade Microbial Reference DatabaseDevelopment of FDA MicroDB: A Regulatory-Grade Microbial Reference Database
Development of FDA MicroDB: A Regulatory-Grade Microbial Reference DatabaseNathan Olson
 
171017 giab for giab grc workshop
171017 giab for giab grc workshop171017 giab for giab grc workshop
171017 giab for giab grc workshopGenomeInABottle
 
VarSeq 2.4.0: VSClinical ACMG Workflow from the User Perspective
VarSeq 2.4.0: VSClinical ACMG Workflow from the User PerspectiveVarSeq 2.4.0: VSClinical ACMG Workflow from the User Perspective
VarSeq 2.4.0: VSClinical ACMG Workflow from the User PerspectiveGolden Helix
 
VarSeq 2.4.0: VSClinical ACMG Workflow from the User Perspective
VarSeq 2.4.0: VSClinical ACMG Workflow from the User PerspectiveVarSeq 2.4.0: VSClinical ACMG Workflow from the User Perspective
VarSeq 2.4.0: VSClinical ACMG Workflow from the User PerspectiveGolden Helix
 
GIAB for AMP GeT-RM Forum
GIAB for AMP GeT-RM ForumGIAB for AMP GeT-RM Forum
GIAB for AMP GeT-RM ForumGenomeInABottle
 
GIAB Benchmarks for SVs and Repeats for stanford genetics sv 200511
GIAB Benchmarks for SVs and Repeats for stanford genetics sv 200511GIAB Benchmarks for SVs and Repeats for stanford genetics sv 200511
GIAB Benchmarks for SVs and Repeats for stanford genetics sv 200511GenomeInABottle
 
Databases_CSS2.pptx
Databases_CSS2.pptxDatabases_CSS2.pptx
Databases_CSS2.pptxSilpa87
 
Advanced Bioinformatics for Genomics and BioData Driven Research
Advanced Bioinformatics for Genomics and BioData Driven ResearchAdvanced Bioinformatics for Genomics and BioData Driven Research
Advanced Bioinformatics for Genomics and BioData Driven ResearchEuropean Bioinformatics Institute
 
Review of Liao et al - A draft human pangenome reference - Nature (2023)
Review of Liao et al - A draft human pangenome reference - Nature (2023)Review of Liao et al - A draft human pangenome reference - Nature (2023)
Review of Liao et al - A draft human pangenome reference - Nature (2023)Stuart MacGowan
 
Overview of the commonly used sequencing platforms, bioinformatic search tool...
Overview of the commonly used sequencing platforms, bioinformatic search tool...Overview of the commonly used sequencing platforms, bioinformatic search tool...
Overview of the commonly used sequencing platforms, bioinformatic search tool...OECD Environment
 
An introduction to Web Apollo for the Biomphalaria glabatra research community.
An introduction to Web Apollo for the Biomphalaria glabatra research community.An introduction to Web Apollo for the Biomphalaria glabatra research community.
An introduction to Web Apollo for the Biomphalaria glabatra research community.Monica Munoz-Torres
 
Role of bioinformatics in life sciences research
Role of bioinformatics in life sciences researchRole of bioinformatics in life sciences research
Role of bioinformatics in life sciences researchAnshika Bansal
 

Similar to Variant analysis and whole exome sequencing (20)

Genome in a Bottle - Towards new benchmarks for the “dark matter” of the huma...
Genome in a Bottle - Towards new benchmarks for the “dark matter” of the huma...Genome in a Bottle - Towards new benchmarks for the “dark matter” of the huma...
Genome in a Bottle - Towards new benchmarks for the “dark matter” of the huma...
 
Giab for jax long read 190917
Giab for jax long read 190917Giab for jax long read 190917
Giab for jax long read 190917
 
Development of FDA MicroDB: A Regulatory-Grade Microbial Reference Database
Development of FDA MicroDB: A Regulatory-Grade Microbial Reference DatabaseDevelopment of FDA MicroDB: A Regulatory-Grade Microbial Reference Database
Development of FDA MicroDB: A Regulatory-Grade Microbial Reference Database
 
Giab jan2016 intro and update 160128
Giab jan2016 intro and update 160128Giab jan2016 intro and update 160128
Giab jan2016 intro and update 160128
 
Development of FDA MicroDB: A Regulatory-Grade Microbial Reference Database
Development of FDA MicroDB: A Regulatory-Grade Microbial Reference DatabaseDevelopment of FDA MicroDB: A Regulatory-Grade Microbial Reference Database
Development of FDA MicroDB: A Regulatory-Grade Microbial Reference Database
 
Introduction to Apollo for i5k
Introduction to Apollo for i5kIntroduction to Apollo for i5k
Introduction to Apollo for i5k
 
171017 giab for giab grc workshop
171017 giab for giab grc workshop171017 giab for giab grc workshop
171017 giab for giab grc workshop
 
VarSeq 2.4.0: VSClinical ACMG Workflow from the User Perspective
VarSeq 2.4.0: VSClinical ACMG Workflow from the User PerspectiveVarSeq 2.4.0: VSClinical ACMG Workflow from the User Perspective
VarSeq 2.4.0: VSClinical ACMG Workflow from the User Perspective
 
VarSeq 2.4.0: VSClinical ACMG Workflow from the User Perspective
VarSeq 2.4.0: VSClinical ACMG Workflow from the User PerspectiveVarSeq 2.4.0: VSClinical ACMG Workflow from the User Perspective
VarSeq 2.4.0: VSClinical ACMG Workflow from the User Perspective
 
171017 giab for giab grc workshop
171017 giab for giab grc workshop171017 giab for giab grc workshop
171017 giab for giab grc workshop
 
GIAB for AMP GeT-RM Forum
GIAB for AMP GeT-RM ForumGIAB for AMP GeT-RM Forum
GIAB for AMP GeT-RM Forum
 
GIAB Benchmarks for SVs and Repeats for stanford genetics sv 200511
GIAB Benchmarks for SVs and Repeats for stanford genetics sv 200511GIAB Benchmarks for SVs and Repeats for stanford genetics sv 200511
GIAB Benchmarks for SVs and Repeats for stanford genetics sv 200511
 
Introduction to 16S Microbiome Analysis
Introduction to 16S Microbiome AnalysisIntroduction to 16S Microbiome Analysis
Introduction to 16S Microbiome Analysis
 
Databases_CSS2.pptx
Databases_CSS2.pptxDatabases_CSS2.pptx
Databases_CSS2.pptx
 
Intro to databases
Intro to databasesIntro to databases
Intro to databases
 
Advanced Bioinformatics for Genomics and BioData Driven Research
Advanced Bioinformatics for Genomics and BioData Driven ResearchAdvanced Bioinformatics for Genomics and BioData Driven Research
Advanced Bioinformatics for Genomics and BioData Driven Research
 
Review of Liao et al - A draft human pangenome reference - Nature (2023)
Review of Liao et al - A draft human pangenome reference - Nature (2023)Review of Liao et al - A draft human pangenome reference - Nature (2023)
Review of Liao et al - A draft human pangenome reference - Nature (2023)
 
Overview of the commonly used sequencing platforms, bioinformatic search tool...
Overview of the commonly used sequencing platforms, bioinformatic search tool...Overview of the commonly used sequencing platforms, bioinformatic search tool...
Overview of the commonly used sequencing platforms, bioinformatic search tool...
 
An introduction to Web Apollo for the Biomphalaria glabatra research community.
An introduction to Web Apollo for the Biomphalaria glabatra research community.An introduction to Web Apollo for the Biomphalaria glabatra research community.
An introduction to Web Apollo for the Biomphalaria glabatra research community.
 
Role of bioinformatics in life sciences research
Role of bioinformatics in life sciences researchRole of bioinformatics in life sciences research
Role of bioinformatics in life sciences research
 

More from Bioinformatics and Computational Biosciences Branch

More from Bioinformatics and Computational Biosciences Branch (20)

Hong_Celine_ES_workshop.pptx
Hong_Celine_ES_workshop.pptxHong_Celine_ES_workshop.pptx
Hong_Celine_ES_workshop.pptx
 
Virus Sequence Alignment and Phylogenetic Analysis 2019
Virus Sequence Alignment and Phylogenetic Analysis 2019Virus Sequence Alignment and Phylogenetic Analysis 2019
Virus Sequence Alignment and Phylogenetic Analysis 2019
 
Nephele 2.0: How to get the most out of your Nephele results
Nephele 2.0: How to get the most out of your Nephele resultsNephele 2.0: How to get the most out of your Nephele results
Nephele 2.0: How to get the most out of your Nephele results
 
Introduction to METAGENOTE
Introduction to METAGENOTE Introduction to METAGENOTE
Introduction to METAGENOTE
 
Intro to homology modeling
Intro to homology modelingIntro to homology modeling
Intro to homology modeling
 
Protein fold recognition and ab_initio modeling
Protein fold recognition and ab_initio modelingProtein fold recognition and ab_initio modeling
Protein fold recognition and ab_initio modeling
 
Homology modeling: Modeller
Homology modeling: ModellerHomology modeling: Modeller
Homology modeling: Modeller
 
Protein docking
Protein dockingProtein docking
Protein docking
 
Protein function prediction
Protein function predictionProtein function prediction
Protein function prediction
 
Protein structure prediction with a focus on Rosetta
Protein structure prediction with a focus on RosettaProtein structure prediction with a focus on Rosetta
Protein structure prediction with a focus on Rosetta
 
Biological networks
Biological networksBiological networks
Biological networks
 
UNIX Basics and Cluster Computing
UNIX Basics and Cluster ComputingUNIX Basics and Cluster Computing
UNIX Basics and Cluster Computing
 
Statistical applications in GraphPad Prism
Statistical applications in GraphPad PrismStatistical applications in GraphPad Prism
Statistical applications in GraphPad Prism
 
Intro to JMP for statistics
Intro to JMP for statisticsIntro to JMP for statistics
Intro to JMP for statistics
 
Categorical models
Categorical modelsCategorical models
Categorical models
 
Better graphics in R
Better graphics in RBetter graphics in R
Better graphics in R
 
Automating biostatistics workflows using R-based webtools
Automating biostatistics workflows using R-based webtoolsAutomating biostatistics workflows using R-based webtools
Automating biostatistics workflows using R-based webtools
 
Overview of statistical tests: Data handling and data quality (Part II)
Overview of statistical tests: Data handling and data quality (Part II)Overview of statistical tests: Data handling and data quality (Part II)
Overview of statistical tests: Data handling and data quality (Part II)
 
Overview of statistics: Statistical testing (Part I)
Overview of statistics: Statistical testing (Part I)Overview of statistics: Statistical testing (Part I)
Overview of statistics: Statistical testing (Part I)
 
GraphPad Prism: Curve fitting
GraphPad Prism: Curve fittingGraphPad Prism: Curve fitting
GraphPad Prism: Curve fitting
 

Recently uploaded

Erythropoiesis- Dr.E. Muralinath-C Kalyan
Erythropoiesis- Dr.E. Muralinath-C KalyanErythropoiesis- Dr.E. Muralinath-C Kalyan
Erythropoiesis- Dr.E. Muralinath-C Kalyanmuralinath2
 
The solar dynamo begins near the surface
The solar dynamo begins near the surfaceThe solar dynamo begins near the surface
The solar dynamo begins near the surfaceSérgio Sacani
 
WASP-69b’s Escaping Envelope Is Confined to a Tail Extending at Least 7 Rp
WASP-69b’s Escaping Envelope Is Confined to a Tail Extending at Least 7 RpWASP-69b’s Escaping Envelope Is Confined to a Tail Extending at Least 7 Rp
WASP-69b’s Escaping Envelope Is Confined to a Tail Extending at Least 7 RpSérgio Sacani
 
PLANT DISEASE MANAGEMENT PRINCIPLES AND ITS IMPORTANCE
PLANT DISEASE MANAGEMENT PRINCIPLES AND ITS IMPORTANCEPLANT DISEASE MANAGEMENT PRINCIPLES AND ITS IMPORTANCE
PLANT DISEASE MANAGEMENT PRINCIPLES AND ITS IMPORTANCETALAPATI ARUNA CHENNA VYDYANAD
 
Plasma proteins_ Dr.Muralinath_Dr.c. kalyan
Plasma proteins_ Dr.Muralinath_Dr.c. kalyanPlasma proteins_ Dr.Muralinath_Dr.c. kalyan
Plasma proteins_ Dr.Muralinath_Dr.c. kalyanmuralinath2
 
NuGOweek 2024 full programme - hosted by Ghent University
NuGOweek 2024 full programme - hosted by Ghent UniversityNuGOweek 2024 full programme - hosted by Ghent University
NuGOweek 2024 full programme - hosted by Ghent Universitypablovgd
 
Extensive Pollution of Uranus and Neptune’s Atmospheres by Upsweep of Icy Mat...
Extensive Pollution of Uranus and Neptune’s Atmospheres by Upsweep of Icy Mat...Extensive Pollution of Uranus and Neptune’s Atmospheres by Upsweep of Icy Mat...
Extensive Pollution of Uranus and Neptune’s Atmospheres by Upsweep of Icy Mat...Sérgio Sacani
 
Virulence Analysis of Citrus canker caused by Xanthomonas axonopodis pv. citr...
Virulence Analysis of Citrus canker caused by Xanthomonas axonopodis pv. citr...Virulence Analysis of Citrus canker caused by Xanthomonas axonopodis pv. citr...
Virulence Analysis of Citrus canker caused by Xanthomonas axonopodis pv. citr...TALAPATI ARUNA CHENNA VYDYANAD
 
Manganese‐RichSandstonesasanIndicatorofAncientOxic LakeWaterConditionsinGale...
Manganese‐RichSandstonesasanIndicatorofAncientOxic  LakeWaterConditionsinGale...Manganese‐RichSandstonesasanIndicatorofAncientOxic  LakeWaterConditionsinGale...
Manganese‐RichSandstonesasanIndicatorofAncientOxic LakeWaterConditionsinGale...Sérgio Sacani
 
Mining Activity and Investment Opportunity in Myanmar.pptx
Mining Activity and Investment Opportunity in Myanmar.pptxMining Activity and Investment Opportunity in Myanmar.pptx
Mining Activity and Investment Opportunity in Myanmar.pptxKyawThanTint
 
Constraints on Neutrino Natal Kicks from Black-Hole Binary VFTS 243
Constraints on Neutrino Natal Kicks from Black-Hole Binary VFTS 243Constraints on Neutrino Natal Kicks from Black-Hole Binary VFTS 243
Constraints on Neutrino Natal Kicks from Black-Hole Binary VFTS 243Sérgio Sacani
 
VILLAGE ATTACHMENT For rural agriculture PPT.pptx
VILLAGE ATTACHMENT For rural agriculture  PPT.pptxVILLAGE ATTACHMENT For rural agriculture  PPT.pptx
VILLAGE ATTACHMENT For rural agriculture PPT.pptxAQIBRASOOL4
 
The Scientific names of some important families of Industrial plants .pdf
The Scientific names of some important families of Industrial plants .pdfThe Scientific names of some important families of Industrial plants .pdf
The Scientific names of some important families of Industrial plants .pdfMohamed Said
 
Emergent ribozyme behaviors in oxychlorine brines indicate a unique niche for...
Emergent ribozyme behaviors in oxychlorine brines indicate a unique niche for...Emergent ribozyme behaviors in oxychlorine brines indicate a unique niche for...
Emergent ribozyme behaviors in oxychlorine brines indicate a unique niche for...Sérgio Sacani
 
GBSN - Microbiology (Unit 7) Microbiology in Everyday Life
GBSN - Microbiology (Unit 7) Microbiology in Everyday LifeGBSN - Microbiology (Unit 7) Microbiology in Everyday Life
GBSN - Microbiology (Unit 7) Microbiology in Everyday LifeAreesha Ahmad
 
Detectability of Solar Panels as a Technosignature
Detectability of Solar Panels as a TechnosignatureDetectability of Solar Panels as a Technosignature
Detectability of Solar Panels as a TechnosignatureSérgio Sacani
 
mixotrophy in cyanobacteria: a dual nutritional strategy
mixotrophy in cyanobacteria: a dual nutritional strategymixotrophy in cyanobacteria: a dual nutritional strategy
mixotrophy in cyanobacteria: a dual nutritional strategyMansiBishnoi1
 
Triploidy ...............................pptx
Triploidy ...............................pptxTriploidy ...............................pptx
Triploidy ...............................pptxCherry
 
Molecular and Cellular Mechanism of Action of Hormones such as Growth Hormone...
Molecular and Cellular Mechanism of Action of Hormones such as Growth Hormone...Molecular and Cellular Mechanism of Action of Hormones such as Growth Hormone...
Molecular and Cellular Mechanism of Action of Hormones such as Growth Hormone...Ansari Aashif Raza Mohd Imtiyaz
 
Cellular Communication and regulation of communication mechanisms to sing the...
Cellular Communication and regulation of communication mechanisms to sing the...Cellular Communication and regulation of communication mechanisms to sing the...
Cellular Communication and regulation of communication mechanisms to sing the...Nistarini College, Purulia (W.B) India
 

Recently uploaded (20)

Erythropoiesis- Dr.E. Muralinath-C Kalyan
Erythropoiesis- Dr.E. Muralinath-C KalyanErythropoiesis- Dr.E. Muralinath-C Kalyan
Erythropoiesis- Dr.E. Muralinath-C Kalyan
 
The solar dynamo begins near the surface
The solar dynamo begins near the surfaceThe solar dynamo begins near the surface
The solar dynamo begins near the surface
 
WASP-69b’s Escaping Envelope Is Confined to a Tail Extending at Least 7 Rp
WASP-69b’s Escaping Envelope Is Confined to a Tail Extending at Least 7 RpWASP-69b’s Escaping Envelope Is Confined to a Tail Extending at Least 7 Rp
WASP-69b’s Escaping Envelope Is Confined to a Tail Extending at Least 7 Rp
 
PLANT DISEASE MANAGEMENT PRINCIPLES AND ITS IMPORTANCE
PLANT DISEASE MANAGEMENT PRINCIPLES AND ITS IMPORTANCEPLANT DISEASE MANAGEMENT PRINCIPLES AND ITS IMPORTANCE
PLANT DISEASE MANAGEMENT PRINCIPLES AND ITS IMPORTANCE
 
Plasma proteins_ Dr.Muralinath_Dr.c. kalyan
Plasma proteins_ Dr.Muralinath_Dr.c. kalyanPlasma proteins_ Dr.Muralinath_Dr.c. kalyan
Plasma proteins_ Dr.Muralinath_Dr.c. kalyan
 
NuGOweek 2024 full programme - hosted by Ghent University
NuGOweek 2024 full programme - hosted by Ghent UniversityNuGOweek 2024 full programme - hosted by Ghent University
NuGOweek 2024 full programme - hosted by Ghent University
 
Extensive Pollution of Uranus and Neptune’s Atmospheres by Upsweep of Icy Mat...
Extensive Pollution of Uranus and Neptune’s Atmospheres by Upsweep of Icy Mat...Extensive Pollution of Uranus and Neptune’s Atmospheres by Upsweep of Icy Mat...
Extensive Pollution of Uranus and Neptune’s Atmospheres by Upsweep of Icy Mat...
 
Virulence Analysis of Citrus canker caused by Xanthomonas axonopodis pv. citr...
Virulence Analysis of Citrus canker caused by Xanthomonas axonopodis pv. citr...Virulence Analysis of Citrus canker caused by Xanthomonas axonopodis pv. citr...
Virulence Analysis of Citrus canker caused by Xanthomonas axonopodis pv. citr...
 
Manganese‐RichSandstonesasanIndicatorofAncientOxic LakeWaterConditionsinGale...
Manganese‐RichSandstonesasanIndicatorofAncientOxic  LakeWaterConditionsinGale...Manganese‐RichSandstonesasanIndicatorofAncientOxic  LakeWaterConditionsinGale...
Manganese‐RichSandstonesasanIndicatorofAncientOxic LakeWaterConditionsinGale...
 
Mining Activity and Investment Opportunity in Myanmar.pptx
Mining Activity and Investment Opportunity in Myanmar.pptxMining Activity and Investment Opportunity in Myanmar.pptx
Mining Activity and Investment Opportunity in Myanmar.pptx
 
Constraints on Neutrino Natal Kicks from Black-Hole Binary VFTS 243
Constraints on Neutrino Natal Kicks from Black-Hole Binary VFTS 243Constraints on Neutrino Natal Kicks from Black-Hole Binary VFTS 243
Constraints on Neutrino Natal Kicks from Black-Hole Binary VFTS 243
 
VILLAGE ATTACHMENT For rural agriculture PPT.pptx
VILLAGE ATTACHMENT For rural agriculture  PPT.pptxVILLAGE ATTACHMENT For rural agriculture  PPT.pptx
VILLAGE ATTACHMENT For rural agriculture PPT.pptx
 
The Scientific names of some important families of Industrial plants .pdf
The Scientific names of some important families of Industrial plants .pdfThe Scientific names of some important families of Industrial plants .pdf
The Scientific names of some important families of Industrial plants .pdf
 
Emergent ribozyme behaviors in oxychlorine brines indicate a unique niche for...
Emergent ribozyme behaviors in oxychlorine brines indicate a unique niche for...Emergent ribozyme behaviors in oxychlorine brines indicate a unique niche for...
Emergent ribozyme behaviors in oxychlorine brines indicate a unique niche for...
 
GBSN - Microbiology (Unit 7) Microbiology in Everyday Life
GBSN - Microbiology (Unit 7) Microbiology in Everyday LifeGBSN - Microbiology (Unit 7) Microbiology in Everyday Life
GBSN - Microbiology (Unit 7) Microbiology in Everyday Life
 
Detectability of Solar Panels as a Technosignature
Detectability of Solar Panels as a TechnosignatureDetectability of Solar Panels as a Technosignature
Detectability of Solar Panels as a Technosignature
 
mixotrophy in cyanobacteria: a dual nutritional strategy
mixotrophy in cyanobacteria: a dual nutritional strategymixotrophy in cyanobacteria: a dual nutritional strategy
mixotrophy in cyanobacteria: a dual nutritional strategy
 
Triploidy ...............................pptx
Triploidy ...............................pptxTriploidy ...............................pptx
Triploidy ...............................pptx
 
Molecular and Cellular Mechanism of Action of Hormones such as Growth Hormone...
Molecular and Cellular Mechanism of Action of Hormones such as Growth Hormone...Molecular and Cellular Mechanism of Action of Hormones such as Growth Hormone...
Molecular and Cellular Mechanism of Action of Hormones such as Growth Hormone...
 
Cellular Communication and regulation of communication mechanisms to sing the...
Cellular Communication and regulation of communication mechanisms to sing the...Cellular Communication and regulation of communication mechanisms to sing the...
Cellular Communication and regulation of communication mechanisms to sing the...
 

Variant analysis and whole exome sequencing

  • 1. February 4th, 2015 Mariam Quiñones, PhD Computational Molecular Biology Specialist Bioinformatics and Computational Biosciences Branch OCICB/OSMO/OD/NIAID/NIH
  • 2. BCBB: A Branch Devoted to Bioinformatics and Computational Biosciences   Researchers’ time is increasingly important   BCBB saves our collaborators time and effort   Researchers speed projects to completion using BCBB consultation and development services   No need to hire extra post docs or use external consultants or developers What makes us different? Software DevelopersComputational Biologists PMs and Analysts 2
  • 3. BCBB   “NIH Users: Access a menu of BCBB services on the NIAID Intranet: •  http://bioinformatics.niaid.nih.gov/   Outside of NIH – •  search “BCBB” on the NIAID Public Internet Page: www.niaid.nih.gov   Email us at: •  ScienceApps@niaid.nih.gov 3
  • 4. Remember Sanger? •  Sanger introduced the “dideoxy method” (also known as Sanger sequencing) in December 1977 Alignment of reads using tools such as ‘Sequencher’ IMAGE: http://www.lifetechnologies.com 4
  • 6. File formats for aligned reads   SAM (sequence alignment map) CTTGGGCTGCGTCGTGTCTTCGCTTCACACCCGCGACGAGCGCGGCTTCT CTTGGGCTGCGTCGTGTCTTCGCTTCACACC Chr_ start end Chr2 100000 100050 Chr_ start end Chr2 50000 50050 6
  • 7. Most commonly used alignment file formats   SAM (sequence alignment map) Unified format for storing alignments to a reference genome   BAM (binary version of SAM) – used commonly to deliver data Compressed SAM file, is normally indexed   BED Commonly used to report features described by chrom, start, end, name, score, and strand. For example: chr1 11873 14409 uc001aaa.3 0 + 7
  • 8. Variant Analysis – Class Topics Introduction Variant calling, filtering and annotation Overview of downstream analyses 8
  • 9. Efforts at creating databases of variants: •  Project that started on 2002 with the goal of describing patterns of human genetic variation and create a haplotype map using SNPs present in at least 1% of the population, which were deposited in dbSNPs. 1000 Genomes •  Started in 2008 with a goal of using at least 1000 individuals (about 2,500 samples at 4X coverage), interrogate 1000 gene regions in 900 samples (exome analysis), find most genetic variants with allele frequencies above 1% and to a 0.1% if in coding regions as well as Indels and structural variants •  Make data available to the public ftp://ftp-trace.ncbi.nih.gov/1000genomes/ftp/ or via Amazon Cloud http://s3.amazonaws.com/1000genomes 9
  • 10. Variants are not only found in coding sequences Main Goal: •  Find all functional elements in the genome 10
  • 11. Read alignment •  Mapping reads to reference genome, processing to improve alignment and mark PCR duplicates Variant identification •  Variant calling and genotyping Annotation and Filtering •  Removing likely false positive variants Visualization and downstream analyses •  (e.g. association studies) A typical variant calling pipeline 11
  • 12. Mapping reads to reference Whole Genome Exome-Seq   Useful for identifying SNPs but also structural variants in any genomic region.   Interrogates variants in specific genomic regions, usually coding sequences.   Cheaper and provides high coverage Read alignment Recommended alignment tools: BWA-MEM, Bowtie2, ssaha2, novoalign. See more tools: •  Seq Answers Forum: http://seqanswers.com/wiki/Software/list 12
  • 13. How to identify structural variants? http://www.sciencedirect.com/science/article/pii/S0168952511001685 Methods and SV tools 1- Read Pair – use pair ends. GASVPro (Sindi 2012), BreakDancer (Chen 2009) 2- Read depth – CNVnator (Abyzov, 2010) 3- Split read – PinDEL (Ye 2009) 4- Denovo assembly Learn more: http://bit.ly/16A8FKR Also see references: http://bit.ly/1z7xnol - SV http://bit.ly/qin294 - CNV http://bit.ly/rLB7jc http://bit.ly/17fdZTc 13
  • 14. Exome-Seq Targeted exome capture   targets ~20,000 variants near coding sequences and a few rare missense or loss of function variants   Provides high depth of coverage for more accurate variant calling   It is starting to be used as a diagnostic tool Ann Neurol. 2012 Jan;71(1):5-14. -Nimblegen -Agilent -Illumina 14
  • 16. Mapping subject and family sequence data with BWA (paired end) Variants called with SAMtools Filtering out common variants in 1000 genomes (>0.05 allele freq) 500K variants Annotation using ANNOVAR* 576 non- synonymous filtered variants Visualization of each gene Whole-exome sequencing reveals a heterozygous LRP5 mutation in a 6- year-old boy with vertebral compression fractures and low trabecular bone density Fahiminiya S, Majewski J, Roughley P, Roschger P, Klaushofer K, Rauch F. Bone: July 23, 2013 *Annovar annotated: the type of mutations, presence in dbSNP132, minor allele frequency in the 1000 Genomes project, SIFT, Polyphen-2 and PHASTCONS scores 16
  • 17. Exome-seq - Also used for finding somatic mutations Exome sequencing of serous endometrial tumors identifies recurrent somatic mutations in chromatin- remodeling and ubiquitin ligase complex genes VOLUME 44 | NUMBER 12 | DECEMBER 2012 Nature Genetics Figure 1: Somatic mutations in CHD4, FBXW7 and SPOP cluster within important functional domains of the encoded proteins. 17
  • 18. Variant Analysis – Class Topics Introduction Variant calling, filtering and annotation Overview of downstream analyses 18
  • 19. Variant identification Goals: •  Identify variant bases, genotype likelihood and allele frequency while avoiding instrument noise. •  Generate an output file in vcf format (variant call format) with genotypes assigned to each sample 19
  • 20. Challenges of finding variants using NGS data   Base calling errors •  Different types of errors that vary by technology, sequence cycle and sequence context  Low coverage sequencing •  Lack of sequence from two chromosomes of a diploid individual at a site   Inaccurate mapping •  Aligned reads should be reported with mapping quality score 20
  • 22. Processing reads for Variant Analysis   Trimming: •  Unless quality of read data is poor, low quality end trimming of short reads (e.g. Illumina) prior to mapping is usually not required. •  If adapters are present in a high number of reads, these could be trimmed to improve mapping. –  Recommended tools: Prinseq, Btrim64, FastQC   Marking duplicates: •  It is not required to remove duplicate reads prior to mapping but instead it is recommended to mark duplicates after the alignment. –  Recommended tool: Picard. •  A library that is composed mainly of PCR duplicates could produce inaccurate variant calling. http://www.biomedcentral.com/1471-2164/13/S8/S8 Clip: http://bestclipartblog.com 22
  • 23. Picard Tools (integrates with GATK) AddOrReplaceReadGroups.jar BamIndexStats.jar BamToBfq.jar BuildBamIndex.jar CalculateHsMetrics.jar CleanSam.jar CollectAlignmentSummaryMetrics.jar CollectCDnaMetrics.jar CollectGcBiasMetrics.jar CollectInsertSizeMetrics.jar CollectMultipleMetrics.jar CompareSAMs.jar CreateSequenceDictionary.jar EstimateLibraryComplexity.jar ExtractIlluminaBarcodes.jar ExtractSequences.jar FastqToSam.jar FixMateInformation.jar IlluminaBasecallsToSam.jar MarkDuplicates.jar MeanQualityByCycle.jar MergeBamAlignment.jar MergeSamFiles.jar NormalizeFasta.jar picard-1.45.jar QualityScoreDistribution.jar ReorderSam.jar ReplaceSamHeader.jar RevertSam.jar sam-1.45.jar SamFormatConverter.jar SamToFastq.jar SortSam.jar ValidateSamFile.jar ViewSam.jar http://picard.sourceforge.net/command-line-overview.shtml java -jar QualityScoreDistribution.jar I=file.bam CHART=file.pdf 23
  • 24. SNP Calling Methods Early SNP callers and some commercial packages use a simple method of counting reads for each allele that have passed a mapping quality threshold. ** This is not good enough in particular when coverage is low. It is best to use advanced SNP callers which add more statistics for more accurate variant calling of low coverage datasets and indels. -e.g. GATK 24
  • 25. SNP and Genotype calling http://bib.oxfordjournals.org/content/early/2013/01/21/bib.bbs086/T1.expansion.html Germline Variant Callers Somatic Variant Callers •  Varscan, MuTEC Samtools: https://github.com/samtools/bcftools/wiki/HOWTOs 25
  • 26. VCF format (version 4.0)   Format used to report information about a position in the genome   Use by 1000 genomes to report all variants 26
  • 28. GATK pipeline (BROAD) for variant calling http://www.broadinstitute.org/gatk/guide/topic?name=methods-and-workflows 28
  • 29. GATK Haplotype Caller shows improvements on detecting misalignments around gaps and reducing false positives 29
  • 30. GATK uses a Base Quality Recalibration method http://www.nature.com/ng/journal/v43/n5/full/ng.806.html Covariates •  the raw quality score •  the position of the base in the read •  the dinucleotide context and the read group 30
  • 31. GATK uses a bayesian model http://www.broadinstitute.org/gatk//events/2038/GATKwh0-BP-5-Variant_calling.pdf •  It determines possible SNP and indel alleles •  Computes, for each sample, for each genotype, likelihoods of data given genotypes •  Computes the allele frequency distribution to determine most likely allele count, and emit a variant call if determined – When it reports a variant, it assign a genotype to each sample 31
  • 32. From the output of thousands of variants, which ones should you consider?   Various important considerations •  Is the variant call of good quality? •  If you expect a rare mutation, is the variant commonly found in the general population? •  What is the predicted effect of the variant? –  Non-synonymous –  Detrimental for function 32
  • 33. Read alignment •  Mapping reads to reference genome, processing to improve alignment and mark pcr duplicates Variant identification •  Variant calling and genotyping Annotation and Filtering •  Removing likely false positive variants Visualization and downstream analyses •  (e.g. association studies) A typical variant calling pipeline 33
  • 34. Filtering variants   The initial set of variants is usually filtered extensively in hopes of removing false positives.   More filtering can include public data or custom filters based on in-house data 2 novel in chr10 In house exome dbSNPs 1000 genomes 17,687 SNPs PLoS One. 2012;7(1):e29708 34
  • 35. Removing the common and low frequency to get the novel SNPs http://www.cardiovasculairegeneeskunde.nl/bestanden/Kathiresan.pdf 35
  • 36. Filtering variants   The initial set of variants is usually filtered extensively in hopes of removing false positives.   More filtering can include public data or custom filters based on in-house data   Most exome studies will then filter common variants (>1%) such as those in dbSNP database –  Good tools for filtering and annotation: Annovar, SNPeff –  Reports genes at or near variants as well as the type (non- synonymous coding, UTR, splicing, etc.) 36
  • 37. Filtering variants   The initial set of variants is usually filtered extensively in hopes of removing false positives.   More filtering can include public data or custom filters based on in-house data   Most exome studies will then filter common variants (>1%) such as those in dbSNP database –  Good tools for filtering and annotation: Annovar, SNPeff –  Reports genes at or near variants as well as the type (non- synonymous coding, UTR, splicing, etc.)   To filter by variant consequence, use SIFT and Polyphen2. These are available via Annovar or ENSEMBL VEP http://www.ensembl.org/Homo_sapiens/Tools/VEP   For a more flexible annotation workflow, explore GEMINI http://gemini.readthedocs.org/en/latest/ 37
  • 38. Evaluating Variant Consequence SIFT predictions - SIFT predicts whether an amino acid substitution affects protein function based on sequence homology and the physical properties of amino acids. PolyPhen predictions - PolyPhen is a tool which predicts possible impact of an amino acid substitution on the structure and function of a human protein using straightforward physical and comparative considerations. Condel consensus predictions - Condel computes a weighed average of the scores (WAS) of several computational tools aimed at classifying missense mutations as likely deleterious or likely neutral. The VEP currently presents a Condel WAS from SIFT and PolyPhen. 38
  • 39. Read alignment •  Mapping reads to reference genome, processing to improve alignment and mark pcr duplicates Variant identification •  Variant calling and genotyping Annotation and Filtering •  Removing likely false positive variants Visualization and downstream analyses •  (e.g. association studies) A typical variant calling pipeline 39
  • 40. Viewing reads in browser   If your genome is available via the UCSC genome browser http://genome.ucsc.edu/, import bam format file to the UCSC genome browser by hosting the file on a server and providing the link.   If your genome is not in UCSC, use another browser such as IGV http://www.broadinstitute.org/igv/ , or IGB http://bioviz.org/igb/ •  Import genome (fasta) •  Import annotations (gff3 or bed format) •  Import data (bam) 40
  • 41. Variant Analysis – Class Topics Introduction Variant calling, filtering and annotation Overview of downstream analyses 41
  • 42. Before exome-seq there was GWAS GWAS – Genome wide association study   Examination of common genetic variants in individuals and their association with a trait   Analysis is usually association to disease (Case/control) Genome-wide association study of systemic sclerosis identifies CD247 as a new susceptibility locus Nature Genetics 42, 426–429 (2010) Manhatan Plot – each dot is a SNP, Y-axis shows association level 42
  • 43. GWAS Association studies   A typical analysis: •  Identify SNPs where one allele is significantly more common in cases than controls •  Hardy-Weinberg Chi Square http://en.wikipedia.org/wiki/Genome-wide_association_study 43
  • 44. Analysis Tools for genotype-phenotype association from sequencing data   Plink-seq - http://atgu.mgh.harvard.edu/plinkseq/   EPACTS - http://genome.sph.umich.edu/wiki/EPACTS   SNPTestv2 / GRANVIL - http://www.well.ox.ac.uk/GRANVIL/ 44
  • 45. Consider a more integrative approach, which could include adding more SNP or exome data, biological function, pedigree, gene exprssion network and more. Science 2002 Oltvai et al., pp. 763 - 764 45
  • 46. A more integrative approach http://www.genome.gov/Multimedia/ Slides/SequenceVariants2012/ Day2_IntegratedApproachWG.pdf PLoS Genet. 2011 Jan 13;7(1):e1001273 46
  • 47. Pathways Analysis With pathways analysis we can study: • How genes and molecules communicate • The effect of a disruption to a pathway in relation to the associated phenotype or disease • Which pathways are likely to be affected an affected individual 0 1 2 3 4 5 Reference Test sample1 Test sample2 DNA damage Apoptosis Interferon signalling Enrichment and Network 47
  • 48. Networks Analysis   Encore: Genetic Association Interaction Network Centrality Pipeline and Application to SLE Exome Data Nicholas A. Davis1,†,‡, Caleb A. Lareau2,3,‡, Bill C. White1, Ahwan Pandey1, Graham Wiley3, Courtney G. Montgomery3, Patrick M. Gaffney3, B. A. McKinney1,2,* Article first published online: 5 JUN 2013 •  open source network analysis pipeline for genome-wide association studies and rare variant data 48
  • 49. Visualization   Browsers •  IGV - http://www.broadinstitute.org/igv/ - see slide 31 •  UCSC Genome browser - http://genome.ucsc.edu/   Other •  Cytoscape – can be used for example to visualize variants in the context of affected genes 49
  • 50. Other applications of variant calling in Deep Sequence: Virus evolution Deep Sequencing detects early variants in HIV evolution http://www.broadinstitute.org/scientific-community/science/projects/viral-genomics/v-phaser http://www.plospathogens.org/article/info%3Adoi%2F10.1371%2Fjournal.ppat.1002529 50
  • 51. Quasispecies evolution Whole Genome Deep Sequencing of HIV-1 Reveals the Impact of Early Minor Variants Upon Immune Recognition During Acute Infection   They concluded that the early control of HIV-1 replication by immunodominant CD8+ T cell responses may be substantially influenced by rapid, low frequency viral adaptations not detected by conventional sequencing approaches, which warrants further investigation. http://www.plospathogens.org/article/info%3Adoi%2F10.1371%2Fjournal.ppat.1002529 51
  • 52. Other applications of variant calling in Deep Sequence: Fast genotyping Outbreak investigation using high-throughput genome sequencing within a diagnostic microbiology laboratory. J Clin Microbiol. 2013 Feb 13 Ion Torrent was used! 52
  • 53. Links for variant calling and filtering tools   Variant Annotation -  Annovar http://www.openbioinformatics.org/annovar/ -  snpEff http://snpeff.sourceforge.net -  SeattleSeq Annotation http://snp.gs.washington.edu/SeattleSeqAnnotation137/   Variant Consequence -  SIFT: http://sift.jcvi.org/ -  Polyphen-2: http://genetics.bwh.harvard.edu/pph2/   Multiple tools for VCF file manipulation, variant calling, phenotype association - Galaxy - https://main.g2.bx.psu.edu/root 53
  • 54. Thank You Question or Comments please contact: quinonesm@niaid.nih.gov ScienceApps@niaid.nih.gov 54