%\VignetteIndexEntry{Making and Utilizing TranscriptDb Objects} %\VignetteKeywords{annotation} %\VignettePackage{GenomicFeatures} \documentclass[11pt]{article} \usepackage{url} \newcommand{\Rfunction}[1]{{\texttt{#1}}} \newcommand{\Robject}[1]{{\texttt{#1}}} \newcommand{\Rpackage}[1]{{\textit{#1}}} \newcommand{\Rmethod}[1]{{\texttt{#1}}} \newcommand{\Rfunarg}[1]{{\texttt{#1}}} \newcommand{\Rclass}[1]{{\textit{#1}}} \newcommand{\Rcode}[1]{{\texttt{#1}}} \newcommand{\software}[1]{\textsf{#1}} \newcommand{\R}{\software{R}} \title{Making and Utilizing TranscriptDb Objects} \author{Marc Carlson \and Patrick Aboyoun \and Herv\'{e} Pag\`{e}s \and Seth Falcon \and Martin Morgan} \SweaveOpts{keep.source=TRUE} \begin{document} \maketitle \section{Introduction} The \Rpackage{GenomicFeatures} package retrieves and manages transcript-related features from the UCSC Genome Bioinformatics\footnote{\url{http://genome.ucsc.edu/}} and BioMart\footnote{\url{http://www.biomart.org/}} data resources. The package is useful for ChIP-chip, ChIP-seq, and RNA-seq analyses. <>= library("GenomicFeatures") @ \section{Transcript Metadata} \subsection{\Rclass{TranscriptDb} Objects} The \Rpackage{GenomicFeatures} package uses \Rclass{TranscriptDb} objects to store transcript metadata. This class maps the 5' and 3' untranslated regions (UTRs), protein coding sequences (CDSs) and exons for a set of mRNA transcripts to their associated genome. \Rclass{TranscriptDb} objects also have accessors functions to allow such features to be retrieved individually or grouped together in a way that reflects the underlying biology. All \Rclass{TranscriptDb} objects are backed by a SQLite database that manages genomic locations and the relationships between pre-processed mRNA transcripts, exons, protein coding sequences, and their related gene identifiers. \subsection{Creating New \Rclass{TranscriptDb} Objects} The \Rpackage{GenomicFeatures} package provides functions to create \Rclass{TranscriptDb} objects based on data downloaded from UCSC Genome Bioinformatics or BioMart. The following subsections demonstrate the use of these functions. There is also support for creating \Rclass{TranscriptDb} objects from custom data sources using \Rfunction{makeTranscriptDb}; see the help page for this function for details. \subsubsection{Using \Rfunction{makeTranscriptDbFromUCSC}} The function \Rfunction{makeTranscriptDbFromUCSC} downloads UCSC Genome Bioinformatics transcript tables (e.g. \Rcode{"knownGene"}, \Rcode{"refGene"}, \Rcode{"ensGene"}) for a genome build (e.g. \Rcode{"mm9"}, \Rcode{"hg19"}). Use the \Rfunction{supportedUCSCtables} utility function to get the list of supported tables. %% <>= supportedUCSCtables()[1:4, ] @ <>= mm9KG <- makeTranscriptDbFromUCSC(genome = "mm9", tablename = "knownGene") @ The function \Rfunction{makeTranscriptDbFromUCSC} also takes an important argument called \Robject{circ\_seqs} to label which chromosomes are circular. The argument is a character vector of strings that correspond to the circular chromosomes (as labeled by the source). To discover what the source calls their chromosomes, use the \Rfunction{getChromInfoFromUCSC} function to list them. By default, there is a supplied character vector that will attempt to label all the mitochondrial chromosomes as circular by matching to them. This is the \Robject{DEFAULT\_CIRC\_SEQS} vector. It contains strings that usually correspond to mitochondrial chromosomes. Once the database has been generated with the circular chromosomes tagged in this way, all subsequent analysis of these chromosomes will be able to consider their circularity for analysis. So it is important for the user to make sure that they pass in the correct strings to the \Robject{circ\_seqs} argument to ensure that the correct sequences are tagged as circular by the database. <>= head(getChromInfoFromUCSC("hg19")) @ \subsubsection{Using \Rfunction{makeTranscriptDbFromBiomart}} Retrieve data from BioMart by specifying the mart and the data set to the \Rfunction{makeTranscriptDbFromBiomart} function (not all BioMart data sets are currently supported): %% <>= mmusculusEnsembl <- makeTranscriptDbFromBiomart(biomart = "ensembl", dataset = "mmusculus_gene_ensembl") @ As with the \Rfunction{makeTranscriptDbFromUCSC} function, the \Rfunction{makeTranscriptDbFromBiomart} function also has a \Robject{circ\_seqs} argument that will default to using the contents of the \Robject{DEFAULT\_CIRC\_SEQS} vector. And just like those UCSC sources, there is also a helper function called \Rfunction{getChromInfoFromBiomart} that can show what the different chromosomes are called for a given source. Using the \Rfunction{makeTranscriptDbFromBiomart} \Rfunction{makeTranscriptDbFromUCSC} functions can take a while and may also require some bandwidth as these methods have to download and then assemble a database from their respective sources. It is not expected that most users will want to do this step every time. Instead, we suggest that you save your annotation objects and label them with an appropriate time stamp so as to facilitate reproducible research. \subsection{Saving and Loading a \Rclass{TranscriptDb} Object} Once a \Rclass{TranscriptDb} object has been created, it can be saved to avoid the time and bandwidth costs of recreating it and to make it possible to reproduce results with identical genomic feature data at a later date. Since \Rclass{TranscriptDb} objects are backed by a SQLite database, the save format is a SQLite database file (which could be accessed from programs other than \R if desired). Note that it is not possible to serialize a \Rclass{TranscriptDb} object using \R's \Rfunction{save} function. <>= saveFeatures(mm9KG, file="fileName.sqlite") @ A \Rclass{TranscriptDb} object can be initialized from a file using \Rfunction{loadFeatures}. <>= mm9KG <- loadFeatures("fileName.sqlite") @ \section{Retrieving Transcript, Exon, and Coding Sequence Ranges} \subsection{Loading some sample genomic feature data} Here was are loading a previously created \Rclass{TranscriptDb} object based on UCSC known gene data. This database only contains a small subset of the possible annotations for human and is only included to demonstrate and test the functionality of the \Rpackage{GenomicFeatures} package. <>= samplefile <- system.file("extdata", "UCSC_knownGene_sample.sqlite", package="GenomicFeatures") txdb <- loadFeatures(samplefile) txdb @ %%FIXME. Lets do better with the examples \subsection{Working with Basic Features} The most basic operations on a \Rclass{TranscriptDb} object retrieve the genomic coordinates or \textit{ranges} for exons, transcripts or coding sequences. The functions \Rfunction{transcripts}, \Rfunction{exons}, and \Rfunction{cds} return the coordinate information as a \Rclass{GRanges} object. For example, all transcripts present in a \Rclass{TranscriptDb} object can be obtained as follows: <>= GR <- transcripts(txdb) GR[1:3] @ The \Rfunction{transcripts} function returns a \Rclass{GRanges} class object. You can learn a lot more about the manipulation of these objects by reading the \Rpackage{GenomicRanges} introductory vignette. The \Rmethod{show} method for a \Rclass{GRanges} object will display the ranges, seqnames (a chromosome or a contig), and strand on the left side and then present related metadata on the right side. At the bottom, the seqlengths display all the possible seqnames along with the length of each sequence. In addition, the \Rfunction{transcripts} function can also be used to retrieve a subset of the transcripts available such as those on the $+$-strand of chromosome 1. <>= GR <- transcripts(txdb, vals <- list(tx_chrom = "chr1", tx_strand = "+")) length(GR) unique(strand(GR)) @ The \Rfunction{exons} and \Rfunction{cds} functions can also be used in a similar fashion to retrive genomic coordinates for exons and coding sequences. \subsection{Working with Grouped Features} Often one is interested in how particular genomic features relate to each other, and not just their location. For example, it might be of interest to group transcripts by gene or to group exons by transcript. Such groupings are supported by the \Rfunction{transcriptsBy}, \Rfunction{exonsBy}, and \Rfunction{cdsBy} functions. The following call can be used to group transcripts by genes: <>= GRList <- transcriptsBy(txdb, by = "gene") length(GRList) names(GRList)[10:13] GRList[11:12] @ The \Rfunction{transcriptsBy} function returns a \Rclass{GRangesList} class object. As with \Rclass{GRanges} objects, you can learn more about these objects by reading the \Rpackage{GenomicRanges} introductory vignette. The \Rmethod{show} method for a \Rclass{GRangesList} object will display as a list of \Rclass{GRanges} objects. And, at the bottom the seqlengths will be displayed once for the entire list. For each of these three functions, there is a limited set of options that can be passed into the \Rfunarg{by} argument to allow grouping. For the \Rfunction{transcriptsBy} function, you can group by gene, exon or cds, whereas for the \Rfunction{exonsBy} and \Rfunction{cdsBy} functions can only be grouped by transcript (tx) or gene. So as a further example, to extract all the exons for each transcript you can call: <>= GRList <- exonsBy(txdb, by = "tx") length(GRList) names(GRList)[10:13] GRList[[12]] @ As you can see, the \Rclass{GRangesList} objects returned from each function contain locations and identifiers grouped into a list like object according to the type of feature specified in the \Rfunarg{by} argument. The object returned can then be used by functions like \Rfunction{findOverlaps} to contextualize alignments from high-throughput sequencing. The identifiers used to label the \Rclass{GRanges} objects depend upon the data source used to create the \Rclass{TranscriptDb} object. So the list identifiers will not always be Entrez Gene IDs, as they were in the first example. Furthermore, some data sources do not provide a unique identifier for all features. In this situation, the group label will be a synthetic ID created by \Rpackage{GenomicFeatures} to keep the relations between features consistent in the database this was the case in the 2nd example. Even though the results will sometimes have to come back to you as synthetic IDs, you can still always retrieve the original IDs. In the following example, we will find the original transcript names stored in the database for each ID by calling the \Rfunction{transcripts} function. %% FIXME: add example on how to map from internal ID to common ID %% using the exons grouped by tx created above. <>= tx_ids <- names(GRList) vals <- list(tx_id=tx_ids) txs <- transcripts(txdb, vals, columns = c("tx_id", "tx_name")) head(values(txs)) @ Finally, the order of the results in a \Rclass{GRangesList} object can vary with the way in which things were grouped. In most cases the grouped elements of the \Rclass{GRangesList} object will be listed in the order that they occurred along the chromosome. However, when exons or CDS are grouped by transcript, they will instead be grouped according to their position along the transcript itself. This is important because alternative splicing can mean that the order along the transcript can be different from that along the chromosome. \subsection{Prespecfied grouping functions} The \Rfunction{intronsByTranscript}, \Rfunction{fiveUTRsByTranscript} and \Rfunction{threeUTRsByTranscript} are convenience functions that provide behavior equivalent to the grouping functions, but in prespecified form. These functions return a \Rclass{GRangesList} object grouped by transcript for introns, 5' UTR's, and 3' UTR's, respectively. <>= length(intronsByTranscript(txdb)) length(fiveUTRsByTranscript(txdb)) length(threeUTRsByTranscript(txdb)) @ \subsection{Convenience functions for computing overlap} The \Rfunction{transcriptsByOverlaps}, \Rfunction{exonsByOverlaps} and \Rfunction{cdsByOverlaps} functions return a \Rclass{GRangesList} object containing data about transcripts, exons, or coding sequences that overlap genomic coordinates specified by a \Rclass{GRanges} object. So for example, lets just mock up some fake data: <>= gr <- GRanges( seqnames = rep("chr5",4), ranges = IRanges(start = c(244620, 244670, 245804, 247502), end = c(244652, 244702, 245836, 247534)), strand = rep("+", 4)) @ Then we can call the convenience function to see what transcripts overlap with our ranges. <>= transcriptsByOverlaps(txdb, gr) @ The convenience functions can be a great shortcut, but because they have to make assumptions about how the results are compared and represented, they are ultimately not as flexible as just using the basic and grouping accessors in combination with \Rfunction{findOverlaps}. \section{A typical example treating \Robject{gr} as RNA-seq data} Let's suppose that you have run an experiment. After mapping all your reads to a genome and collapsing them into a set of ranges, you want to find out which genomic features a particular range overlaps with. What would be the usual way to proceed? For this example, let's also assume that you are only interested in mapping the ranges that overlap with exons (not introns). From our \Rclass{TranscriptDb} object, we want to recover the annotations for all of the relevant exons, but grouped according to their transcripts. Therefore, we want to use \Rfunction{exonsby} and group them by transcripts. <>= annotGr <- exonsBy(txdb, "tx") @ Then we need to use the \Rfunction{findOverlaps} method to learn which of our data ranges, \Robject{gr}, will overlap with the in exons that we have grouped by transcripts. <>= OL <- findOverlaps(query = annotGr, subject = gr) @ Finally, once we have called \Rfunction{findOverlaps} we can subset out the annotations that meet our criteria. The \Rfunction{queryHits} method will allow us to retrieve only the parts of the query that overlapped from our original \Rfunction{findOverlaps} call. Once we have subsetted out annotations in this way, the length of the resulting \Rclass{GRangesList} object is also the number of transcripts that overlap with our data. <>= tdata <- annotGr[unique(queryHits(OL)),] tdata length(tdata) @ By using \Rfunction{findOverlaps} along with the different accessors in this way, it is possible to connect any data that has been represented as a \Rclass{GRanges} object with the annotations stored in a \Rclass{TranscriptDb} object. Calling \Rfunction{findOverlaps} along with the appropriate \Rclass{GRanges} object not only allows users to quickly determine what has overlapped, but also controls what criteria are used for determining whether an overlap has occurred. This can be done by passing in an alternate \Rfunarg{type} parameter to \Rfunction{findOverlaps}. In addition, because the basic accessors allow for the users to retrieve data grouped in different ways, the user has control over which parts of a transcript or gene are included in the overlap. For a more complete example of how you could approach RNA-seq analysis, including explanation on methods that will help to tally up the counts etc. please see the \Rpackage{GenomicRanges} Use Cases vignette. \section{Session Information} <>= sessionInfo() @ \end{document}