bioconductor v3.9.0 OrganismDbi

The package enables a simple unified interface to several

Link to this section Summary

Functions

MultiDb and OrganismDb objects

Map range coordinates between transcripts and genome space

Make a OrganismDb object from annotations available on a BioMart database

Make an OrganismDb object from an existing TxDb object.

Make a OrganismDb object from annotations available at the UCSC Genome Browser

Making OrganismDb packages from annotation packages.

Extract genomic features from an object

Link to this section Functions

MultiDb and OrganismDb objects

Description

The OrganismDb class is a container for storing knowledge about existing Annotation packages and the relationships between these resources. The purpose of this object and it's associated methods is to provide a means by which users can conveniently query for data from several different annotation resources at the same time using a familiar interface.

The supporting methods select , columns and keys are used together to extract data from an OrganismDb object in a manner that should be consistent with how these are used on the supporting annotation resources.

The family of seqinfo style getters ( seqinfo , seqlevels , seqlengths , isCircular , genome , and seqnameStyle ) is also supported for OrganismDb objects provided that the object in question has an embedded TxDb object.

Seealso

  • AnnotationDb-class for more descriptsion of methods select , keytypes , keys and columns .

  • makeOrganismPackage for functions used to generate an OrganismDb based package.

  • rangeBasedAccessors for the range based methods used in extracting data from a OrganismDb object.

  • list("GenomeInfoDb") .

  • list("seqlevels") .

  • list("seqlengths") .

  • list("isCircular") .

  • list("genome") .

Author

Marc Carlson

Examples

## load a package that creates an OrganismDb
library(Homo.sapiens)
ls(2)
## then the methods can be used on this object.
columns <- columns(Homo.sapiens)[c(7,10,11,12)]
keys <- head(keys(org.Hs.eg.db, "ENTREZID"))
keytype <- "ENTREZID"
res <- select(Homo.sapiens, keys, columns, keytype)
head(res)
res <-  mapIds(Homo.sapiens, keys=c('1','10'), column='ALIAS',
keytype='ENTREZID',  multiVals="CharacterList")

## get symbols for ranges in question:
ranges <-  GRanges(seqnames=Rle(c('chr11'), c(2)),
IRanges(start=c(107899550, 108025550),
end=c(108291889, 108050000)), strand='*',
seqinfo=seqinfo(Homo.sapiens))
selectByRanges(Homo.sapiens, ranges, 'SYMBOL')

## Or extract the gene model for the 'A1BG' gene:
selectRangesById(Homo.sapiens, 'A1BG', keytype='SYMBOL')


## Get the DB connections or DB file paths associated with those for
## each.
dbconn(Homo.sapiens)
dbfile(Homo.sapiens)

## extract the taxonomyId
taxonomyId(Homo.sapiens)

##extract the resources
resources(Homo.sapiens)
Link to this function

coordinate_mapping_method()

Map range coordinates between transcripts and genome space

Description

Map range coordinates between features in the transcriptome and genome (reference) space.

See ? in the GenomicAlignments package for mapping coordinates between reads (local) and genome (reference) space using a CIGAR alignment.

Usage

list(list("mapToTranscripts"), list("ANY,MultiDb"))(x, transcripts,
          ignore.strand = TRUE,
          extractor.fun = GenomicFeatures::transcripts, ...)

Arguments

ArgumentDescription
xGRanges-class object of positions to be mapped. x must have names when mapping to the genome.
transcriptsThe OrganismDb object that will be used to extract features using the extractor.fun .
ignore.strandWhen TRUE, strand is ignored in overlap operations.
extractor.funFunction to extract genomic features from a TxDb object. Valid extractor functions:
  • transcripts ## default

  • exons

  • cds

  • genes

  • promoters

  • disjointExons

  • microRNAs

  • tRNAs

  • transcriptsBy

  • exonsBy

  • cdsBy

  • intronsByTranscript

  • fiveUTRsByTranscript

  • threeUTRsByTranscript
    |list() | Additional arguments passed to extractor.fun functions. |

Details

  • list(list("mapToTranscripts")) list(" ", " The genomic range in ", list("x"), " is mapped to the local position in the ", " ", list("transcripts"), " ranges. A successful mapping occurs when ", list("x"), " ", " is completely within the ", list("transcripts"), " range, equivalent to: ", " ", list(" ", " findOverlaps(..., type="within") ", " "), " ", " Transcriptome-based coordinates start counting at 1 at the beginning ", " of the ", list("transcripts"), " range and return positions where ", list("x"), " ", " was aligned. The seqlevels of the return object are taken from the ", " ", list("transcripts"), " object and should be transcript names. In this ", " direction, mapping is attempted between all elements of ", list("x"), " and ", " all elements of ", list("transcripts"), ". ", " ")

