systemPipeTools 1.0.0
systemPipeRsystemPipeTools package extends the widely used systemPipeR (SPR) (H Backman and Girke 2016) workflow environment with enhanced toolkit for data visualization, including utilities to automate the analysis of differentially expressed genes (DEGs). systemPipeTools provides functions for data transformation and data exploration via scatterplots, hierarchical clustering heatMaps, principal component analysis, multidimensional scaling, generalized principal components, t-Distributed Stochastic Neighbor embedding (t-SNE), and MA and volcano plots. All these utilities can be integrated with the modular design of the systemPipeR environment that allows users to easily substitute any of these features and/or custom with alternatives.
systemPipeTools environment can be installed from the R console using the BiocManager::install
command. The associated package systemPipeR
can be installed the same way. The latter provides core functionalities for
defining workflows, interacting with command-line software, and executing both
R and/or command-line software, as well as generating publication-quality
analysis reports.
if (!requireNamespace("BiocManager", quietly = TRUE)) install.packages("BiocManager")
BiocManager::install("systemPipeTools")
BiocManager::install("systemPipeR")library("systemPipeTools")  # Loads the package
library(help = "systemPipeTools")  # Lists package info
vignette("systemPipeTools")  # Opens vignetteThe first step is importing the targets file and raw reads counting table.
- The targets file defines all FASTQ files and sample comparisons of the
analysis workflow.
- The raw reads counting table represents all the reads that map to gene
(row) for each sample (columns).
## Targets file
targetspath <- system.file("extdata", "targets.txt", package = "systemPipeR")
targets <- read.delim(targetspath, comment = "#")
cmp <- systemPipeR::readComp(file = targetspath, format = "matrix", delim = "-")
## Count table file
countMatrixPath <- system.file("extdata", "countDFeByg.xls", package = "systemPipeR")
countMatrix <- read.delim(countMatrixPath, row.names = 1)
showDT(countMatrix)For gene differential expression, raw counts are required, however for data
visualization or clustering, it can be useful to work with transformed count
data.
exploreDDS function is convenience wrapper to transform raw read counts
using the DESeq2 package transformations methods. The input
file has to contain all the genes, not just differentially expressed ones.
Supported methods include variance stabilizing transformation (vst)
(Anders and Huber (2010)), and regularized-logarithm transformation or rlog
(Love, Huber, and Anders (2014)).
exploredds <- exploreDDS(countMatrix, targets, cmp = cmp[[1]], preFilter = NULL, 
    transformationMethod = "rlog")
exploredds## class: DESeqTransform 
## dim: 116 18 
## metadata(1): version
## assays(1): ''
## rownames(116): AT1G01010 AT1G01020 ... ATMG00180 ATMG00200
## rowData names(51): baseMean baseVar ... dispFit rlogIntercept
## colnames(18): M1A M1B ... V12A V12B
## colData names(2): condition sizeFactorUsers are strongly encouraged to consult the DESeq2 vignette
for more detailed information on this topic and how to properly run DESeq2 on
datasets with more complex experimental designs.
To decide which transformation to choose, we can visualize the transformation effect comparing two samples or a grid of all samples, as follows:
exploreDDSplot(countMatrix, targets, cmp = cmp[[1]], preFilter = NULL, samples = c("M12A", 
    "M12A", "A12A", "A12A"), scattermatrix = TRUE)The scatterplots are created using the log2 transform normalized reads count,
variance stabilizing transformation (VST) (Anders and Huber (2010)), and
regularized-logarithm transformation or rlog (Love, Huber, and Anders (2014)).
The following computes the sample-wise correlation coefficients using the
stats::cor() function from the transformed expression values. After
transformation to a distance matrix, hierarchical clustering is performed with
the stats::hclust function and the result is plotted as a dendrogram,
as follows:
hclustplot(exploredds, method = "spearman")The function provides the utility to save the plot automatically.
This function performs hierarchical clustering on the transformed expression
matrix generated within the DESeq2 package. It uses, by default, a Pearson
correlation-based distance measure and complete linkage for cluster join.
If samples selected in the clust argument, it will be applied the
stats::dist() function to the transformed count matrix to get sample-to-sample
distances. Also, it is possible to generate the pheatmap or plotly
plot format.
## Samples plot
heatMaplot(exploredds, clust = "samples", plotly = FALSE)If ind selected in the clust argument, it is necessary to provide the list
of differentially expressed genes for the exploredds subset.
## Individuals genes identified in DEG analysis DEG analysis with `systemPipeR`
degseqDF <- systemPipeR::run_DESeq2(countDF = countMatrix, targets = targets, cmp = cmp[[1]], 
    independent = FALSE)
