1 Basic DESeq2 results exploration

Project: Heart Development CS13 vs CS16 Report.

2 Introduction

This report is meant to help explore DESeq2 (Love, Huber, and Anders, 2014) results and was generated using the regionReport (Collado-Torres, Jaffe, and Leek, 2016) package. While the report is rich, it is meant to just start the exploration of the results and exemplify some of the code used to do so. If you need a more in-depth analysis for your specific data set you might want to use the customCode argument. This report is based on the vignette of the DESeq2 (Love, Huber, and Anders, 2014) package which you can find here.

2.1 Code setup

This section contains the code for setting up the rest of the report.

## knitrBoostrap and device chunk options
load_install('knitr')
opts_chunk$set(bootstrap.show.code = FALSE, dev = device)
if(!outputIsHTML) opts_chunk$set(bootstrap.show.code = FALSE, dev = device, echo = FALSE)
#### Libraries needed

## Bioconductor
load_install('DESeq2')
if(isEdgeR) load_install('edgeR')

## CRAN
load_install('ggplot2')
if(!is.null(theme)) theme_set(theme)
load_install('knitr')
if(is.null(colors)) {
    load_install('RColorBrewer')
}
load_install('pheatmap')
load_install('DT')
load_install('sessioninfo')

## Working behind the scenes
# load_install('knitcitations')
# load_install('rmarkdown')
## Optionally
# load_install('knitrBootstrap')

#### Code setup

## For ggplot
res.df <- as.data.frame(res)

## Sort results by adjusted p-values
ord <- order(res.df$padj, decreasing = FALSE)
res.df <- res.df[ord, ]
features <- rownames(res.df)
res.df <- cbind(data.frame(Feature = features), res.df)
rownames(res.df) <- NULL

3 PCA

## Transform count data
rld <- tryCatch(rlog(dds), error = function(e) { rlog(dds, fitType = 'mean') })

## Perform PCA analysis and make plot
plotPCA(rld, intgroup = intgroup)

## Get percent of variance explained
data_pca <- plotPCA(rld, intgroup = intgroup, returnData = TRUE)
percentVar <- round(100 * attr(data_pca, "percentVar"))

The above plot shows the first two principal components that explain the variability in the data using the regularized log count data. If you are unfamiliar with principal component analysis, you might want to check the Wikipedia entry or this interactive explanation. In this case, the first and second principal component explain 40 and 18 percent of the variance respectively.

4 Sample-to-sample distances

## Obtain the sample euclidean distances
sampleDists <- dist(t(assay(rld)))
sampleDistMatrix <- as.matrix(sampleDists)
## Add names based on intgroup
rownames(sampleDistMatrix) <- apply(as.data.frame(colData(rld)[, intgroup]), 1,
    paste, collapse = ' : ')
colnames(sampleDistMatrix) <- NULL

## Define colors to use for the heatmap if none were supplied
if(is.null(colors)) {
    colors <- colorRampPalette( rev(brewer.pal(9, "Blues")) )(255)
}

## Make the heatmap
pheatmap(sampleDistMatrix, clustering_distance_rows = sampleDists,
    clustering_distance_cols = sampleDists, color = colors)

This plot shows how samples are clustered based on their euclidean distance using the regularized log transformed count data. This figure gives an overview of how the samples are hierarchically clustered. It is a complementary figure to the PCA plot.

5 MA plots

This section contains three MA plots (see Wikipedia) that compare the mean of the normalized counts against the log fold change. They show one point per feature. The points are shown in red if the feature has an adjusted p-value less than alpha, that is, the statistically significant features are shown in red.

## MA plot with alpha used in DESeq2::results()
plotMA(res, alpha = metadata(res)$alpha, main = paste('MA plot with alpha =',
    metadata(res)$alpha))

This first plot shows uses alpha = 0.01, which is the alpha value used to determine which resulting features were significant when running the function DESeq2::results().

## MA plot with alpha = 1/2 of the alpha used in DESeq2::results()
plotMA(res, alpha = metadata(res)$alpha / 2,
    main = paste('MA plot with alpha =', metadata(res)$alpha / 2))

This second MA plot uses alpha = 0.005 and can be used agains the first MA plot to identify which features have adjusted p-values between 0.005 and 0.01.