Value

An object the same class as x .

Parallel methods return an object the same shape as x . Ranges that cannot be mapped (out of bounds or strand mismatch) are returned as zero-width ranges starting at 0 with a seqname of "UNMAPPED".

Non-parallel methods return an object that varies in length similar to a Hits object. The result only contains mapped records, strand mismatch and out of bound ranges are not returned. xHits and transcriptsHits metadata columns indicate the elements of x and transcripts used in the mapping.

When present, names from x are propagated to the output. When mapping to transcript coordinates, seqlevels of the output are the names on the transcripts object; most often these will be transcript names. When mapping to the genome, seqlevels of the output are the seqlevels of transcripts which are usually chromosome names.

Seealso

  • list("mapToTranscripts") .

Author

V. Obenchain, M. Lawrence and H. Pagès; ported to work with OrganismDbi by Marc Carlson

Examples

## ---------------------------------------------------------------------
## A. Basic Use
## ---------------------------------------------------------------------

library(Homo.sapiens)
x <- GRanges("chr5",
IRanges(c(173315331,174151575), width=400,
names=LETTERS[1:2]))

## Map to transcript coordinates:
mapToTranscripts(x, Homo.sapiens)
Link to this function

makeOrganismDbFromBiomart()

Make a OrganismDb object from annotations available on a BioMart database

Description

The makeOrganismDbFromBiomart function allows the user to make a OrganismDb object from transcript annotations available on a BioMart database. This object has all the benefits of a TxDb, plus an associated OrgDb and GODb object.

Usage

makeOrganismDbFromBiomart(biomart="ENSEMBL_MART_ENSEMBL",
                    dataset="hsapiens_gene_ensembl",
                    transcript_ids=NULL,
                    circ_seqs=DEFAULT_CIRC_SEQS,
                    filter="",
                    id_prefix="ensembl_",
                    host="www.ensembl.org",
                    port=80,
                    miRBaseBuild=NA,
                    keytype = "ENSEMBL",
                    orgdb = NA)

Arguments

ArgumentDescription
biomartwhich BioMart database to use. Get the list of all available BioMart databases with the listMarts function from the biomaRt package. See the details section below for a list of BioMart databases with compatible transcript annotations.
datasetwhich dataset from BioMart. For example: "hsapiens_gene_ensembl" , "mmusculus_gene_ensembl" , "dmelanogaster_gene_ensembl" , "celegans_gene_ensembl" , "scerevisiae_gene_ensembl" , etc in the ensembl database. See the examples section below for how to discover which datasets are available in a given BioMart database.
transcript_idsoptionally, only retrieve transcript annotation data for the specified set of transcript ids. If this is used, then the meta information displayed for the resulting TxDb object will say 'Full dataset: no'. Otherwise it will say 'Full dataset: yes'. This TxDb object will be embedded in the resulting OrganismDb object.
circ_seqsa character vector to list out which chromosomes should be marked as circular.
filterAdditional filters to use in the BioMart query. Must be a named list. An example is filter=as.list(c(source="entrez"))
hostThe host URL of the BioMart. Defaults to www.ensembl.org.
portThe port to use in the HTTP communication with the host.
id_prefixSpecifies the prefix used in BioMart attributes. For example, some BioMarts may have an attribute specified as "ensembl_transcript_id" whereas others have the same attribute specified as "transcript_id" . Defaults to "ensembl_" .
miRBaseBuildspecify the string for the appropriate build Information from mirbase.db to use for microRNAs. This can be learned by calling supportedMiRBaseBuildValues . By default, this value will be set to NA , which will inactivate the microRNAs accessor.
keytypeThis indicates the kind of key that this database will use as a foreign key between it's TxDb object and it's OrgDb object. So basically whatever the column name is for the foreign key from your OrgDb that your TxDb will need to map it's GENEID on to. By default it is "ENSEMBL" since the GENEID's for most biomaRt based TxDbs will be ensembl gene ids and therefore they will need to map to ENSEMBL gene mappings from the associated OrgDb object.
orgdbBy default, makeOrganismDbFromBiomart will use the taxonomyID from your txdb to lookup an appropriate matching OrgDb object but using this you can supply a different OrgDb object.

