SlideShare uma empresa Scribd logo
1 de 57
Integrated DNA Technologies
Use of NCBI Databases in qPCR Assay
Design
Elisabeth Wagner, PhD
Scientific Applications Specialist
1
Session Outcomes
 You will:
 Learn which NCBI tools are useful for designing qPCR assays
 Become proficient using tools for qPCR design in the IDT SciTools® suite
 Navigate the features and tools available on the NCBI website
 Obtain sequence information for your gene of interest
 Perform a BLAST search for assay specificity
 Search for SNPs
 Understand how to proceed with a basic qPCR design
2
qPCR Design Covers A Lot of Ground
There are many uses for quantitative PCR.
For some examples:
 Gene expression
 Copy number variation
 Genotyping
 Multi-species analysis
 Splice variant specific (or common) expression
We will address the general considerations for design in this session,
and cover more specific examples later this afternoon.
3
SciTools® Overview
 http://www.idtdna.com/pages/scitools
 Several Tools are available in the IDT SciTools® suite to assist with qPCR design
 1. RealTime PCR Tool
 2. PrimerQuest® Tool
 3. OligoAnalyzer® Tool
 4. PrimeTime® Predesigned qPCR Assay Database
4
NCBI Databases Overview:
 1. Obtain sequence information for your gene of interest-
 NCBI Nucleotide or Gene
 2. Perform a BLAST search for assay specificity
 NCBI BLAST
 3. Search for SNPs
 NCBI dbSNP
NCBI enables you to access all of this information necessary for design
in one location.
5
Using NCBI Databases for Custom qPCR Assay Design
NCBI Overview (National Center for Biotechnology and Information)
 Founded in 1988 as part of the United States National Library of Medicine
 Houses a series of databases relevant to biotechnology and biomedicine
 Curates Genbank, a database of over 1x1012 bp of DNA sequences
 Gene database, which integrates gene-specific information from numerous
species
 dbSNP, which is a database of reported Single Nucleotide Polymorphisms (SNPs)
 Contains the BLAST sequence similarity search program
 Maintains PubMed, a journal database for biomedical literature
 Much, much more information!
6
NCBI Database Search: Sequence Information for qPCR Assay Design
http://www.ncbi.nlm.nih.gov/
7
NCBI Sequence Files
Files:
 Can be entered by anyone
 May or may not be checked for accuracy
 May contain contaminated sequence (plasmid or other)
 May contain annotation errors
Accession numbers:
 Letters at the beginning indicate the type of file
 Nucleotide sequences start with 1 or 2 letters:
8
The RefSeq Database
 non-redundant
 explicitly linked nucleotide and protein
sequences
 ongoing curation by NCBI staff and
collaborators, with reviewed records
indicated
 includes data validation and
format consistency
 distinct accession numbers
 all accessions include an
underscore '_' character
 Different versions are tracked
9
RefSeq Accession Numbers
 mRNAs and Proteins
 NM_123456 Curated mRNA
 NP_123456 Curated Protein
 NR_123456 Curated non-coding RNA
 XM_123456 Predicted mRNA
 XP_123456 Predicted Protein
 XR_123456 Predicted non-coding RNA
 Gene Records
 NG_123456 Reference Genomic Sequence
 Chromosome
 NC_123455 Microbial replicons, organelle
genomes, human chromosomes
 AC-123455 Alternate assemblies
 Assemblies
 NT_123456 Contig
 NW_123456 WGS Supercontig
10
Accessing Sequence Information in NCBI
11
NCBI
NCBI Gene Database Information: Gene Search
12
Sequence Data Searches Using Nucleotide
 Sequence Files
 mRNA and genomic
 Transcript variants
http://www.ncbi.nlm.nih.gov/nuccore
13
Genbank information
14
Data Retrieval: Graphics View
15
Data Retrieval: FASTA Sequence Format
16
17
Using PrimerQuest® Tool for Custom qPCR Designs
18
PrimerQuest® Tool for Generating Custom qPCR Designs
Highly customizable tool
19
You Can Use NCBI Accession Number or FASTA Sequence
20
Once Sequence Entered, 3 Defaults Become Available
Often you will need to adjust the
parameters of the tool to meet
experimental design requirements
21
PrimerQuest® Tool Assay Output
22
Changing Parameters Depend on the Assay Required
Before changing anything, make sure
you have selected the correct assay
Sometimes you
simply need to
increase the number
of designs returned
It is unlikely that you will need
to change these parameters
23
Directing the Design to a Specific Region
Target a particular “junction”
24
Examples
Excluded region
260-280
Excluded region-probe 260-280Target region 260-280
25
Changing Primer/Probe Parameters
If the target is particularly biased (AT or GC rich), you may need to change primer/probe
parameters (i.e. length)
26
Once Initial Design Completed, Back to NCBI
Use NCBI tools to:
 Check whether assay is specific (BLAST)
 Ensure there are no SNPs to worry about (dbSNP)
Use IDT OligoAnalzyer® Tool
 Check primers (and probe) for secondary structure and dimer
formation
27
Using NCBI BLAST to Check for Primer Specificity
28
What is BLAST?—Getting to BLAST
 http://www.ncbi.nlm.nih.gov/
 Or http://blast.ncbi.nlm.nih.gov/Blast.cgi
29
What is BLAST (Basic Local Alignment Search Tool)?
 BLAST stands for Basic Local Alignment Search Tool and is provided by the National Center for
Biotechnology and Information (NCBI)
 Aligns a user defined query (sequence) to a wide variety of databases
 Can translate the query or the database to align sequences
 Can align 2 or more sequences together
 Heuristic algorithm to create alignments very fast
 Breaks sequences into “words” and searches the database for matches
 Reassembles these matches based on the criteria entered
30
What is BLAST?—Basic BLAST
31
How BLAST Works—Words
 BLAST divides the query sequence into subsets called “words”,
which the algorithm uses to perform the alignment
 Example (35 nt sequence):
CGATCGGGCATCACACAAAGTTATGTAGTAGAAAT
 All possible words that can be generated from the sequence are