## MA plot with alpha corresponding to the one that gives the nBest features
nBest.actual <- min(nBest, nrow(head(res.df, n = nBest)))
nBest.alpha <- head(res.df, n = nBest)$padj[nBest.actual]
plotMA(res, alpha = nBest.alpha * 1.00000000000001,
    main = paste('MA plot for top', nBest.actual, 'features'))

The third and final MA plot uses an alpha such that the top 2500 features are shown in the plot. These are the features that whose details are included in the top features interactive table.

6 P-values distribution

## P-value histogram plot
ggplot(res.df[!is.na(res.df$pvalue), ], aes(x = pvalue)) +
    geom_histogram(alpha=.5, position='identity', bins = 50) +
    labs(title='Histogram of unadjusted p-values') +
    xlab('Unadjusted p-values') +
    xlim(c(0, 1.0005))
## Warning: Removed 2 rows containing missing values (geom_bar).

This plot shows a histogram of the unadjusted p-values. It might be skewed right or left, or flat as shown in the Wikipedia examples. The shape depends on the percent of features that are differentially expressed. For further information on how to interpret a histogram of p-values check David Robinson’s post on this topic.

## P-value distribution summary
summary(res.df$pvalue)
##    Min. 1st Qu.  Median    Mean 3rd Qu.    Max. 
## 0.00000 0.04059 0.25953 0.34220 0.59857 1.00000

This is the numerical summary of the distribution of the p-values.

## Split features by different p-value cutoffs
pval_table <- lapply(c(1e-04, 0.001, 0.01, 0.025, 0.05, 0.1, 0.2, 0.3, 0.4, 0.5,
    0.6, 0.7, 0.8, 0.9, 1), function(x) {
    data.frame('Cut' = x, 'Count' = sum(res.df$pvalue <= x, na.rm = TRUE))
})
pval_table <- do.call(rbind, pval_table)
if(outputIsHTML) {
    kable(pval_table, format = 'markdown', align = c('c', 'c'))
} else {
    kable(pval_table)
}
Cut Count
0.0001 1441
0.0010 2331
0.0100 4192
0.0250 5561
0.0500 7005
0.1000 8917
0.2000 11637
0.3000 13938
0.4000 15909
0.5000 17773
0.6000 19620
0.7000 21261
0.8000 22859
0.9000 24537
1.0000 26122

This table shows the number of features with p-values less or equal than some commonly used cutoff values.

7 Adjusted p-values distribution

## Adjusted p-values histogram plot
ggplot(res.df[!is.na(res.df$padj), ], aes(x = padj)) +
    geom_histogram(alpha=.5, position='identity', bins = 50) +
    labs(title=paste('Histogram of', elementMetadata(res)$description[grep('adjusted', elementMetadata(res)$description)])) +
    xlab('Adjusted p-values') +
    xlim(c(0, 1.0005))
## Warning: Removed 2 rows containing missing values (geom_bar).

This plot shows a histogram of the BH adjusted p-values. It might be skewed right or left, or flat as shown in the Wikipedia examples.

## Adjusted p-values distribution summary
summary(res.df$padj)
##    Min. 1st Qu.  Median    Mean 3rd Qu.    Max.    NA's 
##   0.000   0.118   0.448   0.449   0.754   1.000    3545

This is the numerical summary of the distribution of the BH adjusted p-values.

## Split features by different adjusted p-value cutoffs
padj_table <- lapply(c(1e-04, 0.001, 0.01, 0.025, 0.05, 0.1, 0.2, 0.3, 0.4, 0.5,
    0.6, 0.7, 0.8, 0.9, 1), function(x) {
    data.frame('Cut' = x, 'Count' = sum(res.df$padj <= x, na.rm = TRUE))
})
padj_table <- do.call(rbind, padj_table)
if(outputIsHTML) {
    kable(padj_table, format = 'markdown', align = c('c', 'c'))
} else {
    kable(padj_table)
}
Cut Count
0.0001 823
0.0010 1314
0.0100 2320
0.0250 3120
0.0500 3958
0.1000 5286
0.2000 7286
0.3000 8994
0.4000 10586
0.5000 12269
0.6000 13970
0.7000 15839
0.8000 17930
0.9000 19953
1.0000 22577