Details

makeOrganismDbFromBiomart is a convenience function that feeds data from a BioMart database to the lower level OrganismDb constructor. See ? for a similar function that feeds data from the UCSC source.

The listMarts function from the biomaRt package can be used to list all public BioMart databases. Not all databases returned by this function contain datasets that are compatible with (i.e. understood by) makeOrganismDbFromBiomart . Here is a list of datasets known to be compatible (updated on Sep 24, 2014):

  • All the datasets in the main Ensembl database: use biomart="ensembl" .

  • All the datasets in the Ensembl Fungi database: use biomart="fungi_mart_XX" where XX is the release version of the database e.g. "fungi_mart_22" .

  • All the datasets in the Ensembl Metazoa database: use biomart="metazoa_mart_XX" where XX is the release version of the database e.g. "metazoa_mart_22" .

  • All the datasets in the Ensembl Plants database: use biomart="plants_mart_XX" where XX is the release version of the database e.g. "plants_mart_22" .

  • All the datasets in the Ensembl Protists database: use biomart="protists_mart_XX" where XX is the release version of the database e.g. "protists_mart_22" .

  • All the datasets in the Gramene Mart: use biomart="ENSEMBL_MART_PLANT" .
    Not all these datasets have CDS information.

Value

A OrganismDb object.

Seealso

Author

M. Carlson

Examples

## Discover which datasets are available in the "ensembl" BioMart
## database:
library(biomaRt)
head(listDatasets(useMart("ensembl")))

## Retrieving an incomplete transcript dataset for Human from the
## "ensembl" BioMart database:
transcript_ids <- c(
"ENST00000013894",
"ENST00000268655",
"ENST00000313243",
"ENST00000435657",
"ENST00000384428",
"ENST00000478783"
)
odb <- makeOrganismDbFromBiomart(transcript_ids=transcript_ids)
odb  # note that these annotations match the GRCh38 genome assembly

## Now what if we want to use another mirror?  We might make use of the
## new host argument.  But wait!  If we use biomaRt, we can see that
## this host has named the mart differently!
listMarts(host="useast.ensembl.org")
## Therefore we must also change the name passed into the "mart"
## argument thusly:
try(
odb <- makeOrganismDbFromBiomart(biomart="ENSEMBL_MART_ENSEMBL",
transcript_ids=transcript_ids,
host="useast.ensembl.org")
)
odb
Link to this function

makeOrganismDbFromTxDb()

Make an OrganismDb object from an existing TxDb object.

Description

The makeOrganismDbFromTxDb function allows the user to make a OrganismDb object from an existing TxDb object.

Usage

makeOrganismDbFromTxDb(txdb, keytype=NA, orgdb=NA)

Arguments

ArgumentDescription
txdba TxDb object
keytypeBy default, makeOrganismDbFromTxDb will try to guess this information based on the OrgDb object that is inferred to go with your TxDb object... But in some instances, you may need to supply an over-ride and that is what this argument is for. It is the column name of the ID type that your OrgDb will use as a foreign key when connecting to the data from the associated TxDb. So for example, if you looked at the Homo.sapiens package the keytype for org.Hs.eg.db , would be 'ENTREZID' because that is the kind of ID that matches up with it's TxDb GENEID. (Because the GENEID for that specific TxDb is from UCSC and uses entrez gene IDs)
orgdbBy default, makeOrganismDbFromTxDb will use the taxonomyID from your txdb to lookup an appropriate matching OrgDb object but using this you can supply a different OrgDb object.

Details

makeOrganismDbFromTxDb is a convenience function that processes a TxDb object and pairs it up with GO.db and an appropriate OrgDb object to make a OrganismDb object. See ? and ? for a similar function that feeds data from either a BioMart or UCSC.

Value

A OrganismDb object.

Seealso

Author

M. Carlson

Examples

## lets start with a txdb object
transcript_ids <- c(
"uc009uzf.1",
"uc009uzg.1",
"uc009uzh.1",
"uc009uzi.1",
"uc009uzj.1"
)
txdbMouse <- makeTxDbFromUCSC(genome="mm9", tablename="knownGene",
transcript_ids=transcript_ids)

## Using that, we can call our function to promote it to an OrgDb object:
odb <- makeOrganismDbFromTxDb(txdb=txdbMouse)