used for the alignment
 The max number of words for this sequence is 29
7-letter word
32
Overview—Definitions
 Hit: A sequence to which the query is aligned and is returned in the
results of BLAST
 Identity: the extent of exact matches between 2 sequences (eg
ACGT and ACGG have 75% identity)
 Similarity = Positives (in BLAST scoring)
33
How BLAST Works—Scores
 The BLAST raw score is converted to a bit score for each alignment using
parameters based on statistics described in Karlin and Altschul (1990)
(www.ncbi.nlm.nih.gov/pmc/articles/PMC53667/pdf/pnas01031-0226.pdf).
 A high score does not necessarily indicate that the query is unique
 The score is only dependent on the alignment, length of the sequence, and the
length of the database
 E-value is the expected amount of random sequences that have equivalent
sequence alignment
 Calculated using the Max bit score and the length of the query and database
 Tells you the relative strength of the alignment
 Shorter sequences have higher E-values because the probability of finding that
sequence is higher
 A low E-value does not mean you have a unique match!
34
BLAST Assessment for qPCR Primers
 Go to the BLAST server:
 http://blast.ncbi.nlm.nih.gov/Blast.cgi
Enter primer sequences
separated by 7+ N’s
35
Select the Correct Database
“Others” is the most general but contains a lot of sequences. If possible use
Human or Mouse specific databases
For species with completed genome
projects, consider using “NCBI
Genomes” to limit BLAST results
36
Change the parameters of the BLAST scoring
Select less
rigorous
algorithm
Change
Word size
to “7”
37
Looking at the Results
The Graphic
Summary can
immediately give
you a sense of
what the overall
results are
Hover over
each result in
the graphic to
identify the
sequence
name
38
Then Look at Results List
Look at E-value and Query Coverage. Look for
jumps in either/both.
Looks like assay is specific to a single
gene by transcript
Ignore the “alternate”
chromosome assemblies
39
Investigate details of alignment
Check distance between primer
binding if looking at mRNA
Open
Graphics
result in a
new
tab/window
40
BLAST Shows Primer Aligned to Sequence
Zoom out with “-” sign
You can grab within
window and drag
sequence side to side
41
The Target Gene is on Chromosome 6
This looks promising with primers on different exons.
42
But We Had Other Chromosomal Hits……
“real” transcript
Pseudogene—
doesn’t look
transcribed
Primers (red
bar indicates
mismatch)
43
And Another One……
Another pseudogene.
But what’s
this?
Intron of a transcribed gene. So potentially in
RNA samples. Recommend avoiding if possible
44
Using NCBI to Check for SNPs
45
While Assessing BLAST Results, Also Assess for SNPs
46
Investigate SNPs in Primer Binding Sites
47
Assessing SNP Data
Tells you it’s a
single base
substitution
Indicates alternate
forms (here recorded
on opposite strand)
Indicates allele
frequency if known
Sometimes more frequency
data at bottom of page
48
SNP Data Roughly Divided by Risk
Trusted source
Very low frequency
No data, likely not
going to be
problematic
Significant risk. Look
to redesign if possible
49
Using OligoAnalzyer® Tool to Check Primers and Probes
50
Checking Primers with OligoAnalyzer® Tool
 PrimerQuest® design tools give you the “best” assays for the region
specified
 They check for self- and hetero-dimers, but this is only part of the scoring
system used
 An assay maybe be “better” even with dimer issues if it scores well on
other parameters
 Go to the OligoAnalyzer Tool
 Perform self-dimer checks for primers and probe
 Perform heterodimer checks on all primer/probe combinations (especially
important to include all combinations when multiplexing)
 Check hairpin structures.
 Look for stability of < -9 kcal/mol
 Or multiple hairpins forming with < -4 kcal/mol
51
Assessing Dimer Data
Looks stable < -9kcal/mol
But this is not “dangerous”,
avoid if possible but ok
Looks stable < -9kcal/mol
Not extendable, not a problem
Doesn’t look stable > -9kcal/mol
Danger of extension,
exponential amplification!
52
Assessing Hairpin Structures
 Based on UNAfold predictions
IDT PrimeTime® Predesigned qPCR Database
53
54
Primer and Probe Design Criteria for PrimeTime® Assays
 Primers
 equal Tm (60–63oC)
 15–30 bases in length
 no runs of 4 or more Gs
 amplicon size 50–150 bp (max 400 bp)
 Probe
 Probe length no longer than 30–35 bases
 Tm value 4–10oC higher than primers
 no runs of 4 or more consecutive Gs
 G+C content 30–80%
 no G at the 5′ end
55
PrimeTime Results
56
 Questions?

Mais conteúdo relacionado

Mais procurados

Q pcr introduction 2013
Q pcr introduction 2013Q pcr introduction 2013
Q pcr introduction 2013
Elsa von Licy
 
Dna sequencing methods
Dna sequencing methodsDna sequencing methods
Dna sequencing methods
hephz
 

Mais procurados (20)

qRT PCR
qRT PCRqRT PCR
qRT PCR
 
Real Time PCR
Real Time PCRReal Time PCR
Real Time PCR
 
Real-Time PCR
Real-Time PCRReal-Time PCR
Real-Time PCR
 
Innovative NGS Library Construction Technology
Innovative NGS Library Construction TechnologyInnovative NGS Library Construction Technology
Innovative NGS Library Construction Technology
 
Introduction to real-Time Quantitative PCR (qPCR) - Download the slides
Introduction to real-Time Quantitative PCR (qPCR) - Download the slidesIntroduction to real-Time Quantitative PCR (qPCR) - Download the slides
Introduction to real-Time Quantitative PCR (qPCR) - Download the slides
 
Next generation sequencing
Next generation sequencingNext generation sequencing
Next generation sequencing
 
Q pcr introduction 2013
Q pcr introduction 2013Q pcr introduction 2013
Q pcr introduction 2013
 
Dna sequencing methods
Dna sequencing methodsDna sequencing methods
Dna sequencing methods
 