This table shows the number of features with BH adjusted p-values less or equal than some commonly used cutoff values.

8 Top features

This interactive table shows the top 2500 features ordered by their BH adjusted p-values. Use the search function to find your feature of interest or sort by one of the columns.

## Add search url if appropriate
if(!is.null(searchURL) & outputIsHTML) {
    res.df$Feature <- paste0('<a href="', searchURL, res.df$Feature, '">',
        res.df$Feature, '</a>')
}

for(i in which(colnames(res.df) %in% c('pvalue', 'padj'))) res.df[, i] <- format(res.df[, i], scientific = TRUE)

if(outputIsHTML) {
    datatable(head(res.df, n = nBest), options = list(pagingType='full_numbers', pageLength=10, scrollX='100%'), escape = FALSE, rownames = FALSE) %>% formatRound(which(!colnames(res.df) %in% c('pvalue', 'padj', 'Feature')), digits)
} else {
    res.df_top <- head(res.df, n = 20)
    for(i in which(!colnames(res.df) %in% c('pvalue', 'padj', 'Feature'))) res.df_top[, i] <- round(res.df_top[, i], digits)
    kable(res.df_top)
}

9 Count plots top features

This section contains plots showing the normalized counts per sample for each group of interest. Only the best 10 features are shown, ranked by their BH adjusted p-values. The Y axis is on the log10 scale and the feature name is shown in the title of each plot.

plotCounts_gg <- function(i, dds, intgroup) {
    group <- if (length(intgroup) == 1) {
        colData(dds)[[intgroup]]
    } else if (length(intgroup) == 2) {
        lvls <- as.vector(t(outer(levels(colData(dds)[[intgroup[1]]]), 
            levels(colData(dds)[[intgroup[2]]]), function(x, 
                y) paste(x, y, sep = " : "))))
        droplevels(factor(apply(as.data.frame(colData(dds)[, 
            intgroup, drop = FALSE]), 1, paste, collapse = " : "), 
            levels = lvls))
    } else {
        factor(apply(as.data.frame(colData(dds)[, intgroup, drop = FALSE]), 
            1, paste, collapse = " : "))
    }
    data <- plotCounts(dds, gene=i, intgroup=intgroup, returnData = TRUE)
    ## Change in version 1.15.3
    ## It might not be necessary to have any of this if else, but I'm not
    ## sure that plotCounts(returnData) will always return the 'group' variable.
    if('group' %in% colnames(data)) {
        data$group <- group
    } else {
        data <- cbind(data, data.frame('group' = group))
    }

    ggplot(data, aes(x = group, y = count)) + geom_point() + ylab('Normalized count') + ggtitle(i) + coord_trans(y = "log10") + theme(axis.text.x = element_text(angle = 90, hjust = 1))
}
for(i in head(features, nBestFeatures)) {
    print(plotCounts_gg(i, dds = dds, intgroup = intgroup))
}

10 Reproducibility

The input for this report was generated with DESeq2 (Love, Huber, and Anders, 2014) using version 1.22.2 and the resulting features were called significantly differentially expressed if their BH adjusted p-values were less than alpha = 0.01. This report was generated in path /Users/jcotney/Google Drive/Heart Manuscript/EMERGE using the following call to DESeq2Report():

## DESeq2Report(dds = ddssva, project = "Heart Development CS13 vs CS16 Report", 
##     intgroup = c("sample"), res = resHeartCS13vsCS16, nBest = 2500, 
##     nBestFeatures = 10, outdir = "regionReport", output = "regionReportCS13VSCS16", 
##     searchURL = "http://www.ensembl.org/Homo_sapiens/Gene/Summary?g=", 
##     theme = theme_gray())

Date the report was generated.

## [1] "2020-04-10 14:47:10 EDT"

Wallclock time spent generating the report.

## Time difference of 1.664 mins

R session information.

