Learn about various annotation package types
Learn the basics of querying these resources
Discuss annotations in regard to Bioc data structures
Get in some practice
26 June | Bioc 2016
Learn about various annotation package types
Learn the basics of querying these resources
Discuss annotations in regard to Bioc data structures
Get in some practice
Map a known ID to other functional or positional information
We have data and statistics, and we want to add other useful information
The end result might be as simple as a data.frame or HTML table, or as complex as a RangedSummarizedExperiment
load(system.file("data/eset.Rdata", package = "BiocAnno2016")) eset
## ExpressionSet (storageMode: lockedEnvironment) ## assayData: 33552 features, 6 samples ## element names: exprs ## protocolData: none ## phenoData ## sampleNames: GSM2194079 GSM2194080 ... GSM2194084 (6 total) ## varLabels: title characteristics_ch1.1 ## varMetadata: labelDescription ## featureData ## featureNames: 16657436 16657440 ... 17118478 (33552 total) ## fvarLabels: PROBEID ENTREZID SYMBOL GENENAME ## fvarMetadata: labelDescription ## experimentData: use 'experimentData(object)' ## Annotation: pd.hugene.2.0.st
head(exprs(eset))
## GSM2194079 GSM2194080 GSM2194081 GSM2194082 GSM2194083 GSM2194084 ## 16657436 8.505158 9.046577 8.382674 9.115481 8.715343 8.566301 ## 16657440 7.948860 8.191222 7.901911 8.459781 8.191793 8.219658 ## 16657450 10.932934 11.228553 10.948120 11.462231 11.300046 11.300886 ## 16657469 9.172462 9.344630 9.193450 9.465584 9.464020 9.135715 ## 16657473 6.222049 6.551035 6.000246 6.398798 5.892654 5.592125 ## 16657476 8.514300 8.474073 8.407196 8.811238 8.780833 8.874606
head(pData(phenoData(eset)))
## title characteristics_ch1.1 ## GSM2194079 SW620-miR625-rep1 shRNA: miR-625-3p ## GSM2194080 SW620-miR625-rep2 shRNA: miR-625-3p ## GSM2194081 SW620-miR625-rep3 shRNA: miR-625-3p ## GSM2194082 SW620-scramble-rep1 shRNA: scramble ## GSM2194083 SW620-scramble-rep2 shRNA: scramble ## GSM2194084 SW620-scramble-rep3 shRNA: scramble
head(pData(featureData(eset)))
## PROBEID ENTREZID SYMBOL ## 16657436 16657436 84771 DDX11L2 ## 16657440 16657440 100302278 MIR1302-2 ## 16657450 16657450 402483 LINC01000 ## 16657469 16657469 140849 LINC00266-1 ## 16657473 16657473 729759 OR4F29 ## 16657476 16657476 388574 RPL23AP87 ## GENENAME ## 16657436 DEAD/H-box helicase 11 like 2 ## 16657440 microRNA 1302-2 ## 16657450 long intergenic non-protein coding RNA 1000 ## 16657469 long intergenic non-protein coding RNA 266-1 ## 16657473 olfactory receptor family 4 subfamily F member 29 ## 16657476 ribosomal protein L23a pseudogene 87
Validity checking
Subsetting
Function dispatch
Automatic behaviors
Difficult to create
Cumbersome to extract data by hand
Useful only within R
Package type | Example |
---|---|
ChipDb | hugene20sttranscriptcluster.db |
OrgDb | org.Hs.eg.db |
TxDb/EnsDb | TxDb.Hsapiens.UCSC.hg19.knownGene; EnsDb.Hsapiens.v75 |
OrganismDb | Homo.sapiens |
BSgenome | BSgenome.Hsapiens.UCSC.hg19 |
Others | GO.db; KEGG.db |
AnnotationHub | Online resource |
biomaRt | Online resource |
The main function is select
:
select(annopkg, keys, columns, keytype)
Where
annopkg is the annotation package
keys are the IDs that we know
columns are the values we want
Say we have analyzed data from an Affymetrix Human Gene ST 2.0 array and want to know what the genes are. For purposes of this lab, we just select some IDs at random.
library(hugene20sttranscriptcluster.db) set.seed(12345) ids <- featureNames(eset)[sample(1:25000, 5)] ids
## [1] "16908472" "16962185" "16920686" "16965513" "16819952"
select(hugene20sttranscriptcluster.db, ids, "SYMBOL")
## 'select()' returned 1:1 mapping between keys and columns
## PROBEID SYMBOL ## 1 16908472 LINC01494 ## 2 16962185 ALG3 ## 3 16920686 <NA> ## 4 16965513 <NA> ## 5 16819952 CBFB
How do you know what the central keys are?
If it's a ChipDb, the central key are the manufacturer's probe IDs
It's sometimes in the name - org.Hs.eg.db, where 'eg' means Entrez Gene ID
You can see examples using e.g., head(keys(annopkg)), and infer from that
But note that it's never necessary to know the central key, as long as you specify the keytype
What keytypes or columns are available for a given annotation package?
keytypes(hugene20sttranscriptcluster.db)
## [1] "ACCNUM" "ALIAS" "ENSEMBL" "ENSEMBLPROT" ## [5] "ENSEMBLTRANS" "ENTREZID" "ENZYME" "EVIDENCE" ## [9] "EVIDENCEALL" "GENENAME" "GO" "GOALL" ## [13] "IPI" "MAP" "OMIM" "ONTOLOGY" ## [17] "ONTOLOGYALL" "PATH" "PFAM" "PMID" ## [21] "PROBEID" "PROSITE" "REFSEQ" "SYMBOL" ## [25] "UCSCKG" "UNIGENE" "UNIPROT"
columns(hugene20sttranscriptcluster.db)
## [1] "ACCNUM" "ALIAS" "ENSEMBL" "ENSEMBLPROT" ## [5] "ENSEMBLTRANS" "ENTREZID" "ENZYME" "EVIDENCE" ## [9] "EVIDENCEALL" "GENENAME" "GO" "GOALL" ## [13] "IPI" "MAP" "OMIM" "ONTOLOGY" ## [17] "ONTOLOGYALL" "PATH" "PFAM" "PMID" ## [21] "PROBEID" "PROSITE" "REFSEQ" "SYMBOL" ## [25] "UCSCKG" "UNIGENE" "UNIPROT"
There is one issue with select
however.
ids <- c('16737401','16657436' ,'16678303') select(hugene20sttranscriptcluster.db, ids, c("SYMBOL","MAP"))
## 'select()' returned 1:many mapping between keys and columns
## PROBEID SYMBOL MAP ## 1 16737401 TRAF6 11p12 ## 2 16657436 DDX11L2 2q13 ## 3 16657436 DDX11L9 15q26.3 ## 4 16657436 DDX11L10 16p13.3 ## 5 16657436 DDX11L1 1p36.33 ## 6 16657436 DDX11L5 9p24.3 ## 7 16657436 DDX11L16 Xq28 ## 8 16657436 DDX11L16 Yq12 ## 9 16657436 DDX11L12 <NA> ## 10 16657436 DDX11L11 17p13.3 ## 11 16678303 ARF1 1q42 ## 12 16678303 MIR3620 <NA>
mapIds
functionAn alternative to select
is mapIds
, which gives control of duplicates
Same arguments as select
with slight differences
The columns argument can only specify one column
The keytype argument must be specified
An additional argument, multiVals used to control duplicates
mapIds(hugene20sttranscriptcluster.db, ids, "SYMBOL", "PROBEID")
## 'select()' returned 1:many mapping between keys and columns
## 16737401 16657436 16678303 ## "TRAF6" "DDX11L2" "ARF1"
Default is first
, where we just choose the first of the duplicates. Other choices are list
, CharacterList
, filter
, asNA
or a user-specified function.
mapIds(hugene20sttranscriptcluster.db, ids, "SYMBOL", "PROBEID", multiVals = "list")
## 'select()' returned 1:many mapping between keys and columns
## $`16737401` ## [1] "TRAF6" ## ## $`16657436` ## [1] "DDX11L2" "DDX11L9" "DDX11L10" "DDX11L1" "DDX11L5" "DDX11L16" ## [7] "DDX11L12" "DDX11L11" ## ## $`16678303` ## [1] "ARF1" "MIR3620"
mapIds(hugene20sttranscriptcluster.db, ids, "SYMBOL", "PROBEID", multiVals = "CharacterList")
## 'select()' returned 1:many mapping between keys and columns
## CharacterList of length 3 ## [["16737401"]] TRAF6 ## [["16657436"]] DDX11L2 DDX11L9 DDX11L10 ... DDX11L16 DDX11L12 DDX11L11 ## [["16678303"]] ARF1 MIR3620
mapIds(hugene20sttranscriptcluster.db, ids, "SYMBOL", "PROBEID", multiVals = "filter")
## 'select()' returned 1:many mapping between keys and columns
## 16737401 ## "TRAF6"
mapIds(hugene20sttranscriptcluster.db, ids, "SYMBOL", "PROBEID", multiVals = "asNA")
## 'select()' returned 1:many mapping between keys and columns
## 16737401 16657436 16678303 ## "TRAF6" NA NA
Using either the hugene20sttranscriptcluster.db or org.Hs.eg.db package,
What gene symbol corresponds to Entrez Gene ID 1000?
What is the Ensembl Gene ID for PPARG?
What is the UniProt ID for GAPDH?
How many of the probesets from the ExpressionSet (eset) we loaded map to a single gene? How many don't map to a gene at all?
TxDb packages contain positional information; the contents can be inferred by the package name
TxDb.Species.Source.Build.Table
TxDb.Hsapiens.UCSC.hg19.knownGene
Homo sapiens
UCSC genome browser
hg19 (their version of GRCh37)
knownGene table
TxDb.Dmelanogaster.UCSC.dm3.ensGene TxDb.Athaliana.BioMart.plantsmart22
EnsDb packages are similar to TxDb packages, but based on Ensembl mappings
EnsDb.Hsapiens.v79
EnsDb.Mmusculus.v79
EnsDb.Rnorvegicus.v79
As with ChipDb and OrgDb packages, select
and mapIds
can be used to make queries
select(TxDb.Hsapiens.UCSC.hg19.knownGene, c("1","10"), c("TXNAME","TXCHROM","TXSTART","TXEND"), "GENEID")
## 'select()' returned 1:many mapping between keys and columns
## GENEID TXNAME TXCHROM TXSTART TXEND ## 1 1 uc002qsd.4 chr19 58858172 58864865 ## 2 1 uc002qsf.2 chr19 58859832 58874214 ## 3 10 uc003wyw.1 chr8 18248755 18258723
select(EnsDb.Hsapiens.v79, c("1", "10"), c("GENEID","GENENAME","SEQNAME","GENESEQSTART","GENESEQEND"), "ENTREZID")
## ENTREZID GENEID GENENAME SEQNAME GENESEQSTART GENESEQEND ## 1 1 ENSG00000121410 A1BG 19 58345178 58353499 ## 2 10 ENSG00000156006 NAT2 8 18391245 18401218
But this is not how one normally uses them…
The normal use case for transcript packages is to extract positional information into a GRanges
or GRangesList
object. An example is the genomic position of all genes:
gns <- genes(TxDb.Hsapiens.UCSC.hg19.knownGene) gns
## GRanges object with 23056 ranges and 1 metadata column: ## seqnames ranges strand | gene_id ## <Rle> <IRanges> <Rle> | <character> ## 1 chr19 [ 58858172, 58874214] - | 1 ## 10 chr8 [ 18248755, 18258723] + | 10 ## 100 chr20 [ 43248163, 43280376] - | 100 ## 1000 chr18 [ 25530930, 25757445] - | 1000 ## 10000 chr1 [243651535, 244006886] - | 10000 ## ... ... ... ... . ... ## 9991 chr9 [114979995, 115095944] - | 9991 ## 9992 chr21 [ 35736323, 35743440] + | 9992 ## 9993 chr22 [ 19023795, 19109967] - | 9993 ## 9994 chr6 [ 90539619, 90584155] + | 9994 ## 9997 chr22 [ 50961997, 50964905] - | 9997 ## ------- ## seqinfo: 93 sequences (1 circular) from hg19 genome
Or the genomic position of all transcripts by gene:
txs <- transcriptsBy(TxDb.Hsapiens.UCSC.hg19.knownGene) txs
## GRangesList object of length 23459: ## $1 ## GRanges object with 2 ranges and 2 metadata columns: ## seqnames ranges strand | tx_id tx_name ## <Rle> <IRanges> <Rle> | <integer> <character> ## [1] chr19 [58858172, 58864865] - | 70455 uc002qsd.4 ## [2] chr19 [58859832, 58874214] - | 70456 uc002qsf.2 ## ## $10 ## GRanges object with 1 range and 2 metadata columns: ## seqnames ranges strand | tx_id tx_name ## [1] chr8 [18248755, 18258723] + | 31944 uc003wyw.1 ## ## $100 ## GRanges object with 1 range and 2 metadata columns: ## seqnames ranges strand | tx_id tx_name ## [1] chr20 [43248163, 43280376] - | 72132 uc002xmj.3 ## ## ... ## <23456 more elements> ## ------- ## seqinfo: 93 sequences (1 circular) from hg19 genome
Positional information can be extracted for transcripts
, genes
, coding sequences (cds
), promoters
and exons
.
Positional information can be extracted for most of the above, grouped by a second element. For example, our transcriptsBy
call was all transcripts, grouped by gene.
More detail on these *Ranges objects is beyond the scope of this workshop, but why we want them is not.
The main rationale for *Ranges objects is to allow us to easily select and subset data based on genomic position information. This is really powerful!
GRanges
and GRangesLists
act like data.frames and lists, and can be subsetted using the [
function. As a really artificial example:
txs[txs %over% gns[1:2,]]
## GRangesList object of length 3: ## $1 ## GRanges object with 2 ranges and 2 metadata columns: ## seqnames ranges strand | tx_id tx_name ## <Rle> <IRanges> <Rle> | <integer> <character> ## [1] chr19 [58858172, 58864865] - | 70455 uc002qsd.4 ## [2] chr19 [58859832, 58874214] - | 70456 uc002qsf.2 ## ## $10 ## GRanges object with 1 range and 2 metadata columns: ## seqnames ranges strand | tx_id tx_name ## [1] chr8 [18248755, 18258723] + | 31944 uc003wyw.1 ## ## $162968 ## GRanges object with 2 ranges and 2 metadata columns: ## seqnames ranges strand | tx_id tx_name ## [1] chr19 [58865723, 58874214] - | 70457 uc002qsh.2 ## [2] chr19 [58865723, 58874214] - | 70458 uc002qsi.2 ## ## ------- ## seqinfo: 93 sequences (1 circular) from hg19 genome
Gene expression changes near differentially methylated CpG islands
Closest genes to a set of interesting SNPs
Genes near DNAseI hypersensitivity clusters
Number of CpGs measured over Gene X by Chip Y
SummarizedExperiment objects are like ExpressionSets, but the row-wise annotations are GRanges, so you can subset by genomic locations:
How many transcripts does PPARG have, according to UCSC?
Does Ensembl agree?
GRanges
like this - GRanges("chr2", IRanges(2858473,3271812))
OrganismDb packages are meta-packages that contain an OrgDb, a TxDb, and a GO.db package and allow cross-queries between those packages.
All previous accessors work; select
, mapIds
, transcripts
, etc.
library(Homo.sapiens) Homo.sapiens
## OrganismDb Object: ## # Includes GODb Object: GO.db ## # With data about: Gene Ontology ## # Includes OrgDb Object: org.Hs.eg.db ## # Gene data about: Homo sapiens ## # Taxonomy Id: 9606 ## # Includes TxDb Object: TxDb.Hsapiens.UCSC.hg19.knownGene ## # Transcriptome data about: Homo sapiens ## # Based on genome: hg19 ## # The OrgDb gene id ENTREZID is mapped to the TxDb gene id GENEID .
Updateable - can change TxDb object
columns and keytypes span all underlying objects
Calls to TxDb accessors include a 'columns' argument
head(genes(Homo.sapiens, columns = c("ENTREZID","ALIAS","UNIPROT")),4)
## 'select()' returned 1:many mapping between keys and columns
## GRanges object with 4 ranges and 3 metadata columns: ## seqnames ranges strand | ALIAS ## <Rle> <IRanges> <Rle> | <CharacterList> ## 1 chr19 [58858172, 58874214] - | A1B,ABG,GAB,... ## 10 chr8 [18248755, 18258723] + | AAC2,NAT-2,PNAT,... ## 100 chr20 [43248163, 43280376] - | ADA ## 1000 chr18 [25530930, 25757445] - | CD325,CDHN,CDw325,... ## UNIPROT ENTREZID ## <CharacterList> <FactorList> ## 1 P04217,V9HWD8 1 ## 10 A4Z6T7,P11245 10 ## 100 A0A0S2Z381,P00813,F5GWI4 100 ## 1000 P19022,A0A024RC42 1000 ## ------- ## seqinfo: 93 sequences (1 circular) from hg19 genome
Get all the GO terms for BRCA1
What gene does the UCSC transcript ID uc002fai.3 map to?
How many other transcripts does that gene have?
Get all the transcripts from the hg19 genome build, along with their Ensembl gene ID, UCSC transcript ID and gene symbol
BSgenome packages contain sequence information for a given species/build. There are many such packages - you can get a listing using available.genomes
library(BSgenome) head(available.genomes())
## [1] "BSgenome.Alyrata.JGI.v1" ## [2] "BSgenome.Amellifera.BeeBase.assembly4" ## [3] "BSgenome.Amellifera.UCSC.apiMel2" ## [4] "BSgenome.Amellifera.UCSC.apiMel2.masked" ## [5] "BSgenome.Athaliana.TAIR.04232008" ## [6] "BSgenome.Athaliana.TAIR.TAIR9"
We can load and inspect a BSgenome package
library(BSgenome.Hsapiens.UCSC.hg19) Hsapiens
## Human genome: ## # organism: Homo sapiens (Human) ## # provider: UCSC ## # provider version: hg19 ## # release date: Feb. 2009 ## # release name: Genome Reference Consortium GRCh37 ## # 93 sequences: ## # chr1 chr2 chr3 ## # chr4 chr5 chr6 ## # chr7 chr8 chr9 ## # chr10 chr11 chr12 ## # chr13 chr14 chr15 ## # ... ... ... ## # chrUn_gl000235 chrUn_gl000236 chrUn_gl000237 ## # chrUn_gl000238 chrUn_gl000239 chrUn_gl000240 ## # chrUn_gl000241 chrUn_gl000242 chrUn_gl000243 ## # chrUn_gl000244 chrUn_gl000245 chrUn_gl000246 ## # chrUn_gl000247 chrUn_gl000248 chrUn_gl000249 ## # (use 'seqnames()' to see all the sequence names, use the '$' or '[[' ## # operator to access a given sequence)
The main accessor is getSeq
, and you can get data by sequence (e.g., entire chromosome or unplaced scaffold), or by passing in a GRanges object, to get just a region.
getSeq(Hsapiens, "chr1")
## 249250621-letter "DNAString" instance ## seq: NNNNNNNNNNNNNNNNNNNNNNNNNNNNNNNNNN...NNNNNNNNNNNNNNNNNNNNNNNNNNNNNNNNN
getSeq(Hsapiens, gns["5467",])
## A DNAStringSet instance of length 1 ## width seq names ## [1] 85634 GCGGAGCGTGTGACGCTGCGG...TATTTAAGAGCTGACTGGAA 5467
The Biostrings package contains most of the code for dealing with these *StringSet
objects - please see the Biostrings vignettes and help pages for more information.
AnnotationHub is a package that allows us to query and download many different annotation objects, without having to explicitly install them.
library(AnnotationHub) hub <- AnnotationHub()
## snapshotDate(): 2016-06-06
hub
## AnnotationHub with 43720 records ## # snapshotDate(): 2016-06-06 ## # $dataprovider: BroadInstitute, UCSC, Ensembl, EncodeDCC, NCBI, ftp://... ## # $species: Homo sapiens, Mus musculus, Bos taurus, Pan troglodytes, Da... ## # $rdataclass: GRanges, BigWigFile, FaFile, OrgDb, TwoBitFile, ChainFil... ## # additional mcols(): taxonomyid, genome, description, ## # preparerclass, tags, sourceurl, sourcetype ## # retrieve records with, e.g., 'object[["AH2"]]' ## ## title ## AH2 | Ailuropoda_melanoleuca.ailMel1.69.dna.toplevel.fa ## AH3 | Ailuropoda_melanoleuca.ailMel1.69.dna_rm.toplevel.fa ## AH4 | Ailuropoda_melanoleuca.ailMel1.69.dna_sm.toplevel.fa ## AH5 | Ailuropoda_melanoleuca.ailMel1.69.ncrna.fa ## AH6 | Ailuropoda_melanoleuca.ailMel1.69.pep.all.fa ## ... ... ## AH50771 | Xiphophorus_maculatus.Xipmac4.4.2.dna.toplevel.2bit ## AH50772 | Xiphophorus_maculatus.Xipmac4.4.2.ncrna.2bit ## AH50773 | Vvinifera_CRIBI_IGGP12Xv0_V2.1.gff3.Rdata ## AH50774 | Vvinifera_Genoscope_IGGP12Xv0_V1.0.gff3.Rdata ## AH50775 | Vvinifera_Genoscope_IGGP8X_V1.0.gff3.Rdata
Finding the 'right' resource on AnnotationHub is like using Google - a well posed query is necessary to find what you are after. Useful queries are based on
Data provider
Data class
Species
Data source
names(mcols(hub))
## [1] "title" "dataprovider" "species" "taxonomyid" ## [5] "genome" "description" "preparerclass" "tags" ## [9] "rdataclass" "sourceurl" "sourcetype"
unique(hub$dataprovider)
## [1] "Ensembl" ## [2] "EncodeDCC" ## [3] "UCSC" ## [4] "RefNet" ## [5] "Inparanoid8" ## [6] "NCBI" ## [7] "NHLBI" ## [8] "ChEA" ## [9] "Pazar" ## [10] "NIH Pathway Interaction Database" ## [11] "Haemcode" ## [12] "GEO" ## [13] "BroadInstitute" ## [14] "ftp://ftp.ncbi.nlm.nih.gov/gene/DATA/" ## [15] "PRIDE" ## [16] "Gencode" ## [17] "dbSNP" ## [18] "CRIBI" ## [19] "Genoscope"
unique(hub$rdataclass)
## [1] "FaFile" "GRanges" "data.frame" ## [4] "Inparanoid8Db" "OrgDb" "TwoBitFile" ## [7] "ChainFile" "SQLiteConnection" "biopax" ## [10] "BigWigFile" "ExpressionSet" "AAStringSet" ## [13] "MSnSet" "mzRpwiz" "mzRident" ## [16] "VcfFile"
head(unique(hub$species))
## [1] "Ailuropoda melanoleuca" "Anolis carolinensis" ## [3] "Bos taurus" "Caenorhabditis elegans" ## [5] "Callithrix jacchus" "Canis familiaris"
length(unique(hub$species))
## [1] 1946
unique(hub$sourcetype)
## [1] "FASTA" "BED" "UCSC track" "GTF" ## [5] "TSV" "Inparanoid" "NCBI/blast2GO" "TwoBit" ## [9] "Chain" "GRASP" "Zip" "CSV" ## [13] "BioPax" "BioPaxLevel2" "RData" "BigWig" ## [17] "tar.gz" "tab" "NCBI/UniProt" "mzTab" ## [21] "mzML" "mzid" "GFF" "NCBI/ensembl" ## [25] "VCF"
qry <- query(hub, c("granges","homo sapiens","ensembl")) qry
## AnnotationHub with 20 records ## # snapshotDate(): 2016-06-06 ## # $dataprovider: Ensembl, UCSC ## # $species: Homo sapiens ## # $rdataclass: GRanges ## # additional mcols(): taxonomyid, genome, description, ## # preparerclass, tags, sourceurl, sourcetype ## # retrieve records with, e.g., 'object[["AH5046"]]' ## ## title ## AH5046 | Ensembl Genes ## AH5160 | Ensembl Genes ## AH5311 | Ensembl Genes ## AH5434 | Ensembl Genes ## AH5435 | Ensembl EST Genes ## ... ... ## AH28812 | Homo_sapiens.GRCh38.77.gtf ## AH47066 | Homo_sapiens.GRCh38.80.gtf ## AH47963 | Homo_sapiens.GRCh38.81.gtf ## AH50308 | Homo_sapiens.GRCh38.82.gtf ## AH50377 | Homo_sapiens.GRCh38.83.gtf
qry$sourceurl
## [1] "rtracklayer://hgdownload.cse.ucsc.edu/goldenpath/hg19/database/ensGene" ## [2] "rtracklayer://hgdownload.cse.ucsc.edu/goldenpath/hg18/database/ensGene" ## [3] "rtracklayer://hgdownload.cse.ucsc.edu/goldenpath/hg17/database/ensGene" ## [4] "rtracklayer://hgdownload.cse.ucsc.edu/goldenpath/hg16/database/ensGene" ## [5] "rtracklayer://hgdownload.cse.ucsc.edu/goldenpath/hg16/database/ensEstGene" ## [6] "ftp://ftp.ensembl.org/pub/release-70/gtf/homo_sapiens/Homo_sapiens.GRCh37.70.gtf.gz" ## [7] "ftp://ftp.ensembl.org/pub/release-69/gtf/homo_sapiens/Homo_sapiens.GRCh37.69.gtf.gz" ## [8] "ftp://ftp.ensembl.org/pub/release-71/gtf/homo_sapiens/Homo_sapiens.GRCh37.71.gtf.gz" ## [9] "ftp://ftp.ensembl.org/pub/release-72/gtf/homo_sapiens/Homo_sapiens.GRCh37.72.gtf.gz" ## [10] "ftp://ftp.ensembl.org/pub/release-73/gtf/homo_sapiens/Homo_sapiens.GRCh37.73.gtf.gz" ## [11] "ftp://ftp.ensembl.org/pub/release-74/gtf/homo_sapiens/Homo_sapiens.GRCh37.74.gtf.gz" ## [12] "ftp://ftp.ensembl.org/pub/release-75/gtf/homo_sapiens/Homo_sapiens.GRCh37.75.gtf.gz" ## [13] "ftp://ftp.ensembl.org/pub/release-78/gtf/homo_sapiens/Homo_sapiens.GRCh38.78.gtf.gz" ## [14] "ftp://ftp.ensembl.org/pub/release-76/gtf/homo_sapiens/Homo_sapiens.GRCh38.76.gtf.gz" ## [15] "ftp://ftp.ensembl.org/pub/release-79/gtf/homo_sapiens/Homo_sapiens.GRCh38.79.gtf.gz" ## [16] "ftp://ftp.ensembl.org/pub/release-77/gtf/homo_sapiens/Homo_sapiens.GRCh38.77.gtf.gz" ## [17] "ftp://ftp.ensembl.org/pub/release-80/gtf/homo_sapiens/Homo_sapiens.GRCh38.80.gtf.gz" ## [18] "ftp://ftp.ensembl.org/pub/release-81/gtf/homo_sapiens/Homo_sapiens.GRCh38.81.gtf.gz" ## [19] "ftp://ftp.ensembl.org/pub/release-82/gtf/homo_sapiens/Homo_sapiens.GRCh38.82.gtf.gz" ## [20] "ftp://ftp.ensembl.org/pub/release-83/gtf/homo_sapiens/Homo_sapiens.GRCh38.83.gtf.gz"
whatIwant <- qry[["AH50377"]]
We can use these data as they are, or convert to a TxDb format:
GRCh38TxDb <- makeTxDbFromGRanges(whatIwant) GRCh38TxDb
## TxDb object: ## # Db type: TxDb ## # Supporting package: GenomicFeatures ## # Genome: GRCh38 ## # transcript_nrow: 199184 ## # exon_nrow: 675836 ## # cds_nrow: 270225 ## # Db created by: GenomicFeatures package from Bioconductor ## # Creation time: 2016-06-22 19:26:00 +0000 (Wed, 22 Jun 2016) ## # GenomicFeatures version at creation time: 1.25.12 ## # RSQLite version at creation time: 1.0.0 ## # DBSCHEMAVERSION: 1.1
How many resources are on AnnotationHub for Atlantic salmon (Salmo salar)?
Get the most recent Ensembl build for domesticated dog (Canis familiaris) and make a TxDb
The biomaRt package allows queries to an Ensembl Biomart server. We can see the choices of servers that we can use:
library(biomaRt) listMarts()
## biomart version ## 1 ENSEMBL_MART_ENSEMBL Ensembl Genes 84 ## 2 ENSEMBL_MART_SNP Ensembl Variation 84 ## 3 ENSEMBL_MART_FUNCGEN Ensembl Regulation 84 ## 4 ENSEMBL_MART_VEGA Vega 64
And we can then check for the available data sets on a particular server.
mart <- useMart("ENSEMBL_MART_ENSEMBL") head(listDatasets(mart))
## dataset ## 1 oanatinus_gene_ensembl ## 2 cporcellus_gene_ensembl ## 3 gaculeatus_gene_ensembl ## 4 itridecemlineatus_gene_ensembl ## 5 lafricana_gene_ensembl ## 6 choffmanni_gene_ensembl ## description version ## 1 Ornithorhynchus anatinus genes (OANA5) OANA5 ## 2 Cavia porcellus genes (cavPor3) cavPor3 ## 3 Gasterosteus aculeatus genes (BROADS1) BROADS1 ## 4 Ictidomys tridecemlineatus genes (spetri2) spetri2 ## 5 Loxodonta africana genes (loxAfr3) loxAfr3 ## 6 Choloepus hoffmanni genes (choHof1) choHof1
After setting up a mart
object pointing to the server and data set that we care about, we can make queries. We first set up the mart
object.
mart <- useMart("ENSEMBL_MART_ENSEMBL","hsapiens_gene_ensembl")
Queries are of the form
getBM(attributes, filters, values, mart)
where
attributes are the things we want
filters are the types of IDs we have
values are the IDs we have
mart is the mart
object we set up
Both attributes and filters have rather inscrutable names, but a listing can be accessed using
atrib <- listAttributes(mart) filts <- listFilters(mart) head(atrib)
## name description page ## 1 ensembl_gene_id Ensembl Gene ID feature_page ## 2 ensembl_transcript_id Ensembl Transcript ID feature_page ## 3 ensembl_peptide_id Ensembl Protein ID feature_page ## 4 ensembl_exon_id Ensembl Exon ID feature_page ## 5 description Description feature_page ## 6 chromosome_name Chromosome Name feature_page
head(filts)
## name description ## 1 chromosome_name Chromosome name ## 2 start Gene Start (bp) ## 3 end Gene End (bp) ## 4 band_start Band Start ## 5 band_end Band End ## 6 marker_start Marker Start
A simple example query
afyids <- c("1000_at","1001_at","1002_f_at","1007_s_at") getBM(c("affy_hg_u95av2", "hgnc_symbol"), c("affy_hg_u95av2"), afyids, mart)
## affy_hg_u95av2 hgnc_symbol ## 1 1000_at MAPK3 ## 2 1002_f_at CYP2C19 ## 3 1002_f_at ## 4 1001_at TIE1 ## 5 1007_s_at DDR1
Get the Ensembl gene IDs and HUGO symbol for Entrez Gene IDs 672, 5468 and 7157
What do you get if you query for the 'gene_exon' for GAPDH?