Real Time PCR
Real Time PCRReal Time PCR
Real Time PCR
 
Next Generation Sequencing - the basics
Next Generation Sequencing - the basicsNext Generation Sequencing - the basics
Next Generation Sequencing - the basics
 
PCR
PCRPCR
PCR
 
Em pcr 16x9
Em pcr 16x9Em pcr 16x9
Em pcr 16x9
 
Primer Designing
Primer DesigningPrimer Designing
Primer Designing
 
Technical Tips for qPCR
Technical Tips for qPCRTechnical Tips for qPCR
Technical Tips for qPCR
 
PCR Methods and applications
PCR Methods and applicationsPCR Methods and applications
PCR Methods and applications
 
PCR
PCRPCR
PCR
 
Q pcr
Q pcrQ pcr
Q pcr
 
Analyzing Fusion Genes Using Next-Generation Sequencing
Analyzing Fusion Genes Using Next-Generation SequencingAnalyzing Fusion Genes Using Next-Generation Sequencing
Analyzing Fusion Genes Using Next-Generation Sequencing
 
Polymerase Chain Reaction
Polymerase Chain ReactionPolymerase Chain Reaction
Polymerase Chain Reaction
 
Ppt.pcr appli.
Ppt.pcr appli.Ppt.pcr appli.
Ppt.pcr appli.
 

Destaque (6)

PCR Primer desining
PCR Primer desiningPCR Primer desining
PCR Primer desining
 
Primer design
Primer designPrimer design
Primer design
 
NCBI -Pcr primer design
NCBI -Pcr primer designNCBI -Pcr primer design
NCBI -Pcr primer design
 
Pcr primer design english version
Pcr primer design english versionPcr primer design english version
Pcr primer design english version
 
How to use primer blast for checking primer specificity
How to use primer blast for checking primer specificityHow to use primer blast for checking primer specificity
How to use primer blast for checking primer specificity
 
PCR, Real Time PCR
PCR, Real Time PCRPCR, Real Time PCR
PCR, Real Time PCR
 

Semelhante a Use of NCBI Databases in qPCR Assay Design

2013 02-14 - ngs webinar - sellappan
2013 02-14 - ngs webinar - sellappan2013 02-14 - ngs webinar - sellappan
2013 02-14 - ngs webinar - sellappan
Elsa von Licy
 
2012 10-24 - ngs webinar
2012 10-24 - ngs webinar2012 10-24 - ngs webinar
2012 10-24 - ngs webinar
Elsa von Licy
 
презентация за варшава
презентация за варшавапрезентация за варшава
презентация за варшава
Valeriya Simeonova
 

Semelhante a Use of NCBI Databases in qPCR Assay Design (20)

Ngs webinar 2013
Ngs webinar 2013Ngs webinar 2013
Ngs webinar 2013
 
2013 02-14 - ngs webinar - sellappan
2013 02-14 - ngs webinar - sellappan2013 02-14 - ngs webinar - sellappan
2013 02-14 - ngs webinar - sellappan
 
2012 10-24 - ngs webinar
2012 10-24 - ngs webinar2012 10-24 - ngs webinar
2012 10-24 - ngs webinar
 
Galaxy dna-seq-variant calling-presentationandpractical_gent_april-2016
Galaxy dna-seq-variant calling-presentationandpractical_gent_april-2016Galaxy dna-seq-variant calling-presentationandpractical_gent_april-2016
Galaxy dna-seq-variant calling-presentationandpractical_gent_april-2016
 
RNA-Seq with R-Bioconductor
RNA-Seq with R-BioconductorRNA-Seq with R-Bioconductor
RNA-Seq with R-Bioconductor
 
Cn presentation
Cn presentationCn presentation
Cn presentation
 
презентация за варшава
презентация за варшавапрезентация за варшава
презентация за варшава
 
Bioinformatics MiRON
Bioinformatics MiRONBioinformatics MiRON
Bioinformatics MiRON
 
Rare Variant Analysis Workflows: Analyzing NGS Data in Large Cohorts
Rare Variant Analysis Workflows: Analyzing NGS Data in Large CohortsRare Variant Analysis Workflows: Analyzing NGS Data in Large Cohorts
Rare Variant Analysis Workflows: Analyzing NGS Data in Large Cohorts
 
Talk ABRF 2015 (Gunnar Rätsch)
Talk ABRF 2015 (Gunnar Rätsch)Talk ABRF 2015 (Gunnar Rätsch)
Talk ABRF 2015 (Gunnar Rätsch)
 
Assign 2.0 software for the analysis of Phred quality values for quality con...
Assign 2.0  software for the analysis of Phred quality values for quality con...Assign 2.0  software for the analysis of Phred quality values for quality con...
Assign 2.0 software for the analysis of Phred quality values for quality con...
 
Lecture 5.pptx
Lecture 5.pptxLecture 5.pptx
Lecture 5.pptx
 
BLAST (Basic local alignment search Tool)
BLAST (Basic local alignment search Tool)BLAST (Basic local alignment search Tool)
BLAST (Basic local alignment search Tool)
 
The Use of K-mer Minimizers to Identify Bacterium Genomes in High Throughput ...
The Use of K-mer Minimizers to Identify Bacterium Genomes in High Throughput ...The Use of K-mer Minimizers to Identify Bacterium Genomes in High Throughput ...
The Use of K-mer Minimizers to Identify Bacterium Genomes in High Throughput ...
 
Bioinformaatics for M.Sc. Biotecchnology.pptx
Bioinformaatics for M.Sc. Biotecchnology.pptxBioinformaatics for M.Sc. Biotecchnology.pptx
Bioinformaatics for M.Sc. Biotecchnology.pptx
 
Blast
BlastBlast
Blast
 
Sequence Analysis
Sequence AnalysisSequence Analysis
Sequence Analysis
 
Database Searching
Database SearchingDatabase Searching
Database Searching
 
blast bioinformatics
blast bioinformaticsblast bioinformatics
blast bioinformatics
 
