FieldEffectCrc 1.15.0
Data included in this package was generated by harmonizing all publicly
available bulk RNA-seq samples from human primary colorectal tissue available
through NCBI’s Sequence Read Archive and
database of Genotypes and Phenotypes, NCI’s
Genomic Data Commons, and the NIH-funded
BarcUVa-Seq project. FASTQ files were downloaded
directly or generated from BAM files using
biobambam2. Gene expression
estimates were generated from FASTQ files using
Salmon and aggregated from quant.sf
files using
tximport.
The original processed data are stored as tab-delimited text on
Synapse under Synapse ID
syn22237139 and
packaged as SummarizedExperiment
objects on ExperimentHub
to facilitate
reproduction and extension of results published in Dampier et al. (PMCID:
PMC7386360, PMID: 32764205).
The following example demonstrates how to download the dataset from
ExperimentHub
.
First, make sure the Bioconductor packages BiocManager
,
SummarizedExperiment
, and ExperimentHub
are installed:
if (!requireNamespace("BiocManager", quietly=TRUE)) {
install.packages("BiocManager")
}
BiocManager::install(c("SummarizedExperiment", "ExperimentHub", "FieldEffectCrc"))
Second, load the SummarizedExperiment
and ExperimentHub
packages:
library(SummarizedExperiment)
## Loading required package: MatrixGenerics
## Loading required package: matrixStats
##
## Attaching package: 'MatrixGenerics'
## The following objects are masked from 'package:matrixStats':
##
## colAlls, colAnyNAs, colAnys, colAvgsPerRowSet, colCollapse,
## colCounts, colCummaxs, colCummins, colCumprods, colCumsums,
## colDiffs, colIQRDiffs, colIQRs, colLogSumExps, colMadDiffs,
## colMads, colMaxs, colMeans2, colMedians, colMins, colOrderStats,
## colProds, colQuantiles, colRanges, colRanks, colSdDiffs, colSds,
## colSums2, colTabulates, colVarDiffs, colVars, colWeightedMads,
## colWeightedMeans, colWeightedMedians, colWeightedSds,
## colWeightedVars, rowAlls, rowAnyNAs, rowAnys, rowAvgsPerColSet,
## rowCollapse, rowCounts, rowCummaxs, rowCummins, rowCumprods,
## rowCumsums, rowDiffs, rowIQRDiffs, rowIQRs, rowLogSumExps,
## rowMadDiffs, rowMads, rowMaxs, rowMeans2, rowMedians, rowMins,
## rowOrderStats, rowProds, rowQuantiles, rowRanges, rowRanks,
## rowSdDiffs, rowSds, rowSums2, rowTabulates, rowVarDiffs, rowVars,
## rowWeightedMads, rowWeightedMeans, rowWeightedMedians,
## rowWeightedSds, rowWeightedVars
## Loading required package: GenomicRanges
## Loading required package: stats4
## Loading required package: BiocGenerics
##
## Attaching package: 'BiocGenerics'
## The following objects are masked from 'package:stats':
##
## IQR, mad, sd, var, xtabs
## The following objects are masked from 'package:base':
##
## Filter, Find, Map, Position, Reduce, anyDuplicated, aperm, append,
## as.data.frame, basename, cbind, colnames, dirname, do.call,
## duplicated, eval, evalq, get, grep, grepl, intersect, is.unsorted,
## lapply, mapply, match, mget, order, paste, pmax, pmax.int, pmin,
## pmin.int, rank, rbind, rownames, sapply, saveRDS, setdiff, table,
## tapply, union, unique, unsplit, which.max, which.min
## Loading required package: S4Vectors
##
## Attaching package: 'S4Vectors'
## The following object is masked from 'package:utils':
##
## findMatches
## The following objects are masked from 'package:base':
##
## I, expand.grid, unname
## Loading required package: IRanges
## Loading required package: GenomeInfoDb
## Loading required package: Biobase
## Welcome to Bioconductor
##
## Vignettes contain introductory material; view with
## 'browseVignettes()'. To cite Bioconductor, see
## 'citation("Biobase")', and for packages 'citation("pkgname")'.
##
## Attaching package: 'Biobase'
## The following object is masked from 'package:MatrixGenerics':
##
## rowMedians
## The following objects are masked from 'package:matrixStats':
##
## anyMissing, rowMedians
library(ExperimentHub)
## Loading required package: AnnotationHub
## Loading required package: BiocFileCache
## Loading required package: dbplyr
##
## Attaching package: 'AnnotationHub'
## The following object is masked from 'package:Biobase':
##
## cache
Third, find the FieldEffectCrc
data objects and look at their descriptions:
hub = ExperimentHub()
## simply list the resource names
ns <- listResources(hub, "FieldEffectCrc")
ns
## [1] "cohort A from Dampier et al." "cohort B from Dampier et al."
## [3] "cohort C from Dampier et al."
## query the hub for full metadata
crcData <- query(hub, "FieldEffectCrc")
crcData
## ExperimentHub with 3 records
## # snapshotDate(): 2024-10-24
## # $dataprovider: Synapse
## # $species: Homo sapiens
## # $rdataclass: SummarizedExperiment
## # additional mcols(): taxonomyid, genome, description,
## # coordinate_1_based, maintainer, rdatadateadded, preparerclass, tags,
## # rdatapath, sourceurl, sourcetype
## # retrieve records with, e.g., 'object[["EH3524"]]'
##
## title
## EH3524 | cohort A from Dampier et al.
## EH3525 | cohort B from Dampier et al.
## EH3526 | cohort C from Dampier et al.
## extract metadata
df <- mcols(crcData)
df
## DataFrame with 3 rows and 15 columns
## title dataprovider species taxonomyid genome
## <character> <character> <character> <integer> <character>
## EH3524 cohort A from Dampie.. Synapse Homo sapiens 9606 GRCh38
## EH3525 cohort B from Dampie.. Synapse Homo sapiens 9606 GRCh38
## EH3526 cohort C from Dampie.. Synapse Homo sapiens 9606 GRCh38
## description coordinate_1_based maintainer
## <character> <integer> <character>
## EH3524 Salmon-generated tra.. 1 Chris Dampier <chd5n..
## EH3525 Salmon-generated tra.. 1 Chris Dampier <chd5n..
## EH3526 Salmon-generated tra.. 1 Chris Dampier <chd5n..
## rdatadateadded preparerclass
## <character> <character>
## EH3524 2020-07-10 FieldEffectCrc
## EH3525 2020-07-10 FieldEffectCrc
## EH3526 2020-07-10 FieldEffectCrc
## tags rdataclass
## <AsIs> <character>
## EH3524 ExperimentData,ReproducibleResearch,Tissue,... SummarizedExperiment
## EH3525 ExperimentData,ReproducibleResearch,Tissue,... SummarizedExperiment
## EH3526 ExperimentData,ReproducibleResearch,Tissue,... SummarizedExperiment
## rdatapath sourceurl sourcetype
## <character> <character> <character>
## EH3524 FieldEffectCrc/Field.. https://www.synapse... tar.gz
## EH3525 FieldEffectCrc/Field.. https://www.synapse... tar.gz
## EH3526 FieldEffectCrc/Field.. https://www.synapse... tar.gz
## see where the cache is stored
hc <- hubCache(crcData)
hc
## [1] "/home/biocbuild/.cache/R/ExperimentHub"
Fourth, explore the metadata of a particular file. Let’s look at the data for cohort A:
md <- hub["EH3524"]
md
## ExperimentHub with 1 record
## # snapshotDate(): 2024-10-24
## # names(): EH3524
## # package(): FieldEffectCrc
## # $dataprovider: Synapse
## # $species: Homo sapiens
## # $rdataclass: SummarizedExperiment
## # $rdatadateadded: 2020-07-10
## # $title: cohort A from Dampier et al.
## # $description: Salmon-generated transcript-level abundance estimates summar...
## # $taxonomyid: 9606
## # $genome: GRCh38
## # $sourcetype: tar.gz
## # $sourceurl: https://www.synapse.org/#!Synapse:syn22237139/files/
## # $sourcesize: NA
## # $tags: c("ExperimentData", "ReproducibleResearch", "Tissue",
## # "Homo_sapiens_Data", "ColonCancerData", "RNASeqData",
## # "ExpressionData", "ExperimentHub")
## # retrieve record with 'object[["EH3524"]]'
Fifth, download the data object itself as a SummarizedExperiment
:
## using resource ID
data1 <- hub[["EH3524"]]
## see ?FieldEffectCrc and browseVignettes('FieldEffectCrc') for documentation
## loading from cache
data1
## class: SummarizedExperiment
## dim: 37361 834
## metadata(4): cohort build assay feature
## assays(3): abundance counts length
## rownames(37361): ENSG00000000003 ENSG00000000005 ... ENSG00000283698
## ENSG00000283700
## rowData names(0):
## colnames(834): AMC_10 AMC_12 ... VM1421 VM1422
## colData names(27): dirName projId ... percMap data
## using loadResources()
data2 <- loadResources(hub, "FieldEffectCrc", "cohort A")
## see ?FieldEffectCrc and browseVignettes('FieldEffectCrc') for documentation
## loading from cache
data2
## [[1]]
## class: SummarizedExperiment
## dim: 37361 834
## metadata(4): cohort build assay feature
## assays(3): abundance counts length
## rownames(37361): ENSG00000000003 ENSG00000000005 ... ENSG00000283698
## ENSG00000283700
## rowData names(0):
## colnames(834): AMC_10 AMC_12 ... VM1421 VM1422
## colData names(27): dirName projId ... percMap data
Since the data is a SummarizedExperiment
, the different phenotypes can be
accessed using colData()
. The phenotype of interest in the field effect
analysis is referred to as sampType
:
summary(colData(data1)$sampType)
## CRC HLT NAT
## 311 462 61
To immediately access the count data for the 834 samples in cohort A, load the
SummarizedExperiment
object for cohort A as demonstrated in the
Installation section immediately above. Then use the assays()
accessor function to extract the counts
assay, which is the second assay in
the SummarizedExperiment
:
se <- data1
counts1 <- assays(se)[["counts"]]
Note that assay()
, the singular as opposed to plural, will by default extract
the first assay element from a SummarizedExperiment
but will extract the ’i’th
assay element with the assay(se, i)
syntax:
counts2 <- assay(se, 2)
The two alternatives are equivalent:
all(counts1==counts2)
## [1] TRUE
We are interested in conducting a differential expression analysis using
DESeq2
to identify genes over- and under-expressed in different colorectal
tissue phenotypes. Due to substantial technical artifacts between single-end and
paired-end library formats observed in the full FieldEffectCrc
data set,
samples are grouped according to library format, with paired-end samples in
cohorts A and B and single-end samples in cohort C. Cohort A is the primary
analysis cohort and the one we want to use to discover differentially expressed
genes. To begin, load cohort A as demonstrated in the
Installation section immediately above if not already loaded.
In the following steps, we will use DESeq2
to perform differential expression
analysis on expression data stored in the SummarizedExperiment
object for
cohort A. We will adjust for latent batch effects with surrogate variable
analysis as implemented in the sva
package. This analysis would typically
consume excess memory and time, so for the purpose of demonstration, we perform
the analysis on a small subset of the full data.
In order to take advantage of the feature lengths preserved by tximport
, we
will recreate a tximport
object from the SummarizedExperiment
object
downloaded from ExperimentHub
and use the DESeqDataSetFromTximport()
function to create the DESeqDataSet
object. Alternatively, the
SummarizedExperiment
object itself could be used to create the DESeqDataSet
object using the DESeqDataSet()
function, but the order of the assays would
need to be re-arranged and the counts would need to be rounded, as the
DESeqDataSet()
function expects counts
with integer values to be the first
assay in a SummarizedExperiment
object, and abundance
with floating-point
values is the first assay in the FieldEffectCrc
objects to facilitate
conversion to tximport
objects. Such a re-ordering is facilitated by the FieldEffectCrc::reorder_assays()
function. Yet another option is to extract
the counts
assay as a matrix and use the DESeqDataSetFromMatrix()
function
to create the DESeqDataSet
object. Since there are probably some benefits to
feature length normalization as implemented in DESeq2
when such information is
available, we demonstrate creation of the tximport
object.
First, make the tximport
object, which is just an object of class list
from
base R:
## manual construction
txi <- as.list(assays(se))
txi$countsFromAbundance <- "no"
## convenience function construction
txi <- make_txi(se)
Next, we could assign the clinical annotations from colData(se)
to an
S4Vectors::DataFrame
or a base::data.frame
object, since that is what
DESeqDataSetFromTximport()
expects for the colData
argument. However, the
colData
slot of a SummarizedExperiment
object already stores the clinical
annotations as an S4Vectors::DataFrame
, so we are ready to create the
DESeqDataSet
object:
if (!requireNamespace("DESeq2", quietly=TRUE)) {
BiocManager::install("DESeq2")
}
library(DESeq2)
dds <- DESeqDataSetFromTximport(txi, colData(se), ~ sampType)
## using counts and average transcript lengths from tximport
Note that we are interested in expression differences between phenotypes, which
are coded in the sampType
field, so we include sampType
in our preliminary
design.
Normally, we would pre-filter genes to select genes whose quantities are likely to be estimated accurately. We could use something like the following code, which selects for genes with a count greater than 10 RNA molecules in at least a third of all samples:
countLimit <- 10
sampleLimit <- (1/3) * ncol(dds)
keep <- rowSums( counts(dds) > countLimit ) >= sampleLimit
dds <- dds[keep, ]
However, to expedite subsequent computational steps in this demonstration, we will select a random subset of genes and samples for analysis and then filter out any gene with a count less than 10 across all samples:
r <- sample(seq_len(nrow(dds)), 6000)
c <- sample(seq_len(ncol(dds)), 250)
dds <- dds[r, c]
r <- rowSums(counts(dds)) >= 10
dds <- dds[r, ]
Amazingly, DESeq2
estimates size factors (i.e. normalization factors based on
library size and feature length) and dispersions for every gene, fits negative
binomial models for every gene, and performs a Wald test for every gene in a
single function:
dds <- DESeq(dds)
## estimating size factors
## using 'avgTxLength' from assays(dds), correcting for library size
## estimating dispersions
## gene-wise dispersion estimates
## mean-dispersion relationship
## final dispersion estimates
## fitting model and testing
## -- replacing outliers and refitting for 155 genes
## -- DESeq argument 'minReplicatesForReplace' = 7
## -- original counts are preserved in counts(dds)
## estimating dispersions
## fitting model and testing
Pretty incredible. Unfortunately, we have to do some more work before we can fit
useful models. The size factor estimates are the key result of the DESeq()
function at this stage.
If we trusted our high-throughput assays to be perfect representations of the
underlying biology they were designed to measure, we would be ready to test for
differential expression. However, our dataset is composed of samples from
several studies collected and processed in various ways over several years, so
we have reason to suspect there are latent factors driving non-biological
variation in the expression data. Fortunately, we can use sva
to estimate the
latent factors and include them in our DESeq2
design.
For a full tutorial on how to use the sva
package, see the package
vignette.
For this demonstration, we will provide only cursory motivations for the code.
The sva
functions will take the normalized count data as well as model
matrices as inputs. The full model matrix should include the variables of
interest (e.g. sampType
) as well as adjustment variables (e.g. sex
, age
),
which we do not use here. The null model matrix should include adjustment
variables only (i.e. no variables of interest). Without any adjustment
variables, the null model includes an intercept term alone.
dat <- counts(dds, normalized=TRUE) ## extract the normalized counts
mod <- model.matrix(~sampType, data=colData(dds)) ## set the full model
mod0 <- model.matrix(~1, data=colData(dds)) ## set the null model
The sva
package offers two approaches for estimating the number of surrogate
variables that should be included in a differential expression model, the Buja
Eyuboglu and Leek approaches. Buja Eyuboglu is the default approach.
if (!requireNamespace("sva", quietly=TRUE)) {
BiocManager::install("sva")
}
library(sva)
## Loading required package: mgcv
## Loading required package: nlme
##
## Attaching package: 'nlme'
## The following object is masked from 'package:IRanges':
##
## collapse
## This is mgcv 1.9-1. For overview type 'help("mgcv-package")'.
## Loading required package: genefilter
##
## Attaching package: 'genefilter'
## The following objects are masked from 'package:MatrixGenerics':
##
## rowSds, rowVars
## The following objects are masked from 'package:matrixStats':
##
## rowSds, rowVars
## Loading required package: BiocParallel
nsv <- num.sv(dat, mod, method=c("be"), B=20, seed=1) ## Buja Eyuboglu method
The crucial function for estimating surrogate variables in RNA-seq data is
svaseq()
:
svs <- svaseq(dat, mod, mod0, n.sv=nsv)
## Number of significant surrogate variables is: 1
## Iteration (out of 5 ):1 2 3 4 5
The output is a list of 4 elements, the first of which is the latent factor
estimate with a vector for each factor. The name of this element is sv
.
We want to include the latent factors as adjustment variables in our statistical
testing. Here, we add the surrogate variables to colData
and update the
DESeqDataSet
design formula:
for (i in seq_len(svs$n.sv)) {
newvar <- paste0("sv", i)
colData(dds)[ , newvar] <- svs$sv[, i]
}
nvidx <- (ncol(colData(dds)) - i + 1):ncol(colData(dds))
newvars <- colnames(colData(dds))[nvidx]
d <- formula(
paste0("~", paste(paste(newvars, collapse="+"), "sampType", sep="+"))
)
design(dds) <- d
Now that we have the surrogate variables in the DESeqDataSet
, we can perform
the differential expression analysis we set out to do:
dds <- DESeq(dds)
## using pre-existing normalization factors
## estimating dispersions
## found already estimated dispersions, replacing these
## gene-wise dispersion estimates
## mean-dispersion relationship
## final dispersion estimates
## fitting model and testing
We want to extract results from each of the following 3 comparisons:
With three categories under consideration, the DESeq()
function call tests the
first level against the other two, but the second and third levels are not
tested against each other. (Note that the order of the levels is simply
alphabetical if they are not explicitly set.) Furthermore, the results reported
with the results()
function are for the comparison of the first level against
the last by default. Therefore, in order to extract all the results of interest,
we set contrasts as follows:
cons <- list()
m <- combn(levels(colData(dds)$sampType), 2)
for (i in seq_len(ncol(m))) {
cons[[i]] <- c("sampType", rev(m[, i]))
names(cons) <- c(
names(cons)[seq_len(length(cons) - 1)], paste(rev(m[, i]), collapse="v")
)
}
res <- list()
for (i in seq_len(length(cons))) {
res[[i]] <- results(dds, contrast=cons[[i]], alpha=0.05) ## default alpha is 0.1
}
names(res) <- names(cons)
Let’s take a look at the results:
lapply(res, head)
## $HLTvCRC
## log2 fold change (MLE): sampType HLT vs CRC
## Wald test p-value: sampType HLT vs CRC
## DataFrame with 6 rows and 6 columns
## baseMean log2FoldChange lfcSE stat pvalue
## <numeric> <numeric> <numeric> <numeric> <numeric>
## ENSG00000251349 48.3350 -0.452806 0.1193758 -3.793114 1.48770e-04
## ENSG00000189152 43.2409 0.709923 0.1485767 4.778160 1.76907e-06
## ENSG00000110080 1383.8467 0.158135 0.1961194 0.806318 4.20059e-01
## ENSG00000138308 146.6435 -1.066786 0.2674974 -3.988024 6.66259e-05
## ENSG00000145014 809.9692 0.250160 0.0817648 3.059505 2.21703e-03
## ENSG00000087470 2346.3064 0.434806 0.0438437 9.917178 3.50527e-23
## padj
## <numeric>
## ENSG00000251349 2.00184e-04
## ENSG00000189152 2.59585e-06
## ENSG00000110080 4.42634e-01
## ENSG00000138308 9.11435e-05
## ENSG00000145014 2.78813e-03
## ENSG00000087470 8.44304e-23
##
## $NATvCRC
## log2 fold change (MLE): sampType NAT vs CRC
## Wald test p-value: sampType NAT vs CRC
## DataFrame with 6 rows and 6 columns
## baseMean log2FoldChange lfcSE stat pvalue
## <numeric> <numeric> <numeric> <numeric> <numeric>
## ENSG00000251349 48.3350 0.0136638 0.1946283 0.0702046 0.9440308
## ENSG00000189152 43.2409 0.4762473 0.2451273 1.9428571 0.0520334
## ENSG00000110080 1383.8467 -0.2937739 0.3246756 -0.9048228 0.3655593
## ENSG00000138308 146.6435 -0.2822789 0.4421588 -0.6384108 0.5232063
## ENSG00000145014 809.9692 -0.0465814 0.1353321 -0.3442010 0.7306952
## ENSG00000087470 2346.3064 0.1181511 0.0725464 1.6286276 0.1033919
## padj
## <numeric>
## ENSG00000251349 0.973144
## ENSG00000189152 0.200149
## ENSG00000110080 0.614041
## ENSG00000138308 0.742312
## ENSG00000145014 0.868332
## ENSG00000087470 0.303647
##
## $NATvHLT
## log2 fold change (MLE): sampType NAT vs HLT
## Wald test p-value: sampType NAT vs HLT
## DataFrame with 6 rows and 6 columns
## baseMean log2FoldChange lfcSE stat pvalue
## <numeric> <numeric> <numeric> <numeric> <numeric>
## ENSG00000251349 48.3350 0.466470 0.1876994 2.485197 1.29480e-02
## ENSG00000189152 43.2409 -0.233676 0.2346667 -0.995778 3.19358e-01
## ENSG00000110080 1383.8467 -0.451909 0.3104657 -1.455583 1.45508e-01
## ENSG00000138308 146.6435 0.784507 0.4231717 1.853874 6.37571e-02
## ENSG00000145014 809.9692 -0.296741 0.1294559 -2.292219 2.18930e-02
## ENSG00000087470 2346.3064 -0.316655 0.0694118 -4.561974 5.06748e-06
## padj
## <numeric>
## ENSG00000251349 0.018717627
## ENSG00000189152 0.364234469
## ENSG00000110080 0.177304605
## ENSG00000138308 0.082981099
## ENSG00000145014 0.030626748
## ENSG00000087470 0.000010528
lapply(res, summary)
##
## out of 6000 with nonzero total read count
## adjusted p-value < 0.05
## LFC > 0 (up) : 2534, 42%
## LFC < 0 (down) : 2658, 44%
## outliers [1] : 0, 0%
## low counts [2] : 0, 0%
## (mean count < 7)
## [1] see 'cooksCutoff' argument of ?results
## [2] see 'independentFiltering' argument of ?results
##
##
## out of 6000 with nonzero total read count
## adjusted p-value < 0.05
## LFC > 0 (up) : 444, 7.4%
## LFC < 0 (down) : 294, 4.9%
## outliers [1] : 0, 0%
## low counts [2] : 0, 0%
## (mean count < 7)
## [1] see 'cooksCutoff' argument of ?results
## [2] see 'independentFiltering' argument of ?results
##
##
## out of 6000 with nonzero total read count
## adjusted p-value < 0.05
## LFC > 0 (up) : 2266, 38%
## LFC < 0 (down) : 2188, 36%
## outliers [1] : 0, 0%
## low counts [2] : 0, 0%
## (mean count < 7)
## [1] see 'cooksCutoff' argument of ?results
## [2] see 'independentFiltering' argument of ?results
## $HLTvCRC
## NULL
##
## $NATvCRC
## NULL
##
## $NATvHLT
## NULL
sessionInfo()
## R Under development (unstable) (2024-10-21 r87258)
## Platform: x86_64-pc-linux-gnu
## Running under: Ubuntu 24.04.1 LTS
##
## Matrix products: default
## BLAS: /home/biocbuild/bbs-3.21-bioc/R/lib/libRblas.so
## LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.12.0
##
## locale:
## [1] LC_CTYPE=en_US.UTF-8 LC_NUMERIC=C
## [3] LC_TIME=en_GB LC_COLLATE=C
## [5] LC_MONETARY=en_US.UTF-8 LC_MESSAGES=en_US.UTF-8
## [7] LC_PAPER=en_US.UTF-8 LC_NAME=C
## [9] LC_ADDRESS=C LC_TELEPHONE=C
## [11] LC_MEASUREMENT=en_US.UTF-8 LC_IDENTIFICATION=C
##
## time zone: America/New_York
## tzcode source: system (glibc)
##
## attached base packages:
## [1] stats4 stats graphics grDevices utils datasets methods
## [8] base
##
## other attached packages:
## [1] sva_3.53.0 BiocParallel_1.39.0
## [3] genefilter_1.87.0 mgcv_1.9-1
## [5] nlme_3.1-166 DESeq2_1.45.3
## [7] FieldEffectCrc_1.15.0 ExperimentHub_2.13.1
## [9] AnnotationHub_3.13.3 BiocFileCache_2.13.2
## [11] dbplyr_2.5.0 SummarizedExperiment_1.35.5
## [13] Biobase_2.65.1 GenomicRanges_1.57.2
## [15] GenomeInfoDb_1.41.2 IRanges_2.39.2
## [17] S4Vectors_0.43.2 BiocGenerics_0.51.3
## [19] MatrixGenerics_1.17.1 matrixStats_1.4.1
## [21] BiocStyle_2.33.1
##
## loaded via a namespace (and not attached):
## [1] DBI_1.2.3 rlang_1.1.4 magrittr_2.0.3
## [4] compiler_4.5.0 RSQLite_2.3.7 png_0.1-8
## [7] vctrs_0.6.5 pkgconfig_2.0.3 crayon_1.5.3
## [10] fastmap_1.2.0 XVector_0.45.0 utf8_1.2.4
## [13] rmarkdown_2.28 UCSC.utils_1.1.0 purrr_1.0.2
## [16] bit_4.5.0 xfun_0.48 zlibbioc_1.51.2
## [19] cachem_1.1.0 jsonlite_1.8.9 blob_1.2.4
## [22] DelayedArray_0.31.14 parallel_4.5.0 R6_2.5.1
## [25] bslib_0.8.0 limma_3.61.12 jquerylib_0.1.4
## [28] Rcpp_1.0.13 bookdown_0.41 knitr_1.48
## [31] Matrix_1.7-1 splines_4.5.0 tidyselect_1.2.1
## [34] abind_1.4-8 yaml_2.3.10 codetools_0.2-20
## [37] RUnit_0.4.33 curl_5.2.3 lattice_0.22-6
## [40] tibble_3.2.1 withr_3.0.1 KEGGREST_1.45.1
## [43] evaluate_1.0.1 survival_3.7-0 Biostrings_2.73.2
## [46] pillar_1.9.0 BiocManager_1.30.25 filelock_1.0.3
## [49] generics_0.1.3 BiocVersion_3.20.0 ggplot2_3.5.1
## [52] munsell_0.5.1 scales_1.3.0 xtable_1.8-4
## [55] glue_1.8.0 tools_4.5.0 annotate_1.83.0
## [58] locfit_1.5-9.10 XML_3.99-0.17 grid_4.5.0
## [61] AnnotationDbi_1.67.0 edgeR_4.3.21 colorspace_2.1-1
## [64] GenomeInfoDbData_1.2.13 cli_3.6.3 rappdirs_0.3.3
## [67] fansi_1.0.6 S4Arrays_1.5.11 dplyr_1.1.4
## [70] gtable_0.3.6 sass_0.4.9 digest_0.6.37
## [73] SparseArray_1.5.45 memoise_2.0.1 htmltools_0.5.8.1
## [76] lifecycle_1.0.4 httr_1.4.7 statmod_1.5.0
## [79] mime_0.12 bit64_4.5.2