columns(odb)
Link to this function

makeOrganismDbFromUCSC()

Make a OrganismDb object from annotations available at the UCSC Genome Browser

Description

The makeOrganismDbFromUCSC function allows the user to make a OrganismDb object from transcript annotations available at the UCSC Genome Browser.

Usage

makeOrganismDbFromUCSC(
        genome="hg19",
        tablename="knownGene",
        transcript_ids=NULL,
        circ_seqs=DEFAULT_CIRC_SEQS,
        url="http://genome.ucsc.edu/cgi-bin/",
        goldenPath_url="http://hgdownload.cse.ucsc.edu/goldenPath",
        miRBaseBuild=NA)

Arguments

ArgumentDescription
genomegenome abbreviation used by UCSC and obtained by ucscGenomes . For example: "hg19" .
tablenamename of the UCSC table containing the transcript annotations to retrieve. Use the supportedUCSCtables utility function to get the list of supported tables. Note that not all tables are available for all genomes.
transcript_idsoptionally, only retrieve transcript annotation data for the specified set of transcript ids. If this is used, then the meta information displayed for the resulting OrganismDb object will say 'Full dataset: no'. Otherwise it will say 'Full dataset: yes'.
circ_seqsa character vector to list out which chromosomes should be marked as circular.
url,goldenPath_urluse to specify the location of an alternate UCSC Genome Browser.
miRBaseBuildspecify the string for the appropriate build Information from mirbase.db to use for microRNAs. This can be learned by calling supportedMiRBaseBuildValues . By default, this value will be set to NA , which will inactivate the microRNAs accessor.

Details

makeOrganismDbFromUCSC is a convenience function that feeds data from the UCSC source to the lower level OrganismDb function. See ? for a similar function that feeds data from a BioMart database.

Value

A OrganismDb object.

Seealso

Author

M. Carlson

Examples

## Display the list of genomes available at UCSC:
library(rtracklayer)
library(RMariaDB)
ucscGenomes()[ , "db"]

## Display the list of tables supported by makeOrganismDbFromUCSC():
supportedUCSCtables()

ontrun{
## Retrieving a full transcript dataset for Yeast from UCSC:
odb1 <- makeOrganismDbFromUCSC(genome="sacCer2", tablename="ensGene")
}

## Retrieving an incomplete transcript dataset for Mouse from UCSC
## (only transcripts linked to Entrez Gene ID 22290):
transcript_ids <- c(
"uc009uzf.1",
"uc009uzg.1",
"uc009uzh.1",
"uc009uzi.1",
"uc009uzj.1"
)

odb2 <- makeOrganismDbFromUCSC(genome="mm9", tablename="knownGene",
transcript_ids=transcript_ids)
odb2
Link to this function

makeOrganismPackage()

Making OrganismDb packages from annotation packages.

Description

makeOrganismPackage is a method that generates a package that will load an appropriate annotationOrganismDb object that will in turn point to existing annotation packages.

Usage

makeOrganismPackage (pkgname,
                     graphData,
                     organism,
                     version,
                     maintainer,
                     author,
                     destDir,
                     license="Artistic-2.0")

Arguments