Kim Pruitt trainingbiocuration2015
Kim Pruitt trainingbiocuration2015Kim Pruitt trainingbiocuration2015
Kim Pruitt trainingbiocuration2015
 

Mais de Integrated DNA Technologies

The quest for high confidence mutations in plasma: searching for a needle in ...
The quest for high confidence mutations in plasma: searching for a needle in ...The quest for high confidence mutations in plasma: searching for a needle in ...
The quest for high confidence mutations in plasma: searching for a needle in ...
Integrated DNA Technologies
 
Characterizing Alzheimer’s Disease candidate genes and transcripts with targe...
Characterizing Alzheimer’s Disease candidate genes and transcripts with targe...Characterizing Alzheimer’s Disease candidate genes and transcripts with targe...
Characterizing Alzheimer’s Disease candidate genes and transcripts with targe...
Integrated DNA Technologies
 

Mais de Integrated DNA Technologies (20)

Overcoming the challenges of designing efficient and specific CRISPR gRNAs
Overcoming the challenges of designing efficient and specific CRISPR gRNAsOvercoming the challenges of designing efficient and specific CRISPR gRNAs
Overcoming the challenges of designing efficient and specific CRISPR gRNAs
 
Best practices for data analysis when using UMI adapters to improve variant d...
Best practices for data analysis when using UMI adapters to improve variant d...Best practices for data analysis when using UMI adapters to improve variant d...
Best practices for data analysis when using UMI adapters to improve variant d...
 
Increasing genome editing efficiency with optimized CRISPR-Cas enzymes
Increasing genome editing efficiency with optimized CRISPR-Cas enzymesIncreasing genome editing efficiency with optimized CRISPR-Cas enzymes
Increasing genome editing efficiency with optimized CRISPR-Cas enzymes
 
The quest for high confidence mutations in plasma: searching for a needle in ...
The quest for high confidence mutations in plasma: searching for a needle in ...The quest for high confidence mutations in plasma: searching for a needle in ...
The quest for high confidence mutations in plasma: searching for a needle in ...
 
SNP genotyping on qPCR platforms: Troubleshooting for amplification and clust...
SNP genotyping on qPCR platforms: Troubleshooting for amplification and clust...SNP genotyping on qPCR platforms: Troubleshooting for amplification and clust...
SNP genotyping on qPCR platforms: Troubleshooting for amplification and clust...
 
Optimized methods to use Cas9 nickases in genome editing
Optimized methods to use Cas9 nickases in genome editingOptimized methods to use Cas9 nickases in genome editing
Optimized methods to use Cas9 nickases in genome editing
 
Dual index adapters with UMIs resolve index hopping and increase sensitivity ...
Dual index adapters with UMIs resolve index hopping and increase sensitivity ...Dual index adapters with UMIs resolve index hopping and increase sensitivity ...
Dual index adapters with UMIs resolve index hopping and increase sensitivity ...
 
Characterizing Alzheimer’s Disease candidate genes and transcripts with targe...
Characterizing Alzheimer’s Disease candidate genes and transcripts with targe...Characterizing Alzheimer’s Disease candidate genes and transcripts with targe...
Characterizing Alzheimer’s Disease candidate genes and transcripts with targe...
 
Reducing off-target events in CRISPR genome editing applications with a novel...
Reducing off-target events in CRISPR genome editing applications with a novel...Reducing off-target events in CRISPR genome editing applications with a novel...
Reducing off-target events in CRISPR genome editing applications with a novel...
 
rhAmp™ SNP Genotyping: A novel approach for improving PCR-based SNP genotyping
rhAmp™ SNP Genotyping: A novel approach for improving PCR-based SNP genotypingrhAmp™ SNP Genotyping: A novel approach for improving PCR-based SNP genotyping
rhAmp™ SNP Genotyping: A novel approach for improving PCR-based SNP genotyping
 
Unique, dual-matched adapters mitigate index hopping between NGS samples
Unique, dual-matched adapters mitigate index hopping between NGS samplesUnique, dual-matched adapters mitigate index hopping between NGS samples
Unique, dual-matched adapters mitigate index hopping between NGS samples
 
Analyzing the exome—focusing your NGS analysis with high performance target c...
Analyzing the exome—focusing your NGS analysis with high performance target c...Analyzing the exome—focusing your NGS analysis with high performance target c...
Analyzing the exome—focusing your NGS analysis with high performance target c...
 
Getting started with CRISPR: a review of gene knockout and homology-directed ...
Getting started with CRISPR: a review of gene knockout and homology-directed ...Getting started with CRISPR: a review of gene knockout and homology-directed ...
Getting started with CRISPR: a review of gene knockout and homology-directed ...
 
Cpf1-based genome editing using ribonucleoprotein complexes
Cpf1-based genome editing using ribonucleoprotein complexesCpf1-based genome editing using ribonucleoprotein complexes
Cpf1-based genome editing using ribonucleoprotein complexes
 
Ribonucleoprotein delivery of CRISPR-Cas9 reagents for increased gene editing...
Ribonucleoprotein delivery of CRISPR-Cas9 reagents for increased gene editing...Ribonucleoprotein delivery of CRISPR-Cas9 reagents for increased gene editing...
Ribonucleoprotein delivery of CRISPR-Cas9 reagents for increased gene editing...
 
Accurate detection of low frequency genetic variants using novel, molecular t...
Accurate detection of low frequency genetic variants using novel, molecular t...Accurate detection of low frequency genetic variants using novel, molecular t...
Accurate detection of low frequency genetic variants using novel, molecular t...
 
Target capture of DNA from FFPE samples— recommendations for generating robus...
Target capture of DNA from FFPE samples— recommendations for generating robus...Target capture of DNA from FFPE samples— recommendations for generating robus...
Target capture of DNA from FFPE samples— recommendations for generating robus...
 
High efficiency qPCR with PrimeTime® Gene Expression Master Mix from IDT
High efficiency qPCR with PrimeTime® Gene Expression Master Mix from IDTHigh efficiency qPCR with PrimeTime® Gene Expression Master Mix from IDT
High efficiency qPCR with PrimeTime® Gene Expression Master Mix from IDT
 
