Title: | Inference of differential exon usage in RNA-Seq |
---|---|
Description: | The package is focused on finding differential exon usage using RNA-seq exon counts between samples with different experimental designs. It provides functions that allows the user to make the necessary statistical tests based on a model that uses the negative binomial distribution to estimate the variance between biological replicates and generalized linear models for testing. The package also provides functions for the visualization and exploration of the results. |
Authors: | Simon Anders <[email protected]> and Alejandro Reyes <[email protected]> |
Maintainer: | Alejandro Reyes <[email protected]> |
License: | GPL (>= 3) |
Version: | 1.53.0 |
Built: | 2024-10-31 06:02:10 UTC |
Source: | https://github.com/bioc/DEXSeq |
The counts slot holds the count data as a matrix of non-negative integer count values, one row for each observational unit (gene or the like), and one column for each sample.
## S4 method for signature 'DEXSeqResults' counts(object,normalized=FALSE)
## S4 method for signature 'DEXSeqResults' counts(object,normalized=FALSE)
object |
a |
normalized |
logical indicating whether or not to divide the counts by the size factors or normalization factors before returning (normalization factors always preempt size factors) |
an integer matrix
data(pasillaDEXSeqDataSet, package="pasilla") head( counts( dxd ))
data(pasillaDEXSeqDataSet, package="pasilla") head( counts( dxd ))
This function is a wrapper that calls the necessary functions to perform a differential exon usage test in a single command.
DEXSeq(object, fullModel=design(object), reducedModel = ~ sample + exon, BPPARAM=MulticoreParam(workers=1), fitExpToVar="condition", quiet=TRUE )
DEXSeq(object, fullModel=design(object), reducedModel = ~ sample + exon, BPPARAM=MulticoreParam(workers=1), fitExpToVar="condition", quiet=TRUE )
object |
An DEXSeqDataSet object. |
fullModel |
The full model formula |
reducedModel |
Null model formula. |
BPPARAM |
A "BiocParallelParam" instance.
See |
fitExpToVar |
A variable name contained in the sample data. The expression values will be fitted to this variable using the the formula " ~ sample + fitExpToVar * exon". |
quiet |
Whether to print messages at each step |
A DEXSeqResults
object.
## Not run: data(pasillaDEXSeqDataSet, package="pasilla") dxr <- DEXSeq( dxd ) ## End(Not run)
## Not run: data(pasillaDEXSeqDataSet, package="pasilla") dxr <- DEXSeq( dxd ) ## End(Not run)
The ExonCountSet object has been deprecated and substituted by the DEXSeqDataSet object. Therefore, all the functions and methods for the ExonCountSet object were deprecated. These functions have been subsituted by new functions and methods designed for DEXSeqDataSet objects.
The replacements of defunct functions are summarized in the following items.
newExonCountSet: DEXseqDataSet
DEUresultTable: DEXseqResults
subsetByGenes:
geneCountTable:
estimateExonDispersionsForModelFrame_BM: estimateDispersions-DEXSeqDataSet
estimateDispersions_BM: estimateDispersions-DEXSeqDataSet
testGeneForDEU_BM: testForDEU
testForDEU_BM: testForDEU
doCompleteDEUAnalysis: DEXSeq
makeCompleteDEUAnalysis_BM: DEXSeq
read.HTSeqCounts: DEXSeqDataSetFromHTSeq
countTableForGene:
fitDispersionFunction: estimateDispersions-DEXSeqDataSet
estimatelog2FoldChange: estimateExonFoldChanges
modelFrameForGene:
buildExonCountSet: DEXSeqDataSetFromSE
constructModelFrame:
getCountVector:
estimateExonDispersion: estimateDispersions-DEXSeqDataSet
testExonForDEU: testForDEU
doCompleteDEUAnalysis: DEXSeq
The DEXSeqDataSet
is a subclass of DESeqDataSet
,
specifically designed to adapt the DESeqDataSet
to test
for differences in exon usage.
DEXSeqDataSet( countData, sampleData, design= ~ sample + exon + condition:exon, featureID, groupID, featureRanges=NULL, transcripts=NULL, alternativeCountData=NULL) DEXSeqDataSetFromHTSeq( countfiles, sampleData, design= ~ sample + exon + condition:exon, flattenedfile=NULL ) DEXSeqDataSetFromSE( SE, design= ~ sample + exon + condition:exon )
DEXSeqDataSet( countData, sampleData, design= ~ sample + exon + condition:exon, featureID, groupID, featureRanges=NULL, transcripts=NULL, alternativeCountData=NULL) DEXSeqDataSetFromHTSeq( countfiles, sampleData, design= ~ sample + exon + condition:exon, flattenedfile=NULL ) DEXSeqDataSetFromSE( SE, design= ~ sample + exon + condition:exon )
countData |
A matrix of count data of non-negative integer values. The rows correspond to counts for each exon counting bin, the columns correspond to samples. Note that biological replicates should each get their own column, while the counts of technical replicates (i.e., several sequencing runs/lanes from the same sample) should be summed up into a single column |
alternativeCountData |
DEXSeq can be also used for test for differences in exon inclusion based on the number of reads supporting the inclusion of an exon and the number of reads supporting the exclusion of an exon. A matrix of count data of non-negative integer values.The rows correspond to exonic regions and the columns correspond to samples. This matrix should contain the number of exon-exon junction reads that skip each exon in each sample. If NULL, then the sum of the other exons belonging to the same gene is considered for testing (i.e. the normal DEXSeq approach). |
countfiles |
A character vector containing the path to the files that were originated with the script 'dexseq_count.py'. |
sampleData |
A |
design |
A formula which specifies the design of the experiment. It must specify an interaction term between a variable from the sampleData columns with the 'exon' variable. By default, the design will be '~ sample + exon + condition:exon'. This formula indicates the contrast between 'condition' and exon', i.e. differences in exon usage due to changes in the 'condition' variable. See the vignette for more examples of other designs. |
featureID |
A character vector of counting regions identifiers ordered according to the rows in countData. The identifiers names can be repeated between groups but not within groups. |
groupID |
A vector of group identifiers ordered according to its respective row in countData. It must reflect the sets of counting regions belonging to the same group, for example, exon bins in belonging to the same gene should have the same group identifier. |
featureRanges |
Optional. |
transcripts |
Optional. A |
flattenedfile |
A character vector containing the path to the flattened annotation file that was originated with the script 'dexseq_prepare_annotation.py'. |
SE |
A |
A DEXSeqDataSet object.
DEXSeqDataSetFromHTSeq
DEXSeqDataSetFromSE
## Not run: ####################################### ### From the output of the ### ### acconpaning python scripts ### ####################################### inDir = system.file("extdata", package="pasilla", mustWork=TRUE) flattenedfile = file.path(inDir, "Dmel.BDGP5.25.62.DEXSeq.chr.gff") sampleData = data.frame( condition = c( rep("treated", 3), rep("untreated", 4) ), type = c("single", "paired", "paired", "single", "single", "paired", "paired") ) countFiles <- list.files(inDir, pattern="fb.txt") rownames( sampleData ) <- countFiles DEXSeqDataSetFromHTSeq( countfiles=file.path( inDir, countFiles ), sampleData = sampleData, design = ~ sample + exon + type:exon + condition:exon, flattenedfile=flattenedfile ) ####################################### ### From GRanges derived objects ### ####################################### library(GenomicRanges) library(GenomicFeatures) library(txdbmaker) library(GenomicAlignments) hse <- makeTxDbFromBiomart(biomart="ensembl", dataset="hsapiens_gene_ensembl", host="grch37.ensembl.org") bamDir <- system.file( "extdata", package="parathyroidSE", mustWork=TRUE ) fls <- list.files( bamDir, pattern="bam$", full=TRUE ) bamlst <- BamFileList( fls, index=character(), yieldSize=100000, obeyQname=TRUE ) exonicParts <- exonicParts( hse, linked.to.single.gene.only = TRUE ) SE <- summarizeOverlaps( exonicParts, bamlst, mode="Union", singleEnd=FALSE, ignore.strand=TRUE, inter.feature=FALSE, fragments=TRUE ) colData(SE)$condition <- c("A", "A", "B") DEXSeqDataSetFromSE( SE, design= ~ sample + exon + condition:exon ) ####################################### ### From elementary data structures ### ####################################### countData <- matrix( rpois(10000, 100), nrow=1000 ) sampleData <- data.frame( condition=rep( c("untreated", "treated"), each=5 ) ) design <- formula( ~ sample + exon + condition:exon ) groupID <- rep( paste0("gene", 1:10), each= 100 ) featureID <- rep( paste0("exon", 1:100), times= 10 ) DEXSeqDataSet( countData, sampleData, design, featureID, groupID ) ## End(Not run)
## Not run: ####################################### ### From the output of the ### ### acconpaning python scripts ### ####################################### inDir = system.file("extdata", package="pasilla", mustWork=TRUE) flattenedfile = file.path(inDir, "Dmel.BDGP5.25.62.DEXSeq.chr.gff") sampleData = data.frame( condition = c( rep("treated", 3), rep("untreated", 4) ), type = c("single", "paired", "paired", "single", "single", "paired", "paired") ) countFiles <- list.files(inDir, pattern="fb.txt") rownames( sampleData ) <- countFiles DEXSeqDataSetFromHTSeq( countfiles=file.path( inDir, countFiles ), sampleData = sampleData, design = ~ sample + exon + type:exon + condition:exon, flattenedfile=flattenedfile ) ####################################### ### From GRanges derived objects ### ####################################### library(GenomicRanges) library(GenomicFeatures) library(txdbmaker) library(GenomicAlignments) hse <- makeTxDbFromBiomart(biomart="ensembl", dataset="hsapiens_gene_ensembl", host="grch37.ensembl.org") bamDir <- system.file( "extdata", package="parathyroidSE", mustWork=TRUE ) fls <- list.files( bamDir, pattern="bam$", full=TRUE ) bamlst <- BamFileList( fls, index=character(), yieldSize=100000, obeyQname=TRUE ) exonicParts <- exonicParts( hse, linked.to.single.gene.only = TRUE ) SE <- summarizeOverlaps( exonicParts, bamlst, mode="Union", singleEnd=FALSE, ignore.strand=TRUE, inter.feature=FALSE, fragments=TRUE ) colData(SE)$condition <- c("A", "A", "B") DEXSeqDataSetFromSE( SE, design= ~ sample + exon + condition:exon ) ####################################### ### From elementary data structures ### ####################################### countData <- matrix( rpois(10000, 100), nrow=1000 ) sampleData <- data.frame( condition=rep( c("untreated", "treated"), each=5 ) ) design <- formula( ~ sample + exon + condition:exon ) groupID <- rep( paste0("gene", 1:10), each= 100 ) featureID <- rep( paste0("exon", 1:100), times= 10 ) DEXSeqDataSet( countData, sampleData, design, featureID, groupID ) ## End(Not run)
Subset and replacements of DEXSeqDataSet slots.
## S4 method for signature 'DEXSeqDataSet' x[i, j, ..., drop=TRUE] ## S4 replacement method for signature 'DEXSeqDataSet' x$name <- value
## S4 method for signature 'DEXSeqDataSet' x[i, j, ..., drop=TRUE] ## S4 replacement method for signature 'DEXSeqDataSet' x$name <- value
x |
A DEXSeqDataSet object. |
i |
Indices specifying elements to extract. |
j |
Indices specifying elements to extract. |
name |
A symbol representing the name of a column of
|
value |
An object of a class specified in the S4 method signature. |
... |
Other arguments passed to lower functions |
drop |
Ignored for subsetting DEXSeqDataSet objects. |
This function generates an HTML report from the results
of a DEXSeqResults
object. Gives an simple report
to explore differential exon usage results.
DEXSeqHTML(object, genes=NULL, path="DEXSeqReport", file="testForDEU.html", fitExpToVar="condition", FDR=0.1, color=NULL, color.samples=NULL, mart="", filter="", attributes="", extraCols=NULL, BPPARAM=MulticoreParam(workers=1))
DEXSeqHTML(object, genes=NULL, path="DEXSeqReport", file="testForDEU.html", fitExpToVar="condition", FDR=0.1, color=NULL, color.samples=NULL, mart="", filter="", attributes="", extraCols=NULL, BPPARAM=MulticoreParam(workers=1))
object |
An DEXSeqResults object |
genes |
A character vector of gene identifiers to be included in the report. If NULL, the genes included in the report will be the significant hits at the given false discovery rate. See "FDR" below. |
path |
A path in the system where to write the report. |
file |
The name of the html file. |
fitExpToVar |
A variable contained in the design of the ecs; the counts will be fitted to this variable to get the plotting values. |
FDR |
A false discovery rate |
color |
A vector of colors, one for each of the levels of the values of "fitExpToVar". |
color.samples |
A vector of colors for each of the samples. If NULL, the colors of each sample will be asigned according to its corresponding condition. Useful to visualize complex experimental designs. |
mart |
object of class Mart, created with the useMart function, with dataset specified |
filter |
Filters (ONLY ONE) that should be used in the query. A possible list of filters can be retrieved using the function listFilters. Please note that the value of this filter will always be the geneIDs in the DEXSeqResults object. |
attributes |
Attributes you want to retrieve. A possible list of attributes can be retrieved using the biomaRt function listAttributes. |
extraCols |
A data frame with one or more columns to add to the report. For example, additional information about the genes. The data frame should be indexed by the gene names of the ExonCountSet object, e.g. the rownames of the data frame should correspond to the gene names. |
BPPARAM |
A 'BiocParallelParam' instance.
See |
This function will write an HTML report in the directory specified by 'path'. There, it will create an html file with the initial report page and a directory called "files" in which SVG files with the plots and other html files are placed. Different plots with different labels are generated for each gene: - counts: the raw data, for each sample - fitted expression: the fitted coefficients per compared condition (e.g.: treated, untreated) - fitted splicing: as 'expression', but after removing overall gene-level differential expression: this is the view most relevant for the interpretation of DEXSeq results, which are about changes in relative exon usage (i.e.: relative to overall gene expression)
## Not run: data(pasillaDEXSeqDataSet, package="pasilla") dxr <- DEXSeq( dxd ) DEXSeqHTML( object=dxr ) ## End(Not run)
## Not run: data(pasillaDEXSeqDataSet, package="pasilla") dxr <- DEXSeq( dxd ) DEXSeqHTML( object=dxr ) ## End(Not run)
The DEXSeqResults
object is a subclass
of a DataFrame
. It collects relevant
information from a DEXSeqDataSet
object with
the results generated from testing for differences
in exon usage.
DEXSeqResults( object, independentFiltering=TRUE, filter)
DEXSeqResults( object, independentFiltering=TRUE, filter)
object |
A |
independentFiltering |
Logical indicating whether independent filtering should be applied automatically. |
filter |
A vector of filter statistics over which the independent filtering will be optimized. The default is the normalized exon means. |
A DEXSeqResults object.
data(pasillaDEXSeqDataSet, package="pasilla") dxd <- estimateSizeFactors( dxd ) dxd <- estimateDispersions( dxd ) dxd <- testForDEU( dxd ) dxr <- DEXSeqResults( dxd )
data(pasillaDEXSeqDataSet, package="pasilla") dxd <- estimateSizeFactors( dxd ) dxd <- estimateDispersions( dxd ) dxd <- testForDEU( dxd ) dxr <- DEXSeqResults( dxd )
This function obtains dispersion estimates for negative binomial distributed data for the specific case for DEXSeq.
## S4 method for signature 'DEXSeqDataSet' estimateDispersions( object, fitType = c("parametric", "local", "mean", "glmGamPoi"), maxit = 100, niter = 10, quiet = FALSE, formula = design(object), BPPARAM = SerialParam() )
## S4 method for signature 'DEXSeqDataSet' estimateDispersions( object, fitType = c("parametric", "local", "mean", "glmGamPoi"), maxit = 100, niter = 10, quiet = FALSE, formula = design(object), BPPARAM = SerialParam() )
object |
A DEXSeqDataSet. |
fitType |
Either "parametric", "local", "mean" or "glmGamPoi" for the type of fitting of dispersions to the mean intensity. See ?estimateDispersions,DESeqDataSet-method for details. If "glmGamPoi" is selected, the GLM fitter from "glmGamPoi" is also used for estimating the dispersion estimates. |
maxit |
Control parameter: maximum number of iterations to allow for convergence |
niter |
Number of times to iterate between estimation of means and estimation of dispersion. |
quiet |
Whether to print messages at each step. |
formula |
Formula used to fit the dispersion estimates. |
BPPARAM |
A "BiocParallelParam" instance. See |
See ?estimateDispersions,DESeqDataSet-method for details.
A DEXSeqDataSet with the dispersion information filled in as metadata columns.
data(pasillaDEXSeqDataSet, package="pasilla") dxd <- estimateSizeFactors( dxd ) dxd <- estimateDispersions( dxd )
data(pasillaDEXSeqDataSet, package="pasilla") dxd <- estimateSizeFactors( dxd ) dxd <- estimateDispersions( dxd )
This function calculates the exon usage coefficients and fold changes (on log2 scale) between the different conditions.
estimateExonFoldChanges( object, fitExpToVar = "condition", denominator = "", BPPARAM=SerialParam(), maxRowsMF=2400, independentFiltering=FALSE, filter)
estimateExonFoldChanges( object, fitExpToVar = "condition", denominator = "", BPPARAM=SerialParam(), maxRowsMF=2400, independentFiltering=FALSE, filter)
object |
An DEXSeqDataSet object. |
fitExpToVar |
A variable contained in |
denominator |
A value of the sample annotation (e.g. condition) to use as a denominator in the log2 fold change. As a default, the function will take the annotation of the first sample. |
BPPARAM |
A "BiocParallelParam" instance.
See |
maxRowsMF |
For the exon fold change estimation, the size of the model matrix for the fitted glm increases with the number of samples and the number of exons for a specific gene (see the DEXSeq paper for details). Since the glm fit for big models is very slow, the maxRowsMF parameter allows to set a threshold on the number of rows from the model matrix (the number of rows of the model matrix will be number of samples times the number of exons of a gene). For all genes passing this threshold, the exon fold changes will be estimated by fitting a slightly different but equivalent model. The formula remains the same, but instead of fitting one model per gene that considers all its exons, it considers, for each exon, the counts from the specific exon and the sum of the rest of exons of the same gene. |
independentFiltering |
Logical indicating whether independent filtering should be applied automatically. For the exons that were discarded, fold changes won't be estimated. |
filter |
A vector of filter statistics over which the independent filtering will be optimized. The default is the normalized exon means. |
Exon usage coefficients are calculated by fitting
a GLM from the joint data of all exons of the same gene.
The model frame can be found in the slot object@modelFrameBM
of a DEXSeqDataSet
object. The model
'~ fitExpToVar * exon' is fitted.
The resulted coefficients are arranged and reformatted
in order to remove gene expression effects, leaving only exon
usage effects for each individual exon in each level of
'fitExpToVar'. These values are used by the function
plotDEXSeq
. For specific details please check
the DEXSeq paper.
data(pasillaDEXSeqDataSet, package="pasilla") dxd <- estimateSizeFactors( dxd ) dxd <- estimateDispersions( dxd ) dxd <- testForDEU( dxd ) dxd <- estimateExonFoldChanges( dxd )
data(pasillaDEXSeqDataSet, package="pasilla") dxd <- estimateSizeFactors( dxd ) dxd <- estimateDispersions( dxd ) dxd <- testForDEU( dxd ) dxd <- estimateExonFoldChanges( dxd )
Estimate the size factors for a DEXSeqDataSet
## S4 method for signature 'DEXSeqDataSet' estimateSizeFactors(object,locfunc=median,geoMeans)
## S4 method for signature 'DEXSeqDataSet' estimateSizeFactors(object,locfunc=median,geoMeans)
object |
a DEXSeqDataSet |
locfunc |
a function to compute a location for a
sample. By default, the median is used. However,
especially for low counts, the
|
geoMeans |
by default this is not provided and the geometric means of the counts are calculated within the function. A vector of geometric means from another count matrix can be provided for a "frozen" size factor calculation |
This function calls the method estimateSizeFactors for the DESeqDataSet object, and adapts it to the specific use to the DEXSeqDataSet.
The DEXSeqDataSet passed as parameters, with the size factors filled in.
Simon Anders, Wolfgang Huber: Differential expression analysis for sequence count data. Genome Biology 11 (2010) R106, http://dx.doi.org/10.1186/gb-2010-11-10-r106
Accessor functions of the DEXSeqDataSet object.
featureCounts(object, normalized=FALSE) featureIDs( object ) featureIDs( object ) <- value exonIDs( object ) exonIDs( object ) <- value groupIDs( object ) groupIDs( object ) <- value geneIDs( object ) geneIDs( object ) <- value sampleAnnotation( object )
featureCounts(object, normalized=FALSE) featureIDs( object ) featureIDs( object ) <- value exonIDs( object ) exonIDs( object ) <- value groupIDs( object ) groupIDs( object ) <- value geneIDs( object ) geneIDs( object ) <- value sampleAnnotation( object )
object |
An DEXSeqDataSet object. |
value |
A character vector to replace previous values. |
normalized |
Logical indicating whether or not to divide the counts by the size factors or normalization factors before returning (normalization factors always preempt size factors) |
'featureCounts' access the counts per exonic region or feature region names. 'featureIDs' and 'exonIDs' are accessor functions for the exon bin or features identifiers. 'groupIDs' and 'geneIDs' are accessor functions for the character vector grouping the features, for example exonIDs from the same gene are grouped together by having the same value in the geneIDs. 'sampleAnnotation' is an accessor for the information from the samples.
data(pasillaDEXSeqDataSet, package="pasilla") head( featureCounts( dxd ) ) head( featureIDs(dxd)) head( exonIDs(dxd))
data(pasillaDEXSeqDataSet, package="pasilla") head( featureCounts( dxd ) ) head( featureIDs(dxd)) head( exonIDs(dxd))
This function generates an MA plot.
## S4 method for signature 'DEXSeqResults,GenomicRanges' subsetByOverlaps( x, ranges, maxgap = -1L, minoverlap = 0L, type = c("any", "start", "end", "within", "equal"), ignore.strand = FALSE ) ## S4 method for signature 'DEXSeqResults,GenomicRanges' findOverlaps( query, subject, maxgap = -1L, minoverlap = 0L, type = c("any", "start", "end", "within", "equal"), ignore.strand = FALSE )
## S4 method for signature 'DEXSeqResults,GenomicRanges' subsetByOverlaps( x, ranges, maxgap = -1L, minoverlap = 0L, type = c("any", "start", "end", "within", "equal"), ignore.strand = FALSE ) ## S4 method for signature 'DEXSeqResults,GenomicRanges' findOverlaps( query, subject, maxgap = -1L, minoverlap = 0L, type = c("any", "start", "end", "within", "equal"), ignore.strand = FALSE )
query , x
|
Either a |
subject , ranges
|
A GRanges or GRangesList object. |
maxgap , minoverlap , type
|
See |
ignore.strand |
See |
data(pasillaDEXSeqDataSet, package="pasilla") dxd <- estimateSizeFactors( dxd ) dxd <- estimateDispersions( dxd ) dxd <- testForDEU( dxd ) dxr <- DEXSeqResults( dxd ) interestingRegion = GRanges("chr2L", IRanges(start=3872658, end=3875302)) subsetByOverlaps( x=dxr, ranges=interestingRegion ) findOverlaps( query=dxr, subject=interestingRegion )
data(pasillaDEXSeqDataSet, package="pasilla") dxd <- estimateSizeFactors( dxd ) dxd <- estimateDispersions( dxd ) dxd <- testForDEU( dxd ) dxr <- DEXSeqResults( dxd ) interestingRegion = GRanges("chr2L", IRanges(start=3872658, end=3875302)) subsetByOverlaps( x=dxr, ranges=interestingRegion ) findOverlaps( query=dxr, subject=interestingRegion )
The use case for this function is the following analysis: given per-exon p-values for null hypothesis H0, we can determine the number of genes in which at least for one exon H0 is rejected. What is the associated false disovery rate?
perGeneQValue(object, p = "pvalue", method = perGeneQValueExact)
perGeneQValue(object, p = "pvalue", method = perGeneQValueExact)
object |
An |
p |
A character string indicating the name of the columns in
|
method |
Use the default value. This is for debugging only. |
Details
A named numeric vector, values are per-gene q-values, names are gene.
data(pasillaDEXSeqDataSet, package="pasilla") dxd <- estimateSizeFactors( dxd ) dxd <- estimateDispersions( dxd ) dxd <- testForDEU( dxd ) dxr <- DEXSeqResults( dxd ) perGeneQValue(dxr)
data(pasillaDEXSeqDataSet, package="pasilla") dxd <- estimateSizeFactors( dxd ) dxd <- estimateDispersions( dxd ) dxd <- testForDEU( dxd ) dxr <- DEXSeqResults( dxd ) perGeneQValue(dxr)
The function provides a plot to visualize read count data,
expression and exon usage coefficients estimated from fitting
a GLM model 'counts ~ fitExpToVar * exon'. The model frame used
can be found in object@modelFrameBM
. One GLM is fitted
for each gene.
plotDEXSeq(object, geneID, FDR=0.1, fitExpToVar="condition", norCounts=FALSE, expression=TRUE, splicing=FALSE, displayTranscripts=FALSE, names=FALSE, legend=FALSE, color=NULL, color.samples=NULL, transcriptDb=NULL, additionalAnnotation=NULL, maxRowsMF=2400, ...)
plotDEXSeq(object, geneID, FDR=0.1, fitExpToVar="condition", norCounts=FALSE, expression=TRUE, splicing=FALSE, displayTranscripts=FALSE, names=FALSE, legend=FALSE, color=NULL, color.samples=NULL, transcriptDb=NULL, additionalAnnotation=NULL, maxRowsMF=2400, ...)
object |
A DEXSeqResults object. A DEXSeqDataSet object is also accepted, but only with the possibility of plotting the normalized read counts for each exon bin. |
geneID |
Gene identifier to visualize. |
FDR |
A false discovery rate. |
fitExpToVar |
A variable contained in the sample annotation of the |
norCounts |
If TRUE, provides a plot of the counts normalized by the size factors. |
expression |
If TRUE, the function plots the fitted EXPRESSION estimates from the glm regression. |
splicing |
If TRUE, the samples gene expression effects are averaged out, leaving only exon usage coefficients. |
displayTranscripts |
If TRUE, the transcripts are displayed in the plot. |
names |
If TRUE, the names of the transcripts are shown. |
legend |
If TRUE, a legend is displayed. |
color |
A vector of colors for each of the levels of the factor in the design of the ExonCountSet object indicated by "fitExpToVar". |
color.samples |
A vector of colors for each of the samples. If NULL, the colors of each sample will be assigned according to its corresponding level from "fitExpToVar". This option is useful to visualize complex experimental designs. |
transcriptDb |
A TxDb object, as defined in the GenomicFeatures package. This parameter is optional. If present and if 'displayTranscripts=TRUE', the transcript UTRs will be distinguished from the coding regions. |
additionalAnnotation |
A GRangesList object specifying the genomic coordinates of annotation features that should be plotted. This parameter is useful, for example, when one wants to show protein domain annotations. |
maxRowsMF |
See |
... |
Further graphical parameters (see |
graphics, segments
## Not run: data(pasillaDEXSeqDataSet, package="pasilla") dxd <- estimateSizeFactors( dxd ) dxd <- estimateDispersions( dxd ) dxd <- testForDEU( dxd ) dxr <- DEXSeqResults( dxd ) plotDEXSeq( dxr, "FBgn0010909" ) ## End(Not run)
## Not run: data(pasillaDEXSeqDataSet, package="pasilla") dxd <- estimateSizeFactors( dxd ) dxd <- estimateDispersions( dxd ) dxd <- testForDEU( dxd ) dxr <- DEXSeqResults( dxd ) plotDEXSeq( dxr, "FBgn0010909" ) ## End(Not run)
A simple helper function that plots the per-gene dispersion estimates together with the fitted mean-dispersion relationship. Internally, it is a wrapper for the pltoDispEsts method from DESeq2.
## S4 method for signature 'DEXSeqDataSet' plotDispEsts(object, ymin, genecol = "black", fitcol = "red", finalcol = "dodgerblue", legend=TRUE, xlab, ylab, log = "xy", cex = 0.45, ...)
## S4 method for signature 'DEXSeqDataSet' plotDispEsts(object, ymin, genecol = "black", fitcol = "red", finalcol = "dodgerblue", legend=TRUE, xlab, ylab, log = "xy", cex = 0.45, ...)
object |
a DESeqDataSet |
ymin |
the lower bound for points on the plot, points beyond this are drawn as triangles at ymin |
genecol |
the color for gene-wise dispersion estimates |
fitcol |
the color of the fitted estimates |
finalcol |
the color of the final estimates used for testing |
legend |
logical, whether to draw a legend |
xlab |
xlab |
ylab |
ylab |
log |
log |
cex |
cex |
... |
further arguments to |
This function generates an MA plot.
## S4 method for signature 'DEXSeqDataSet' plotMA( object, alpha=0.1, ylim=c(-2, 2), foldChangeColumn=NULL, ... ) ## S4 method for signature 'DEXSeqResults' plotMA( object, alpha=0.1, ylim=c(-2, 2), foldChangeColumn=NULL, ... )
## S4 method for signature 'DEXSeqDataSet' plotMA( object, alpha=0.1, ylim=c(-2, 2), foldChangeColumn=NULL, ... ) ## S4 method for signature 'DEXSeqResults' plotMA( object, alpha=0.1, ylim=c(-2, 2), foldChangeColumn=NULL, ... )
object |
Either a |
alpha |
the false discovery rate, i.e., threshold to the adjusted p values, to be used to colour the dots |
ylim |
y-limits of the plot |
foldChangeColumn |
Name of the column containing the fold changes to plot. If NULL, the first fold change column from the object will be taken. |
... |
Further parameters to be passed through to |
## Not run: data(pasillaDEXSeqDataSet, package="pasilla") dxd <- estimateSizeFactors( dxd ) dxd <- estimateDispersions( dxd ) dxd <- testForDEU( dxd ) dxd <- estimateExonFoldChanges( dxd ) dxr <- DEXSeqResults( dxd ) plotMA( dxr ) plotMA( dxd ) ## End(Not run)
## Not run: data(pasillaDEXSeqDataSet, package="pasilla") dxd <- estimateSizeFactors( dxd ) dxd <- estimateDispersions( dxd ) dxd <- testForDEU( dxd ) dxd <- estimateExonFoldChanges( dxd ) dxr <- DEXSeqResults( dxd ) plotMA( dxr ) plotMA( dxd ) ## End(Not run)
This will perform a likelihood ratio test for differential
exon usage. Internally, it calls the DESeq2 function nbinomLRT
.
testForDEU( object, fullModel = design(object), reducedModel = ~sample + exon, BPPARAM = SerialParam(), fitType = c("DESeq2", "glmGamPoi") )
testForDEU( object, fullModel = design(object), reducedModel = ~sample + exon, BPPARAM = SerialParam(), fitType = c("DESeq2", "glmGamPoi") )
object |
A DEXSeqDataSet object. |
fullModel |
The full model formula. |
reducedModel |
Null model formula. |
BPPARAM |
A "BiocParallelParam" instance. See |
fitType |
Specifies what internal engine to use for fitting the GLMs. Options are "DESeq2" or "glmGamPoi". |
The information of the variables of the formulas
should be present in the colData
of the
DEXSeqDataSet
object.
A DEXSeqDataSet
with slots filled with information about the test.
data(pasillaDEXSeqDataSet, package="pasilla") dxd <- estimateSizeFactors( dxd ) dxd <- estimateDispersions( dxd ) dxd <- testForDEU( dxd )
data(pasillaDEXSeqDataSet, package="pasilla") dxd <- estimateSizeFactors( dxd ) dxd <- estimateDispersions( dxd ) dxd <- testForDEU( dxd )