ArgumentDescription
pkgnameWhat is the desired package name. Traditionally, this should be the genus and species separated by a ".". So as an example, "Homo.sapiens" would be the package name for human
graphDataA list of short character vectors. Each character vector in the list is exactly two elements long and represents a join relationship between two packages. The names of these character vectors are the package names and the values are the foreign keys that should be used to connect each package. All foreign keys must be values that can be returned by the columns method for each package in question, and obviously they also must be the same kind of identifier as well.
organismThe name of the organism this package represents
versionWhat is the version number for this package?
maintainerWho is the package maintainer? (must include email to be valid)
authorWho is the creator of this package?
destDirA path where the package source should be assembled.
licenseWhat is the license (and it's version)

Details

The purpose of this method is to create a special package that will depend on existing annotation packages and which will load a special annotationOrganismDb object that will allow proper dispatch of special select methods. These methods will allow the user to easily query across multiple annotation resources via information contained by the annotationOrganismDb object. Because the end result will be a package that treats all the data mapped together as a single source, the user is encouraged to take extra care to ensure that the different packages used are from the same build etc.

Value

A special package to load an OrganismDb object.

Seealso

OrganismDb

Author

M. Carlson

Examples

## set up the list with the relevant relationships:
gd <- list(join1 = c(GO.db="GOID", org.Hs.eg.db="GO"),
join2 = c(org.Hs.eg.db="ENTREZID",
TxDb.Hsapiens.UCSC.hg19.knownGene="GENEID"))

## sets up a temporary directory for this example
## (users won't need to do this step)
destination <- tempfile()
dir.create(destination)

## makes an Organism package for human called Homo.sapiens
if(interactive()){
makeOrganismPackage(pkgname = "Homo.sapiens",
graphData = gd,
organism = "Homo sapiens",
version = "1.0.0",
maintainer = "Bioconductor Package Maintainer <maintainer@bioconductor.org>",
author = "Bioconductor Core Team",
destDir = destination,
license = "Artistic-2.0")
}
Link to this function

rangeBasedAccessors()

Extract genomic features from an object

Description

Generic functions to extract genomic features from an object. This page documents the methods for OrganismDb objects only.

Usage

list(list("transcripts"), list("MultiDb"))(x, columns=c("TXID", "TXNAME"), filter=NULL)
list(list("exons"), list("MultiDb"))(x, columns="EXONID", filter=NULL)
list(list("cds"), list("MultiDb"))(x, columns="CDSID", filter=NULL)
list(list("genes"), list("MultiDb"))(x, columns="GENEID", filter=NULL)
list(list("transcriptsBy"), list("MultiDb"))(x, by, columns, use.names=FALSE,
                                     outerMcols=FALSE)
list(list("exonsBy"), list("MultiDb"))(x, by, columns, use.names=FALSE, outerMcols=FALSE)
list(list("cdsBy"), list("MultiDb"))(x, by, columns, use.names=FALSE, outerMcols=FALSE)
list(list("getTxDbIfAvailable"), list("MultiDb"))(x, ...)
% S4method{columns}{MultiDb}(x)% new stuff: (replace TxDb with MultiDb)list(list("asBED"), list("MultiDb"))(x)
list(list("asGFF"), list("MultiDb"))(x)
list(list("disjointExons"), list("MultiDb"))(x, aggregateGenes=FALSE, 
              includeTranscripts=TRUE, ...) 
list(list("microRNAs"), list("MultiDb"))(x)
list(list("tRNAs"), list("MultiDb"))(x)
list(list("promoters"), list("MultiDb"))(x, upstream=2000, downstream=200, use.names=TRUE, ...)
list(list("distance"), list("GenomicRanges,MultiDb"))(x, y, ignore.strand=FALSE,
    ..., id, type=c("gene", "tx", "exon", "cds"))
list(list("extractTranscriptSeqs"), list("BSgenome"))(x, transcripts, strand = "+")
list(list("extractUpstreamSeqs"), list("MultiDb"))(x, genes, width=1000, exclude.seqlevels=NULL)
list(list("intronsByTranscript"), list("MultiDb"))(x, use.names=FALSE)
list(list("fiveUTRsByTranscript"), list("MultiDb"))(x, use.names=FALSE)
list(list("threeUTRsByTranscript"), list("MultiDb"))(x, use.names=FALSE)
list(list("isActiveSeq"), list("MultiDb"))(x)

Arguments

ArgumentDescription
xA MultiDb object. Except for the extractTranscriptSeqs method. In that case it's a BSgenome object and the second argument is an MultiDb object.
...Arguments to be passed to or from methods.
byOne of "gene" , "exon" , "cds" or "tx" . Determines the grouping.
columnsThe columns or kinds of metadata that can be retrieved from the database. All possible columns are returned by using the columns method.
filterEither NULL or a named list of vectors to be used to restrict the output. Valid names for this list are: "gene_id" , "tx_id" , "tx_name" , "tx_chrom" , "tx_strand" , "exon_id" , "exon_name" , "exon_chrom" , "exon_strand" , "cds_id" , "cds_name" , "cds_chrom" , "cds_strand" and "exon_rank" .
use.namesControls how to set the names of the returned GRangesList object. These functions return all the features of a given type (e.g. all the exons) grouped by another feature type (e.g. grouped by transcript) in a GRangesList object. By default (i.e. if use.names is FALSE ), the names of this GRangesList object (aka the group names) are the internal ids of the features used for grouping (aka the grouping features), which are guaranteed to be unique. If use.names is TRUE , then the names of the grouping features are used instead of their internal ids. For example, when grouping by transcript ( by="tx" ), the default group names are the transcript internal ids ( "tx_id" ). But, if use.names=TRUE , the group names are the transcript names ( "tx_name" ). Note that, unlike the feature ids, the feature names are not guaranteed to be unique or even defined (they could be all NA s). A warning is issued when this happens. See ? for more information about feature internal ids and feature external names and how to map the formers to the latters. Finally, use.names=TRUE cannot be used when grouping by gene by="gene" . This is because, unlike for the other features, the gene ids are external ids (e.g. Entrez Gene or Ensembl ids) so the db doesn't have a "gene_name" column for storing alternate gene names.
upstreamFor promoters : An integer(1) value indicating the number of bases upstream from the transcription start site. For additional details see ?promoters,GRanges-method`` .
downstreamFor promoters : An integer(1) value indicating the number of bases downstream from the transcription start site. For additional details see ?promoters,GRanges-method`` .
aggregateGenesFor disjointExons : A logical . When FALSE (default) exon fragments that overlap multiple genes are dropped. When TRUE , all fragments are kept and the gene_id metadata column includes all gene ids that overlap the exon fragment.
includeTranscriptsFor disjointExons : A logical . When TRUE (default) a tx_name metadata column is included that lists all transcript names that overlap the exon fragment.
yFor distance , a MultiDb instance. The id is used to extract ranges from the MultiDb which are then used to compute the distance from x .
idA character vector the same length as x . The id must be identifiers in the MultiDb object. type indicates what type of identifier id is.
typeA character(1) describing the id . Must be one of gene , tx , exon or cds .
ignore.strandA logical indicating if the strand of the ranges should be ignored. When TRUE , strand is set to '+' .
outerMcolsA logical indicating if the the 'outer' mcols (metadata columns) should be populated for some range based accesors which return a GRangesList object. By default this is FALSE, but if TRUE then the outer list object will also have it's metadata columns (mcols) populated as well as the mcols for the 'inner' GRanges objects.
transcriptsAn object representing the exon ranges of each transcript to extract. It must be a GRangesList or MultiDb object while the x is a BSgenome object. Internally, it's turned into a GRangesList object with exonsBy .
strandOnly supported when x is a DNAString object. Can be an atomic vector, a factor, or an Rle object, in which case it indicates the strand of each transcript (i.e. all the exons in a transcript are considered to be on the same strand). More precisely: it's turned into a factor (or factor- Rle ) that has the "standard strand levels" (this is done by calling the strand function on it). Then it's recycled to the length of IntegerRangesList object transcripts if needed. In the resulting object, the i-th element is interpreted as the strand of all the exons in the i-th transcript. strand can also be a list-like object, in which case it indicates the strand of each exon, individually. Thus it must have the same shape as IntegerRangesList object transcripts (i.e. same length plus strand[[i]] must have the same length as transcripts[[i]] for all i ). strand can only contain "+" and/or "-" values. "*" is not allowed.
genesAn object containing the locations (i.e. chromosome name, start, end, and strand) of the genes or transcripts with respect to the reference genome. Only GenomicRanges and MultiDb objects are supported at the moment. If the latter, the gene locations are obtained by calling the genes function on the MultiDb object internally.
widthHow many bases to extract upstream of each TSS (transcription start site).
exclude.seqlevelsA character vector containing the chromosome names (a.k.a. sequence levels) to exclude when the genes are obtained from a MultiDb object.

Details

These are the range based functions for extracting transcript information from a MultiDb object.

Value

a GRanges or GRangesList object

Seealso

  • MultiDb-class for how to use the simple "select" interface to extract information from a MultiDb object.

  • transcripts for the original transcripts method and related methods.

  • transcriptsBy for the original transcriptsBy method and related methods.

Author

M. Carlson

Examples

## extracting all transcripts from Homo.sapiens with some extra metadata
library(Homo.sapiens)
cols = c("TXNAME","SYMBOL")
res <- transcripts(Homo.sapiens, columns=cols)

## extracting all transcripts from Homo.sapiens, grouped by gene and
## with extra metadata
res <- transcriptsBy(Homo.sapiens, by="gene", columns=cols)

## list possible values for columns argument:
columns(Homo.sapiens)

## Get the TxDb from an MultiDb object (if it's available)
getTxDbIfAvailable(Homo.sapiens)

## Other functions listed above should work in way similar to their TxDb
## counterparts.  So for example:
promoters(Homo.sapiens)
## Should give the same value as:
promoters(getTxDbIfAvailable(Homo.sapiens))