Tips for effective use of BLAST and other NCBI tools
Tips for effective use of BLAST and other NCBI toolsTips for effective use of BLAST and other NCBI tools
Tips for effective use of BLAST and other NCBI tools
 
Gene synthesis technology and applications update—unleash your lab’s potentia...
Gene synthesis technology and applications update—unleash your lab’s potentia...Gene synthesis technology and applications update—unleash your lab’s potentia...
Gene synthesis technology and applications update—unleash your lab’s potentia...
 

Último

(May 9, 2024) Enhanced Ultrafast Vector Flow Imaging (VFI) Using Multi-Angle ...
(May 9, 2024) Enhanced Ultrafast Vector Flow Imaging (VFI) Using Multi-Angle ...(May 9, 2024) Enhanced Ultrafast Vector Flow Imaging (VFI) Using Multi-Angle ...
(May 9, 2024) Enhanced Ultrafast Vector Flow Imaging (VFI) Using Multi-Angle ...
Scintica Instrumentation
 
THE ROLE OF BIOTECHNOLOGY IN THE ECONOMIC UPLIFT.pptx
THE ROLE OF BIOTECHNOLOGY IN THE ECONOMIC UPLIFT.pptxTHE ROLE OF BIOTECHNOLOGY IN THE ECONOMIC UPLIFT.pptx
THE ROLE OF BIOTECHNOLOGY IN THE ECONOMIC UPLIFT.pptx
ANSARKHAN96
 
Reboulia: features, anatomy, morphology etc.
Reboulia: features, anatomy, morphology etc.Reboulia: features, anatomy, morphology etc.
Reboulia: features, anatomy, morphology etc.
Silpa
 
Porella : features, morphology, anatomy, reproduction etc.
Porella : features, morphology, anatomy, reproduction etc.Porella : features, morphology, anatomy, reproduction etc.
Porella : features, morphology, anatomy, reproduction etc.
Silpa
 
+971581248768>> SAFE AND ORIGINAL ABORTION PILLS FOR SALE IN DUBAI AND ABUDHA...
+971581248768>> SAFE AND ORIGINAL ABORTION PILLS FOR SALE IN DUBAI AND ABUDHA...+971581248768>> SAFE AND ORIGINAL ABORTION PILLS FOR SALE IN DUBAI AND ABUDHA...
+971581248768>> SAFE AND ORIGINAL ABORTION PILLS FOR SALE IN DUBAI AND ABUDHA...
?#DUbAI#??##{{(☎️+971_581248768%)**%*]'#abortion pills for sale in dubai@
 

Último (20)

(May 9, 2024) Enhanced Ultrafast Vector Flow Imaging (VFI) Using Multi-Angle ...
(May 9, 2024) Enhanced Ultrafast Vector Flow Imaging (VFI) Using Multi-Angle ...(May 9, 2024) Enhanced Ultrafast Vector Flow Imaging (VFI) Using Multi-Angle ...
(May 9, 2024) Enhanced Ultrafast Vector Flow Imaging (VFI) Using Multi-Angle ...
 
Cyanide resistant respiration pathway.pptx
Cyanide resistant respiration pathway.pptxCyanide resistant respiration pathway.pptx
Cyanide resistant respiration pathway.pptx
 
Molecular markers- RFLP, RAPD, AFLP, SNP etc.
Molecular markers- RFLP, RAPD, AFLP, SNP etc.Molecular markers- RFLP, RAPD, AFLP, SNP etc.
Molecular markers- RFLP, RAPD, AFLP, SNP etc.
 
Chemistry 5th semester paper 1st Notes.pdf
Chemistry 5th semester paper 1st Notes.pdfChemistry 5th semester paper 1st Notes.pdf
Chemistry 5th semester paper 1st Notes.pdf
 
Use of mutants in understanding seedling development.pptx
Use of mutants in understanding seedling development.pptxUse of mutants in understanding seedling development.pptx
Use of mutants in understanding seedling development.pptx
 
THE ROLE OF BIOTECHNOLOGY IN THE ECONOMIC UPLIFT.pptx
THE ROLE OF BIOTECHNOLOGY IN THE ECONOMIC UPLIFT.pptxTHE ROLE OF BIOTECHNOLOGY IN THE ECONOMIC UPLIFT.pptx
THE ROLE OF BIOTECHNOLOGY IN THE ECONOMIC UPLIFT.pptx
 
Reboulia: features, anatomy, morphology etc.
Reboulia: features, anatomy, morphology etc.Reboulia: features, anatomy, morphology etc.
Reboulia: features, anatomy, morphology etc.
 
Genetics and epigenetics of ADHD and comorbid conditions
Genetics and epigenetics of ADHD and comorbid conditionsGenetics and epigenetics of ADHD and comorbid conditions
Genetics and epigenetics of ADHD and comorbid conditions
 
Clean In Place(CIP).pptx .
Clean In Place(CIP).pptx                 .Clean In Place(CIP).pptx                 .
Clean In Place(CIP).pptx .
 
GBSN - Biochemistry (Unit 2)
GBSN - Biochemistry (Unit 2)GBSN - Biochemistry (Unit 2)
GBSN - Biochemistry (Unit 2)
 
FAIRSpectra - Enabling the FAIRification of Analytical Science
FAIRSpectra - Enabling the FAIRification of Analytical ScienceFAIRSpectra - Enabling the FAIRification of Analytical Science
FAIRSpectra - Enabling the FAIRification of Analytical Science
 
Dr. E. Muralinath_ Blood indices_clinical aspects
Dr. E. Muralinath_ Blood indices_clinical  aspectsDr. E. Muralinath_ Blood indices_clinical  aspects
Dr. E. Muralinath_ Blood indices_clinical aspects
 
GBSN - Microbiology (Unit 3)
GBSN - Microbiology (Unit 3)GBSN - Microbiology (Unit 3)
GBSN - Microbiology (Unit 3)
 