## ─ Session info ───────────────────────────────────────────────────────────────────────────────────────────────────────
##  setting  value                       
##  version  R version 3.5.2 (2018-12-20)
##  os       macOS Mojave 10.14.6        
##  system   x86_64, darwin15.6.0        
##  ui       RStudio                     
##  language (EN)                        
##  collate  en_US.UTF-8                 
##  ctype    en_US.UTF-8                 
##  tz       America/New_York            
##  date     2020-04-10                  
## 
## ─ Packages ───────────────────────────────────────────────────────────────────────────────────────────────────────────
##  package              * version  date       lib source        
##  acepack                1.4.1    2016-10-29 [1] CRAN (R 3.5.0)
##  annotate               1.60.1   2019-03-07 [1] Bioconductor  
##  AnnotationDbi        * 1.44.0   2018-10-30 [1] Bioconductor  
##  AnnotationFilter       1.6.0    2018-10-30 [1] Bioconductor  
##  AnnotationForge        1.24.0   2018-10-30 [1] Bioconductor  
##  assertthat             0.2.1    2019-03-21 [1] CRAN (R 3.5.2)
##  backports              1.1.5    2019-10-02 [1] CRAN (R 3.5.2)
##  base64enc              0.1-3    2015-07-28 [1] CRAN (R 3.5.0)
##  bibtex                 0.4.2.2  2020-01-02 [1] CRAN (R 3.5.2)
##  Biobase              * 2.42.0   2018-10-30 [1] Bioconductor  
##  BiocGenerics         * 0.28.0   2018-10-30 [1] Bioconductor  
##  BiocManager            1.30.10  2019-11-16 [1] CRAN (R 3.5.2)
##  BiocParallel         * 1.16.6   2019-02-17 [1] Bioconductor  
##  BiocStyle            * 2.10.0   2018-10-30 [1] Bioconductor  
##  biomaRt              * 2.38.0   2018-10-30 [1] Bioconductor  
##  Biostrings             2.50.2   2019-01-03 [1] Bioconductor  
##  biovizBase             1.30.1   2018-12-11 [1] Bioconductor  
##  bit                    1.1-15.2 2020-02-10 [1] CRAN (R 3.5.2)
##  bit64                  0.9-7    2017-05-08 [1] CRAN (R 3.5.0)
##  bitops                 1.0-6    2013-08-17 [1] CRAN (R 3.5.0)
##  blob                   1.2.1    2020-01-20 [1] CRAN (R 3.5.2)
##  bookdown               0.18     2020-03-05 [1] CRAN (R 3.5.2)
##  BSgenome               1.50.0   2018-10-30 [1] Bioconductor  
##  bumphunter             1.24.5   2018-12-01 [1] Bioconductor  
##  callr                  3.4.3    2020-03-28 [1] CRAN (R 3.5.2)
##  Category               2.48.1   2019-03-07 [1] Bioconductor  
##  caTools                1.17.1.2 2019-03-06 [1] CRAN (R 3.5.2)
##  checkmate              2.0.0    2020-02-06 [1] CRAN (R 3.5.2)
##  cli                    2.0.2    2020-02-28 [1] CRAN (R 3.5.2)
##  cluster                2.1.0    2019-06-19 [1] CRAN (R 3.5.2)
##  clusterProfiler      * 3.10.1   2018-12-20 [1] Bioconductor  
##  codetools              0.2-16   2018-12-24 [1] CRAN (R 3.5.2)
##  colorspace             1.4-1    2019-03-18 [1] CRAN (R 3.5.2)
##  cowplot                1.0.0    2019-07-11 [1] CRAN (R 3.5.2)
##  crayon                 1.3.4    2017-09-16 [1] CRAN (R 3.5.0)
##  crosstalk              1.1.0.1  2020-03-13 [1] CRAN (R 3.5.2)
##  curl                   4.3      2019-12-02 [1] CRAN (R 3.5.2)
##  data.table             1.12.8   2019-12-09 [1] CRAN (R 3.5.2)
##  DBI                    1.1.0    2019-12-15 [1] CRAN (R 3.5.2)
##  DEFormats              1.10.1   2019-01-04 [1] Bioconductor  
##  DelayedArray         * 0.8.0    2018-10-30 [1] Bioconductor  
##  dendextend           * 1.13.4   2020-02-28 [1] CRAN (R 3.5.2)
##  derfinder              1.16.1   2018-12-03 [1] Bioconductor  
##  derfinderHelper        1.16.1   2018-12-03 [1] Bioconductor  
##  desc                   1.2.0    2018-05-01 [1] CRAN (R 3.5.0)
##  DESeq2               * 1.22.2   2019-01-04 [1] Bioconductor  
##  devtools             * 2.2.2    2020-02-17 [1] CRAN (R 3.5.2)
##  dichromat              2.0-0    2013-01-24 [1] CRAN (R 3.5.0)
##  digest                 0.6.25   2020-02-23 [1] CRAN (R 3.5.2)
##  DO.db                  2.9      2019-03-11 [1] Bioconductor  
##  doRNG                  1.8.2    2020-01-27 [1] CRAN (R 3.5.2)
##  DOSE                   3.8.2    2019-01-14 [1] Bioconductor  
##  dplyr                * 0.8.5    2020-03-07 [1] CRAN (R 3.5.2)
##  DT                   * 0.13     2020-03-23 [1] CRAN (R 3.5.2)
##  edgeR                  3.24.3   2019-01-02 [1] Bioconductor  
##  ellipsis               0.3.0    2019-09-20 [1] CRAN (R 3.5.2)
##  EnhancedVolcano      * 1.0.1    2019-01-04 [1] Bioconductor  
##  enrichplot             1.2.0    2018-10-30 [1] Bioconductor  
##  ensembldb              2.6.8    2019-04-03 [1] Bioconductor  
##  europepmc              0.3      2018-04-20 [1] CRAN (R 3.5.0)
##  evaluate               0.14     2019-05-28 [1] CRAN (R 3.5.2)
##  fansi                  0.4.1    2020-01-08 [1] CRAN (R 3.5.2)
##  farver                 2.0.3    2020-01-16 [1] CRAN (R 3.5.2)
##  fastmatch              1.1-0    2017-01-28 [1] CRAN (R 3.5.0)
##  fgsea                  1.8.0    2018-10-30 [1] Bioconductor  
##  foreach                1.5.0    2020-03-30 [1] CRAN (R 3.5.2)
##  foreign                0.8-76   2020-03-03 [1] CRAN (R 3.5.2)
##  Formula                1.2-3    2018-05-03 [1] CRAN (R 3.5.0)
##  fs                     1.3.2    2020-03-05 [1] CRAN (R 3.5.2)
##  gdata                  2.18.0   2017-06-06 [1] CRAN (R 3.5.0)
##  genefilter             1.64.0   2018-10-30 [1] Bioconductor  
##  geneplotter            1.60.0   2018-10-30 [1] Bioconductor  
##  GenomeInfoDb         * 1.18.2   2019-02-12 [1] Bioconductor  
##  GenomeInfoDbData       1.2.0    2019-03-11 [1] Bioconductor  
##  GenomicAlignments      1.18.1   2019-01-04 [1] Bioconductor  
##  GenomicFeatures      * 1.34.8   2019-04-10 [1] Bioconductor  
##  GenomicFiles           1.18.0   2018-10-30 [1] Bioconductor  
##  GenomicRanges        * 1.34.0   2018-10-30 [1] Bioconductor  
##  GGally                 1.5.0    2020-03-25 [1] CRAN (R 3.5.2)
##  ggbio                  1.30.0   2018-10-30 [1] Bioconductor  
##  ggforce                0.3.1    2019-08-20 [1] CRAN (R 3.5.2)
##  ggplot2              * 3.3.0    2020-03-05 [1] CRAN (R 3.5.2)
##  ggplotify              0.0.5    2020-03-12 [1] CRAN (R 3.5.2)
##  ggraph                 2.0.2    2020-03-17 [1] CRAN (R 3.5.2)
##  ggrepel              * 0.8.2    2020-03-08 [1] CRAN (R 3.5.2)
##  ggridges               0.5.2    2020-01-12 [1] CRAN (R 3.5.2)
##  Glimma               * 1.10.1   2019-01-04 [1] Bioconductor  
##  glue                   1.3.2    2020-03-12 [1] CRAN (R 3.5.2)
##  GO.db                  3.7.0    2019-03-11 [1] Bioconductor  
##  GOSemSim               2.8.0    2018-10-30 [1] Bioconductor  
##  GOstats                2.48.0   2018-10-30 [1] Bioconductor  
##  gplots               * 3.0.3    2020-02-25 [1] CRAN (R 3.5.2)
##  graph                  1.60.0   2018-10-30 [1] Bioconductor  
##  graphlayouts           0.6.0    2020-03-09 [1] CRAN (R 3.5.2)
##  gridExtra              2.3      2017-09-09 [1] CRAN (R 3.5.0)
##  gridGraphics           0.5-0    2020-02-25 [1] CRAN (R 3.5.2)
##  GSEABase               1.44.0   2018-10-30 [1] Bioconductor  
##  gtable                 0.3.0    2019-03-25 [1] CRAN (R 3.5.2)
##  gtools                 3.8.1    2018-06-26 [1] CRAN (R 3.5.0)
##  highr                  0.8      2019-03-20 [1] CRAN (R 3.5.2)
##  Hmisc                  4.4-0    2020-03-23 [1] CRAN (R 3.5.2)
##  hms                    0.5.3    2020-01-08 [1] CRAN (R 3.5.2)
##  htmlTable              1.13.3   2019-12-04 [1] CRAN (R 3.5.2)
##  htmltools              0.4.0    2019-10-04 [1] CRAN (R 3.5.2)
##  htmlwidgets            1.5.1    2019-10-08 [1] CRAN (R 3.5.2)
##  httr                   1.4.1    2019-08-05 [1] CRAN (R 3.5.2)
##  hwriter              * 1.3.2    2014-09-10 [1] CRAN (R 3.5.0)
##  igraph                 1.2.5    2020-03-19 [1] CRAN (R 3.5.2)
##  IRanges              * 2.16.0   2018-10-30 [1] Bioconductor  
##  iterators              1.0.12   2019-07-26 [1] CRAN (R 3.5.2)
##  jsonlite               1.6.1    2020-02-02 [1] CRAN (R 3.5.2)
##  KernSmooth             2.23-16  2019-10-15 [1] CRAN (R 3.5.2)
##  knitcitations          1.0.10   2019-09-15 [1] CRAN (R 3.5.2)
##  knitr                * 1.28     2020-02-06 [1] CRAN (R 3.5.2)
##  knitrBootstrap         1.0.2    2018-05-24 [1] CRAN (R 3.5.0)
##  labeling               0.3      2014-08-23 [1] CRAN (R 3.5.0)
##  lattice              * 0.20-40  2020-02-19 [1] CRAN (R 3.5.2)
##  latticeExtra           0.6-28   2016-02-09 [1] CRAN (R 3.5.0)
##  lazyeval               0.2.2    2019-03-15 [1] CRAN (R 3.5.2)
##  lifecycle              0.2.0    2020-03-06 [1] CRAN (R 3.5.2)
##  limma                  3.38.3   2018-12-02 [1] Bioconductor  
##  locfit                 1.5-9.4  2020-03-25 [1] CRAN (R 3.5.2)
##  lubridate              1.7.4    2018-04-11 [1] CRAN (R 3.5.0)
##  magick               * 2.3      2020-01-24 [1] CRAN (R 3.5.2)
##  magrittr               1.5      2014-11-22 [1] CRAN (R 3.5.0)
##  markdown               1.1      2019-08-07 [1] CRAN (R 3.5.2)
##  MASS                   7.3-51.5 2019-12-20 [1] CRAN (R 3.5.2)
##  Matrix                 1.2-18   2019-11-27 [1] CRAN (R 3.5.2)
##  matrixStats          * 0.56.0   2020-03-13 [1] CRAN (R 3.5.2)
##  memoise                1.1.0    2017-04-21 [1] CRAN (R 3.5.0)
##  munsell                0.5.0    2018-06-12 [1] CRAN (R 3.5.0)
##  nnet                   7.3-13   2020-02-25 [1] CRAN (R 3.5.2)
##  org.Hs.eg.db         * 3.7.0    2019-08-02 [1] Bioconductor  
##  OrganismDbi            1.24.0   2018-10-30 [1] Bioconductor  
##  PFAM.db                3.7.0    2020-04-08 [1] Bioconductor  
##  pheatmap             * 1.0.12   2019-01-04 [1] CRAN (R 3.5.2)
##  pillar                 1.4.3    2019-12-20 [1] CRAN (R 3.5.2)
##  pkgbuild               1.0.6    2019-10-09 [1] CRAN (R 3.5.2)
##  pkgconfig              2.0.3    2019-09-22 [1] CRAN (R 3.5.2)
##  pkgload                1.0.2    2018-10-29 [1] CRAN (R 3.5.0)
##  plyr                   1.8.6    2020-03-03 [1] CRAN (R 3.5.2)
##  polyclip               1.10-0   2019-03-14 [1] CRAN (R 3.5.2)
##  prettyunits            1.1.1    2020-01-24 [1] CRAN (R 3.5.2)
##  processx               3.4.2    2020-02-09 [1] CRAN (R 3.5.2)
##  progress               1.2.2    2019-05-16 [1] CRAN (R 3.5.2)
##  ProtGenerics           1.14.0   2018-10-30 [1] Bioconductor  
##  ps                     1.3.2    2020-02-13 [1] CRAN (R 3.5.2)
##  purrr                  0.3.3    2019-10-18 [1] CRAN (R 3.5.2)
##  qvalue                 2.14.1   2019-01-10 [1] Bioconductor  
##  R.methodsS3            1.8.0    2020-02-14 [1] CRAN (R 3.5.2)
##  R.oo                   1.23.0   2019-11-03 [1] CRAN (R 3.5.2)
##  R.utils                2.9.2    2019-12-08 [1] CRAN (R 3.5.2)
##  R6                     2.4.1    2019-11-12 [1] CRAN (R 3.5.2)
##  RBGL                   1.58.2   2019-03-22 [1] Bioconductor  
##  RColorBrewer         * 1.1-2    2014-12-07 [1] CRAN (R 3.5.0)
##  Rcpp                   1.0.4    2020-03-17 [1] CRAN (R 3.5.2)
##  RCurl                  1.98-1.1 2020-01-19 [1] CRAN (R 3.5.2)
##  RefManageR             1.2.12   2019-04-03 [1] CRAN (R 3.5.2)
##  regionReport         * 1.16.1   2018-12-03 [1] Bioconductor  
##  remotes                2.1.1    2020-02-15 [1] CRAN (R 3.5.2)
##  ReportingTools       * 2.22.1   2019-01-04 [1] Bioconductor  
##  reshape                0.8.8    2018-10-23 [1] CRAN (R 3.5.0)
##  reshape2               1.4.3    2017-12-11 [1] CRAN (R 3.5.0)
##  Rgraphviz              2.26.0   2018-10-30 [1] Bioconductor  
##  rlang                  0.4.5    2020-03-01 [1] CRAN (R 3.5.2)
##  rmarkdown              2.1      2020-01-20 [1] CRAN (R 3.5.2)
##  rngtools               1.5      2020-01-23 [1] CRAN (R 3.5.2)
##  rpart                  4.1-15   2019-04-12 [1] CRAN (R 3.5.2)
##  rprojroot              1.3-2    2018-01-03 [1] CRAN (R 3.5.0)
##  Rsamtools              1.34.1   2019-01-31 [1] Bioconductor  
##  RSQLite                2.2.0    2020-01-07 [1] CRAN (R 3.5.2)
##  rstudioapi             0.11     2020-02-07 [1] CRAN (R 3.5.2)
##  rtracklayer            1.42.2   2019-03-01 [1] Bioconductor  
##  rvcheck                0.1.8    2020-03-01 [1] CRAN (R 3.5.2)
##  S4Vectors            * 0.20.1   2018-11-09 [1] Bioconductor  
##  scales                 1.1.0    2019-11-18 [1] CRAN (R 3.5.2)
##  sessioninfo          * 1.1.1    2018-11-05 [1] CRAN (R 3.5.0)
##  stringi                1.4.6    2020-02-17 [1] CRAN (R 3.5.2)
##  stringr                1.4.0    2019-02-10 [1] CRAN (R 3.5.2)
##  SummarizedExperiment * 1.12.0   2018-10-30 [1] Bioconductor  
##  survival               3.1-11   2020-03-07 [1] CRAN (R 3.5.2)
##  testthat               2.3.2    2020-03-02 [1] CRAN (R 3.5.2)
##  tibble                 2.1.3    2019-06-06 [1] CRAN (R 3.5.2)
##  tidygraph              1.1.2    2019-02-18 [1] CRAN (R 3.5.2)
##  tidyr                  1.0.2    2020-01-24 [1] CRAN (R 3.5.2)
##  tidyselect             1.0.0    2020-01-27 [1] CRAN (R 3.5.2)
##  triebeard              0.3.0    2016-08-04 [1] CRAN (R 3.5.0)
##  tweenr                 1.0.1    2018-12-14 [1] CRAN (R 3.5.0)
##  UpSetR                 1.4.0    2019-05-22 [1] CRAN (R 3.5.2)
##  urltools               1.7.3    2019-04-14 [1] CRAN (R 3.5.2)
##  usethis              * 1.5.1    2019-07-04 [1] CRAN (R 3.5.2)
##  VariantAnnotation      1.28.13  2019-03-19 [1] Bioconductor  
##  vctrs                  0.2.4    2020-03-10 [1] CRAN (R 3.5.2)
##  vidger               * 1.2.1    2019-01-04 [1] Bioconductor  
##  viridis                0.5.1    2018-03-29 [1] CRAN (R 3.5.0)
##  viridisLite            0.3.0    2018-02-01 [1] CRAN (R 3.5.0)
##  withr                  2.1.2    2018-03-15 [1] CRAN (R 3.5.0)
##  xfun                   0.12     2020-01-13 [1] CRAN (R 3.5.2)
##  XML                    3.99-0.3 2020-01-20 [1] CRAN (R 3.5.2)
##  xml2                   1.2.5    2020-03-11 [1] CRAN (R 3.5.2)
##  xtable                 1.8-4    2019-04-21 [1] CRAN (R 3.5.2)
##  XVector                0.22.0   2018-10-30 [1] Bioconductor  
##  yaml                   2.2.1    2020-02-01 [1] CRAN (R 3.5.2)
##  zlibbioc               1.28.0   2018-10-30 [1] Bioconductor  
## 
## [1] /Library/Frameworks/R.framework/Versions/3.5/Resources/library