DEG_list <- systemPipeR::filterDEGs(degDF = degseqDF, filter = c(Fold = 2, FDR = 10))### Plot
heatMaplot(exploredds, clust = "ind", DEGlist = unique(as.character(unlist(DEG_list[[1]]))))The function provides the utility to save the plot automatically.
This function plots a Principal Component Analysis (PCA) from transformed expression matrix. This plot shows samples variation based on the expression values and identifies batch effects.
PCAplot(exploredds, plotly = FALSE)The function provides the utility to save the plot automatically.
MDSplotThis function computes and plots multidimensional scaling analysis for dimension
reduction of count expression matrix. Internally, it is applied the
stats::dist() function to the transformed count matrix to get sample-to-sample
distances.
MDSplot(exploredds, plotly = FALSE)The function provides the utility to save the plot automatically.
GLMplotThis function computes and plots generalized principal components analysis for dimension reduction of count expression matrix.
exploredds_r <- exploreDDS(countMatrix, targets, cmp = cmp[[1]], preFilter = NULL, 
    transformationMethod = "raw")
GLMplot(exploredds_r, plotly = FALSE)The function provides the utility to save the plot automatically.
This function plots log2 fold changes (y-axis) versus the mean of normalized counts (on the x-axis). Statistically significant features are colored.
MAplot(degseqDF, comparison = "M12-A12", filter = c(Fold = 1, FDR = 20), genes = "ATCG00280")The function provides the utility to save the plot automatically.
tSNEplotThis function computes and plots t-Distributed Stochastic Neighbor embedding
(t-SNE) analysis for unsupervised nonlinear dimensionality reduction of count
expression matrix. Internally, it is applied the Rtsne::Rtsne() (Krijthe 2015)
function, using the exact
t-SNE computing with theta=0.0.
tSNEplot(countMatrix, targets, perplexity = 5)A simple function that shows statistical significance (p-value) versus
magnitude of change (log2 fold change).
volcanoplot(degseqDF, comparison = "M12-A12", filter = c(Fold = 1, FDR = 20), genes = "ATCG00280")sessionInfo()## R version 4.1.0 (2021-05-18)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 20.04.2 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.13-bioc/R/lib/libRblas.so
## LAPACK: /home/biocbuild/bbs-3.13-bioc/R/lib/libRlapack.so
## 
## 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       
## 
## attached base packages:
## [1] stats4    parallel  stats     graphics  grDevices utils     datasets 
## [8] methods   base     
## 
## other attached packages:
##  [1] systemPipeR_1.26.0          ShortRead_1.50.0           
##  [3] GenomicAlignments_1.28.0    SummarizedExperiment_1.22.0
##  [5] Biobase_2.52.0              MatrixGenerics_1.4.0       
##  [7] matrixStats_0.58.0          BiocParallel_1.26.0        
##  [9] Rsamtools_2.8.0             Biostrings_2.60.0          
## [11] XVector_0.32.0              GenomicRanges_1.44.0       
## [13] GenomeInfoDb_1.28.0         IRanges_2.26.0             
## [15] S4Vectors_0.30.0            BiocGenerics_0.38.0        
## [17] systemPipeTools_1.0.0       BiocStyle_2.20.0           
## 
## loaded via a namespace (and not attached):
##   [1] backports_1.2.1          GOstats_2.58.0           BiocFileCache_2.0.0     
##   [4] plyr_1.8.6               lazyeval_0.2.2           GSEABase_1.54.0         
##   [7] splines_4.1.0            crosstalk_1.1.1          ggplot2_3.3.3           
##  [10] digest_0.6.27            htmltools_0.5.1.1        magick_2.7.2            
##  [13] GO.db_3.13.0             fansi_0.4.2              checkmate_2.0.0         
##  [16] magrittr_2.0.1           memoise_2.0.0            BSgenome_1.60.0         
##  [19] base64url_1.4            limma_3.48.0             annotate_1.70.0         
##  [22] prettyunits_1.1.1        jpeg_0.1-8.1             colorspace_2.0-1        
##  [25] blob_1.2.1               rappdirs_0.3.3           ggrepel_0.9.1           
##  [28] xfun_0.23                dplyr_1.0.6              crayon_1.4.1            
##  [31] RCurl_1.98-1.3           jsonlite_1.7.2           graph_1.70.0            
##  [34] genefilter_1.74.0        VariantAnnotation_1.38.0 brew_1.0-6              
##  [37] survival_3.2-11          ape_5.5                  glue_1.4.2              
##  [40] gtable_0.3.0             zlibbioc_1.38.0          V8_3.4.2                
##  [43] DelayedArray_0.18.0      Rgraphviz_2.36.0         scales_1.1.1            
##  [46] pheatmap_1.0.12          DBI_1.1.1                GGally_2.1.1            
##  [49] edgeR_3.34.0             Rcpp_1.0.6               viridisLite_0.4.0       
##  [52] xtable_1.8-4             progress_1.2.2           tidytree_0.3.3          
##  [55] bit_4.0.4                rsvg_2.1.2               DT_0.18                 
##  [58] AnnotationForge_1.34.0   htmlwidgets_1.5.3        httr_1.4.2              
##  [61] RColorBrewer_1.1-2       ellipsis_0.3.2           farver_2.1.0            
##  [64] pkgconfig_2.0.3          reshape_0.8.8            XML_3.99-0.6            
##  [67] sass_0.4.0               dbplyr_2.1.1             locfit_1.5-9.4          
##  [70] utf8_1.2.1               labeling_0.4.2           tidyselect_1.1.1        
##  [73] rlang_0.4.11             AnnotationDbi_1.54.0     munsell_0.5.0           
##  [76] tools_4.1.0              cachem_1.0.5             generics_0.1.0          
##  [79] RSQLite_2.2.7            evaluate_0.14            stringr_1.4.0           
##  [82] fastmap_1.1.0            yaml_2.2.1               ggtree_3.0.0            
##  [85] knitr_1.33               bit64_4.0.5              purrr_0.3.4             
##  [88] KEGGREST_1.32.0          RBGL_1.68.0              nlme_3.1-152            
##  [91] formatR_1.9              aplot_0.0.6              biomaRt_2.48.0          
##  [94] debugme_1.1.0            compiler_4.1.0           plotly_4.9.3            
##  [97] filelock_1.0.2           curl_4.3.1               png_0.1-7               
## [100] treeio_1.16.0            tibble_3.1.2             geneplotter_1.70.0      
## [103] bslib_0.2.5.1            stringi_1.6.2            highr_0.9               
## [106] GenomicFeatures_1.44.0   lattice_0.20-44          Matrix_1.3-3            
## [109] glmpca_0.2.0             vctrs_0.3.8              pillar_1.6.1            
## [112] lifecycle_1.0.0          BiocManager_1.30.15      jquerylib_0.1.4         
## [115] data.table_1.14.0        bitops_1.0-7             patchwork_1.1.1         
## [118] rtracklayer_1.52.0       R6_2.5.0                 BiocIO_1.2.0            
## [121] latticeExtra_0.6-29      hwriter_1.3.2            bookdown_0.22           
## [124] codetools_0.2-18         MASS_7.3-54              assertthat_0.2.1        
## [127] DESeq2_1.32.0            Category_2.58.0          rjson_0.2.20            
## [130] withr_2.4.2              batchtools_0.9.15        GenomeInfoDbData_1.2.6  
## [133] hms_1.1.0                grid_4.1.0               DOT_0.1                 
## [136] tidyr_1.1.3              rmarkdown_2.8            rvcheck_0.1.8           
## [139] Rtsne_0.15               restfulr_0.0.13This project is funded by NSF award ABI-1661152.
Anders, Simon, and Wolfgang Huber. 2010. “Differential Expression Analysis for Sequence Count Data.” Genome Biol. 11 (10): R106.
H Backman, Tyler W, and Thomas Girke. 2016. “systemPipeR: NGS workflow and report generation environment.” BMC Bioinformatics 17 (1): 388. https://doi.org/10.1186/s12859-016-1241-0.
Krijthe, Jesse H. 2015. Rtsne: T-Distributed Stochastic Neighbor Embedding Using Barnes-Hut Implementation. https://github.com/jkrijthe/Rtsne.
Love, Michael, Wolfgang Huber, and Simon Anders. 2014. “Moderated Estimation of Fold Change and Dispersion for RNA-seq Data with DESeq2.” Genome Biol. 15 (12): 550. https://doi.org/10.1186/s13059-014-0550-8.