Porella : features, morphology, anatomy, reproduction etc.
Porella : features, morphology, anatomy, reproduction etc.Porella : features, morphology, anatomy, reproduction etc.
Porella : features, morphology, anatomy, reproduction etc.
 
Selaginella: features, morphology ,anatomy and reproduction.
Selaginella: features, morphology ,anatomy and reproduction.Selaginella: features, morphology ,anatomy and reproduction.
Selaginella: features, morphology ,anatomy and reproduction.
 
TransientOffsetin14CAftertheCarringtonEventRecordedbyPolarTreeRings
TransientOffsetin14CAftertheCarringtonEventRecordedbyPolarTreeRingsTransientOffsetin14CAftertheCarringtonEventRecordedbyPolarTreeRings
TransientOffsetin14CAftertheCarringtonEventRecordedbyPolarTreeRings
 
+971581248768>> SAFE AND ORIGINAL ABORTION PILLS FOR SALE IN DUBAI AND ABUDHA...
+971581248768>> SAFE AND ORIGINAL ABORTION PILLS FOR SALE IN DUBAI AND ABUDHA...+971581248768>> SAFE AND ORIGINAL ABORTION PILLS FOR SALE IN DUBAI AND ABUDHA...
+971581248768>> SAFE AND ORIGINAL ABORTION PILLS FOR SALE IN DUBAI AND ABUDHA...
 
Proteomics: types, protein profiling steps etc.
Proteomics: types, protein profiling steps etc.Proteomics: types, protein profiling steps etc.
Proteomics: types, protein profiling steps etc.
 
module for grade 9 for distance learning
module for grade 9 for distance learningmodule for grade 9 for distance learning
module for grade 9 for distance learning
 
Zoology 5th semester notes( Sumit_yadav).pdf
Zoology 5th semester notes( Sumit_yadav).pdfZoology 5th semester notes( Sumit_yadav).pdf
Zoology 5th semester notes( Sumit_yadav).pdf
 