Pandoc version used: 1.19.2.1.

11 Bibliography

This report was created with regionReport (Collado-Torres, Jaffe, and Leek, 2016) using rmarkdown while knitr (Xie, 2014) and DT (Xie, Cheng, and Tan, 2020) were running behind the scenes. pheatmap (Kolde, 2019) was used to create the sample distances heatmap. Several plots were made with ggplot2 (Wickham, 2016).

Citations made with knitcitations (Boettiger, 2019). The BibTeX file can be found here.

[1] C. Boettiger. knitcitations: Citations for ‘Knitr’ Markdown Files. R package version 1.0.10. 2019. <URL: https://CRAN.R-project.org/package=knitcitations>.

[2] L. Collado-Torres, A. E. Jaffe, and J. T. Leek. “regionReport: Interactive reports for region-level and feature-level genomic analyses [version2; referees: 2 approved, 1 approved with reservations]”. In: F1000Research 4 (2016), p. 105. DOI: 10.12688/f1000research.6379.2. <URL: http://f1000research.com/articles/4-105/v2>.

[3] R. Kolde. pheatmap: Pretty Heatmaps. R package version 1.0.12. 2019. <URL: https://CRAN.R-project.org/package=pheatmap>.

[4] M. I. Love, W. Huber, and S. Anders. “Moderated estimation of fold change and dispersion for RNA-seq data with DESeq2”. In: Genome Biology 15 (12 2014), p. 550. DOI: 10.1186/s13059-014-0550-8.

[5] H. Wickham. ggplot2: Elegant Graphics for Data Analysis. Springer-Verlag New York, 2016. ISBN: 978-3-319-24277-4. <URL: https://ggplot2.tidyverse.org>.

[6] Y. Xie. “knitr: A Comprehensive Tool for Reproducible Research in R”. In: Implementing Reproducible Computational Research. Ed. by V. Stodden, F. Leisch and R. D. Peng. ISBN 978-1466561595. Chapman and Hall/CRC, 2014. <URL: http://www.crcpress.com/product/isbn/9781466561595>.

[7] Y. Xie, J. Cheng, and X. Tan. DT: A Wrapper of the JavaScript Library ‘DataTables’. R package version 0.13. 2020. <URL: https://CRAN.R-project.org/package=DT>.