Use of NCBI Databases in qPCR Assay Design

  • 1. Integrated DNA Technologies Use of NCBI Databases in qPCR Assay Design Elisabeth Wagner, PhD Scientific Applications Specialist
  • 2. 1 Session Outcomes  You will:  Learn which NCBI tools are useful for designing qPCR assays  Become proficient using tools for qPCR design in the IDT SciTools® suite  Navigate the features and tools available on the NCBI website  Obtain sequence information for your gene of interest  Perform a BLAST search for assay specificity  Search for SNPs  Understand how to proceed with a basic qPCR design
  • 3. 2 qPCR Design Covers A Lot of Ground There are many uses for quantitative PCR. For some examples:  Gene expression  Copy number variation  Genotyping  Multi-species analysis  Splice variant specific (or common) expression We will address the general considerations for design in this session, and cover more specific examples later this afternoon.
  • 4. 3 SciTools® Overview  http://www.idtdna.com/pages/scitools  Several Tools are available in the IDT SciTools® suite to assist with qPCR design  1. RealTime PCR Tool  2. PrimerQuest® Tool  3. OligoAnalyzer® Tool  4. PrimeTime® Predesigned qPCR Assay Database
  • 5. 4 NCBI Databases Overview:  1. Obtain sequence information for your gene of interest-  NCBI Nucleotide or Gene  2. Perform a BLAST search for assay specificity  NCBI BLAST  3. Search for SNPs  NCBI dbSNP NCBI enables you to access all of this information necessary for design in one location.
  • 6. 5 Using NCBI Databases for Custom qPCR Assay Design
  • 7. NCBI Overview (National Center for Biotechnology and Information)  Founded in 1988 as part of the United States National Library of Medicine  Houses a series of databases relevant to biotechnology and biomedicine  Curates Genbank, a database of over 1x1012 bp of DNA sequences  Gene database, which integrates gene-specific information from numerous species  dbSNP, which is a database of reported Single Nucleotide Polymorphisms (SNPs)  Contains the BLAST sequence similarity search program  Maintains PubMed, a journal database for biomedical literature  Much, much more information! 6
  • 8. NCBI Database Search: Sequence Information for qPCR Assay Design http://www.ncbi.nlm.nih.gov/ 7
  • 9. NCBI Sequence Files Files:  Can be entered by anyone  May or may not be checked for accuracy  May contain contaminated sequence (plasmid or other)  May contain annotation errors Accession numbers:  Letters at the beginning indicate the type of file  Nucleotide sequences start with 1 or 2 letters: 8
  • 10. The RefSeq Database  non-redundant  explicitly linked nucleotide and protein sequences  ongoing curation by NCBI staff and collaborators, with reviewed records indicated  includes data validation and format consistency  distinct accession numbers  all accessions include an underscore '_' character  Different versions are tracked 9
  • 11. RefSeq Accession Numbers  mRNAs and Proteins  NM_123456 Curated mRNA  NP_123456 Curated Protein  NR_123456 Curated non-coding RNA  XM_123456 Predicted mRNA  XP_123456 Predicted Protein  XR_123456 Predicted non-coding RNA  Gene Records  NG_123456 Reference Genomic Sequence  Chromosome  NC_123455 Microbial replicons, organelle genomes, human chromosomes  AC-123455 Alternate assemblies  Assemblies  NT_123456 Contig  NW_123456 WGS Supercontig 10
  • 13. NCBI Gene Database Information: Gene Search 12
  • 14. Sequence Data Searches Using Nucleotide  Sequence Files  mRNA and genomic  Transcript variants http://www.ncbi.nlm.nih.gov/nuccore 13
  • 17. Data Retrieval: FASTA Sequence Format 16
  • 18. 17 Using PrimerQuest® Tool for Custom qPCR Designs
  • 19. 18 PrimerQuest® Tool for Generating Custom qPCR Designs Highly customizable tool
  • 20. 19 You Can Use NCBI Accession Number or FASTA Sequence
  • 21. 20 Once Sequence Entered, 3 Defaults Become Available Often you will need to adjust the parameters of the tool to meet experimental design requirements
  • 23. 22 Changing Parameters Depend on the Assay Required Before changing anything, make sure you have selected the correct assay Sometimes you simply need to increase the number of designs returned It is unlikely that you will need to change these parameters
  • 24. 23 Directing the Design to a Specific Region Target a particular “junction”
  • 26. 25 Changing Primer/Probe Parameters If the target is particularly biased (AT or GC rich), you may need to change primer/probe parameters (i.e. length)
  • 27. 26 Once Initial Design Completed, Back to NCBI Use NCBI tools to:  Check whether assay is specific (BLAST)  Ensure there are no SNPs to worry about (dbSNP) Use IDT OligoAnalzyer® Tool  Check primers (and probe) for secondary structure and dimer formation
  • 28. 27 Using NCBI BLAST to Check for Primer Specificity
  • 29. 28 What is BLAST?—Getting to BLAST  http://www.ncbi.nlm.nih.gov/  Or http://blast.ncbi.nlm.nih.gov/Blast.cgi
  • 30. 29 What is BLAST (Basic Local Alignment Search Tool)?  BLAST stands for Basic Local Alignment Search Tool and is provided by the National Center for Biotechnology and Information (NCBI)  Aligns a user defined query (sequence) to a wide variety of databases  Can translate the query or the database to align sequences  Can align 2 or more sequences together  Heuristic algorithm to create alignments very fast  Breaks sequences into “words” and searches the database for matches  Reassembles these matches based on the criteria entered
  • 32. 31 How BLAST Works—Words  BLAST divides the query sequence into subsets called “words”, which the algorithm uses to perform the alignment  Example (35 nt sequence): CGATCGGGCATCACACAAAGTTATGTAGTAGAAAT  All possible words that can be generated from the sequence are used for the alignment  The max number of words for this sequence is 29 7-letter word
  • 33. 32 Overview—Definitions  Hit: A sequence to which the query is aligned and is returned in the results of BLAST  Identity: the extent of exact matches between 2 sequences (eg ACGT and ACGG have 75% identity)  Similarity = Positives (in BLAST scoring)
  • 34. 33 How BLAST Works—Scores  The BLAST raw score is converted to a bit score for each alignment using parameters based on statistics described in Karlin and Altschul (1990) (www.ncbi.nlm.nih.gov/pmc/articles/PMC53667/pdf/pnas01031-0226.pdf).  A high score does not necessarily indicate that the query is unique  The score is only dependent on the alignment, length of the sequence, and the length of the database  E-value is the expected amount of random sequences that have equivalent sequence alignment  Calculated using the Max bit score and the length of the query and database  Tells you the relative strength of the alignment  Shorter sequences have higher E-values because the probability of finding that sequence is higher  A low E-value does not mean you have a unique match!
  • 35. 34 BLAST Assessment for qPCR Primers  Go to the BLAST server:  http://blast.ncbi.nlm.nih.gov/Blast.cgi Enter primer sequences separated by 7+ N’s
  • 36. 35 Select the Correct Database “Others” is the most general but contains a lot of sequences. If possible use Human or Mouse specific databases For species with completed genome projects, consider using “NCBI Genomes” to limit BLAST results
  • 37. 36 Change the parameters of the BLAST scoring Select less rigorous algorithm Change Word size to “7”
  • 38. 37 Looking at the Results The Graphic Summary can immediately give you a sense of what the overall results are Hover over each result in the graphic to identify the sequence name
  • 39. 38 Then Look at Results List Look at E-value and Query Coverage. Look for jumps in either/both. Looks like assay is specific to a single gene by transcript Ignore the “alternate” chromosome assemblies
  • 40. 39 Investigate details of alignment Check distance between primer binding if looking at mRNA Open Graphics result in a new tab/window
  • 41. 40 BLAST Shows Primer Aligned to Sequence Zoom out with “-” sign You can grab within window and drag sequence side to side
  • 42. 41 The Target Gene is on Chromosome 6 This looks promising with primers on different exons.
  • 43. 42 But We Had Other Chromosomal Hits…… “real” transcript Pseudogene— doesn’t look transcribed Primers (red bar indicates mismatch)
  • 44. 43 And Another One…… Another pseudogene. But what’s this? Intron of a transcribed gene. So potentially in RNA samples. Recommend avoiding if possible
  • 45. 44 Using NCBI to Check for SNPs
  • 46. 45 While Assessing BLAST Results, Also Assess for SNPs
  • 47. 46 Investigate SNPs in Primer Binding Sites
  • 48. 47 Assessing SNP Data Tells you it’s a single base substitution Indicates alternate forms (here recorded on opposite strand) Indicates allele frequency if known Sometimes more frequency data at bottom of page
  • 49. 48 SNP Data Roughly Divided by Risk Trusted source Very low frequency No data, likely not going to be problematic Significant risk. Look to redesign if possible
  • 50. 49 Using OligoAnalzyer® Tool to Check Primers and Probes
  • 51. 50 Checking Primers with OligoAnalyzer® Tool  PrimerQuest® design tools give you the “best” assays for the region specified  They check for self- and hetero-dimers, but this is only part of the scoring system used  An assay maybe be “better” even with dimer issues if it scores well on other parameters  Go to the OligoAnalyzer Tool  Perform self-dimer checks for primers and probe  Perform heterodimer checks on all primer/probe combinations (especially important to include all combinations when multiplexing)  Check hairpin structures.  Look for stability of < -9 kcal/mol  Or multiple hairpins forming with < -4 kcal/mol
  • 52. 51 Assessing Dimer Data Looks stable < -9kcal/mol But this is not “dangerous”, avoid if possible but ok Looks stable < -9kcal/mol Not extendable, not a problem Doesn’t look stable > -9kcal/mol Danger of extension, exponential amplification!
  • 53. 52 Assessing Hairpin Structures  Based on UNAfold predictions
  • 54. IDT PrimeTime® Predesigned qPCR Database 53
  • 55. 54 Primer and Probe Design Criteria for PrimeTime® Assays  Primers  equal Tm (60–63oC)  15–30 bases in length  no runs of 4 or more Gs  amplicon size 50–150 bp (max 400 bp)  Probe  Probe length no longer than 30–35 bases  Tm value 4–10oC higher than primers  no runs of 4 or more consecutive Gs  G+C content 30–80%  no G at the 5′ end

Notas do Editor

  1. Sequences can be pasted in or Accession number can allow download of sequence. This is NOT just RefSeq sequences, it will find any accession number
  2. Important to note PrimerQuest will not look for introns, lower and upper case treated the same way. Clicking Orange buttons is preferred if possibleAmplicon size: general PCR 200-1000, qPCR 75-150 default
  3. The default for “set Design parameters for….” is General PCR. Must click the appropriate assay button first as the page will reload and give all defaults (removing any changes you made)First thing to try is just increasing number of assays returned and seeing if one matches the parameters of your design.
  4. Design across junction(s) allows you to specify intron junctions or to focus design on a specific location
  5. Just some examples of using parameters to restrict design to specific regions
  6. This is a place to discuss particularly GC or AT rich sequences. For AT rich need to increase max oligo length as well.
  7. The first link is the URL for the NCBI homepage. The first link to the right under Popular Resources is the link for the BLAST website. The BLAST program is directly accessible by using the link on the bottom of the slide.
  8. There are two different types of alignments: local and global. As the name implies, BLAST is a local alignment tool. Global alignments try to align each letter of the query sequence with the sequence in a database. A local alignment tries to find the best match without trying to align the entire sequence but breaks the query into smaller parts and aligns these smaller sequences. This approach is called a heuristic algorithm. A heuristic algorithm is one that uses knowledge about the problem to create a faster method to solve the problem. This will reduce the time of the search but will not always retrieve all sequences that have high identity.BLAST can also align two sequences together but this is generally not the best method for this type of alignment.BLAST can restrict a search by an Entrez query such as aligning a query to only a specific gene across all species in the database.
  9. This section has the most popular BLAST tools that give users the most flexibility.
  10. The concept of splitting the query into words is essential to understanding how BLAST works. The sequence above is 35 bases long. The box that position over the first 7-letters is the first 7-letter word. The next 7-letter word is the red box shifted one base to the right. Each subsequent word is one base shifted to the right until the end of the sequence is reached.
  11. Homology indicates that the proteins that are related which usually implies similar function but this is not necessary. An example of homologous proteins is human actin and mouse actin. Identity is the percent of bases (or amino acids) of aligned sequences that are exactly the same.Similarity is the percent of amino acids aligned that have either identical or have conserved properties.Hits are the same sequences returned by BLAST that aligned to the query. Homology is not the same as identity or similarity! These terms are frequently improperly used.
  12. The BLAST raw score is converted to a bit score for each alignment using parameters based on statistics described in Karlin et al. paper (http://www.ncbi.nlm.nih.gov/pmc/articles/PMC53667/pdf/pnas01031-0226.pdf). The details of the conversion are beyond the scope of this presentation. The Max bit score is the alignment with the highest bit score for a hit. For example, a primer may align in several places within a mRNA sequence all with different percent identity. The match with the highest identity will have the max bit score while the total score for that transcript will be the sum of all the matches. Blastn: For a given database, bit score is only dependent on the alignment, length of the sequence, and the length of the database. Technically, there are scoring matrices in blastn but these are not frequently changed.A high bit score does not indicate that the query is unique. A database that is completely composed of the same 30nt repeat will give the same bit score for a perfect match of that 30nt sequence as a database that only has this sequence once.
  13. This of course only works with genomic targets. But another chance to show some variations on BLAST that can give clearer resultsThe Database dropdown menu includes the first two radio button options on the top. Users can select the database from the dropdown menu and then click on the question mark to find more the sources of the data in this database, molecule type, update date, and number of sequences.The Nucleotide collection (nr/nt) is the most common choice for nucleotide information and this contains information from GenBank as well information from the European (EMBL) and Japanese (DDBJ) databases. This database also includes information from the Protein data bank (PDB) which is a depository for solved biology structures (mostly protein and nucleic acids). Nr stands for non-redundant, however, this database is full of redundancies. Reference RNA sequences are all RNA sequences that are curated by NCBI and deposited in RefSeq. RefSeq attempts to be non-redundant and more thoroughly annotated than the Nucleotide database.RefSeq genomic sequences is the DNA equivalent to the RNA RefSeq. 16S ribosomal RNA sequences is a new database that allows users to search just the 16S database of bacteria and Achaea. The nucleotide collection does not contain these ribosomal RNAs.
  14. Note that you can also increase the “expect threshold” to 1000
  15. Always good to give a sense of what the BLAST alignments are like. The thin line indicates the two matches are on the same sequence contig. If the bar is short at the 3’ end of either sequence it is likely not a concern
  16. The order that sequences are listed seems a bit random assuming they all have the same score.
  17. Two checks here: 1. does match extend full length of primers? 2. what is the distance between primers? For genomic matches like this a large distance may indicate an intron
  18. How to use the graphic interface
  19. When looking at other off-target matches it may be a pseudogene. This one is non-transcribed and so likely not a problem for an expression assay
  20. Some intron sequences hang around for a while so it’s not always clear if a pseudogene in an intron is a problem. Always best to avoid if possible but inform customer if necessary
  21. SNP analysis on BLAST can be temperamental but it is the simplest analysis so we’ll keep that here
  22. Remember to hover to get pop-up window then click on the rs number
  23. An example of unhelpful frequency data for a SNP.
  24. Examples of different frequencies and discussion of relative danger
  25. The delta G value represents the likelihood an oligo will form a specific structure. The more negative the value, the more spontaneously the oligo will form this structure and remain in this conformation. Therefore, the more negative the value, the stronger the structure. For most analyses, we recommend values less negative than -9 kcal/mole. However, this value is relatively conservative, especially for longer oligos. PCR and qPCR reactions can often perform with delta G’s of up to -12 kcal/mole.