Installation

To install and load methylGSA

if (!requireNamespace("BiocManager", quietly = TRUE))
    install.packages("BiocManager")

BiocManager::install("methylGSA")
library(methylGSA)

Depending on the DNA methylation array type, other packages may be needed before running the analysis.

If analyzing 450K array, IlluminaHumanMethylation450kanno.ilmn12.hg19 needs to be loaded.

library(IlluminaHumanMethylation450kanno.ilmn12.hg19)

If analyzing EPIC array, IlluminaHumanMethylationEPICanno.ilm10b4.hg19 needs to be loaded.

library(IlluminaHumanMethylationEPICanno.ilm10b4.hg19)

If analyzing user-supplied mapping between CpG ID and gene name, neither IlluminaHumanMethylation450kanno.ilmn12.hg19 nor IlluminaHumanMethylationEPICanno.ilm10b4.hg19 needs to be loaded.

Introduction

The methylGSA package contains functions to carry out gene set analysis adjusting for the number of CpGs per gene. It has been shown by Geeleher et al [1] that gene set analysis is extremely biased for DNA methylation data. This package contains three main functions to adjust for the bias in gene set analysis.

Supported gene sets and gene ID types

Supported array types

Description of methylglm

methylglm is an extention of GOglm [9]. GOglm adjusts length bias for RNA-Seq data by incorporating gene length as a covariate in logistic regression model. methylglm adjusts length bias in DNA methylation by the number of CpGs instead of gene length. For each gene set, we fit a logistic regression model:

\[ \text{logit} (\pi_{i}) = \beta_{0} + \beta_{1}x_{i} + \beta_{2}c_{i}\] For each gene \(i\), \(\pi_{i}\) = Pr(gene \(i\) is in gene set), \(x_{i}\) represents negative logarithmic transform of its minimum p-value in differential methylation analysis, and \(c_{i}\) is logarithmic transform of its number of CpGs.

methylglm requires only a simple named vector. This vector contains p-values of each CpG. Names should be their corresponding CpG IDs.

Example

Here is what the input vector looks like:

data(cpgtoy)
head(cpg.pval, 20)
cg00050873 cg00212031 cg00214611 cg01707559 cg02004872 cg02011394 cg02050847 
    0.2876     0.7883     0.4090     0.8830     0.9405     0.0456     0.5281 
cg02233190 cg02494853 cg02839557 cg02842889 cg03052502 cg03244189 cg03443143 
    0.8924     0.5514     0.4566     0.9568     0.4533     0.6776     0.5726 
cg03683899 cg03706273 cg03750315 cg04016144 cg04042030 cg04448376 
    0.1029     0.8998     0.2461     0.0421     0.3279     0.9545 

Please note that the p-values presented here in cpg.pval is for illustration purpose only. They are used to show how to utilize the functions in methylGSA. It does not represent p-values from any real data analysis. The actual p-values in differential methylation analysis may be quite different from the p-values in cpg.pval in terms of the magnitude.

Run methylglm:

res1 = methylglm(cpg.pval = cpg.pval, minsize = 200, 
                 maxsize = 500, GS.type = "KEGG")
head(res1, 15)
         ID                             Description Size    pvalue padj
04080 04080 Neuroactive ligand-receptor interaction  272 0.4811308    1
04060 04060  Cytokine-cytokine receptor interaction  265 0.6961531    1
04010 04010                  MAPK signaling pathway  268 1.0000000    1
04144 04144                             Endocytosis  201 1.0000000    1
04510 04510                          Focal adhesion  200 1.0000000    1
04740 04740                  Olfactory transduction  388 1.0000000    1
04810 04810        Regulation of actin cytoskeleton  213 1.0000000    1
05200 05200                      Pathways in cancer  326 1.0000000    1

Result is a data frame ranked by p-values of gene sets. The meaning of each column is given below.

Column Explanation
ID Gene set ID
Description (N/A for user supplied gene set) Gene set description
Size Number of genes in gene set
pvalue p-value in logistic regression
padj Adjusted p-value

Bioconductor package org.Hs.eg.db can be used to pull out the genes corresponding a specific pathway. For instance, one of the pathways in the methylglm output above is “Neuroactive ligand-receptor interaction” with KEGG ID 04080. The following code can be used to obtain its genes.

library(org.Hs.eg.db)
genes_04080 = select(org.Hs.eg.db, "04080", "SYMBOL", keytype = "PATH")
head(genes_04080)
   PATH    SYMBOL
1 04080 ADCYAP1R1
2 04080    ADORA1
3 04080   ADORA2A
4 04080   ADORA2B
5 04080    ADORA3
6 04080    ADRA1D

The following code can be used to get the genes in all the pathways in methylglm output.

# include all the IDs as the 2nd argument in select function
genes_all_pathway = select(org.Hs.eg.db, as.character(res1$ID), 
                     "SYMBOL", keytype = "PATH")
head(genes_all_pathway)

Description of methylRRA

Robust rank aggregation [2] is a parameter free model that aggregates several ranked gene lists into a single gene list. The aggregation assumes random order of input lists and assign each gene a p-value based on order statistics. We apply this order statistics idea to adjust for number of CpGs.

For gene \(i\), let \(P_{1}, P_{2}, ... P_{n}\) be the p-values of individual CpGs in differential methylation analysis. Under the null hypothesis, \(P_{1}, P_{2}, ... P_{n} ~ \overset{i.i.d}{\sim} Unif[0, 1]\). Let \(P_{(1)}, P_{(2)}, ... P_{(n)}\) be the order statistics. Define: \[\rho = \text{min}\{\text{Pr}(P_{(1)}<P_{(1)\text{obs}}), \text{Pr}(P_{(2)}<P_{(2)\text{obs}})..., \text{Pr}(P_{(n)}<P_{(n)\text{obs}}) \} \]

methylRRA supports two approaches to adjust for number of CpGs, ORA and GSEAPreranked [3]. In ORA approach, for gene \(i\), conversion from \(\rho\) score into p-value is done by Bonferroni correction [2]. We get a p-value for each gene and these p-values are then corrected for multiple testing use Benjamini & Hochberg procedure [10]. By default, genes with False Discovery Rate (FDR) below 0.05 are considered differentially expressed (DE) genes. If there are no DE genes under FDR 0.05, users are able to use sig.cut option to specify a higher FDR cut-off or topDE option to declare top genes to be differentially expressed. We then apply ORA based on these DE genes.

In GSEAPreranked approach, for gene \(i\), we also convert \(\rho\) score into p-value by Bonferroni correction. p-values are converted into z-scores. We then apply Preranked version of Gene Set Enrichment Analysis (GSEAPreranked) on the gene list ranked by the z-scores.

Example

To apply ORA approach, we use argument method = "ORA" (default) in methylRRA

res2 = methylRRA(cpg.pval = cpg.pval, method = "ORA", 
                    minsize = 200, maxsize = 210)
head(res2, 15)

The meaning of each column in the output is given below.

Column Explanation
ID Gene set ID
Description (N/A for user supplied gene set) Gene set description
Count Number of significant genes in the gene set
overlap Names of significant genes in the gene set
Size Number of genes in gene set
pvalue p-value in ORA
padj Adjusted p-value

To apply GSEAPreranked approach, we use argument method = "GSEA" in methylRRA

res3 = methylRRA(cpg.pval = cpg.pval, method = "GSEA", 
                    minsize = 200, maxsize = 210)
head(res3, 10)

The meaning of each column in the output is given below.

Column Explanation
ID Gene set ID
Description (N/A for user supplied gene set) Gene set description
Size Number of genes in gene set
enrichmentScore Enrichment score (see [3] for details)
NES Normalized enrichment score (see [3] for details)
pvalue p-value in GSEA
padj Adjusted p-value

Description of methylgometh

methylgometh calls gometh or gsameth function in missMethyl package [4] to adjust number of CpGs in gene set testing. gometh modifies goseq method [11] by fitting a probability weighting function and resampling from Wallenius non-central hypergeometric distribution.

methylgometh requires two inputs, cpg.pval and sig.cut. sig.cut specifies the cut-off point to declare a CpG as differentially methylated. By default, sig.cut is 0.001. Similar to methylRRA, if no CpG is significant, users are able to specify a higher cut-off or use topDE option to declare top CpGs to be differentially methylated.

Example

res4 = methylgometh(cpg.pval = cpg.pval, sig.cut = 0.001, 
                        minsize = 200, maxsize = 210)
head(res4, 15)

Other options

methylGSA provides many other options for users to customize the analysis.

Examples

An example of user supplied gene sets is given below. The gene ID type is gene symbol.

data(GSlisttoy)
## to make the display compact, only a proportion of each gene set is shown
head(lapply(GS.list, function(x) x[1:30]), 3)   
$GS1
 [1] "ABCA11P"   "ACOT1"     "ACSM2A"    "ADAMTS4"   "ADH4"      "AGTR2"    
 [7] "AMAC1"     "AMY1B"     "AMY2A"     "ANKRD13C"  "ANKRD20A1" "ANKRD20A3"
[13] "ANKRD20A4" "ANXA2P3"   "ANXA8"     "ANXA8L1"   "ARGFXP2"   "ARL17B"   
[19] "ATF5"      "ATP5F1"    "BAGE2"     "BCL8"      "BET3L"     "C12orf24" 
[25] "C15orf62"  "C16orf93"  "C17orf86"  "C19orf70"  "C1orf182"  "C22orf29" 

$GS2
 [1] "KRTAP5-5"     "KRTAP6-1"     "KRTAP9-8"     "KTI12"        "LASS1"       
 [6] "LCMT2"        "LGALS9B"      "LOC100093631" "LOC100101115" "LOC100101266"
[11] "LOC100130264" "LOC100130932" "LOC100131193" "LOC100131726" "LOC100132247"
[16] "LOC100132832" "LOC100133920" "LOC100286938" "LOC144438"    "LOC145820"   
[21] "LOC148413"    "LOC202781"    "LOC286367"    "LOC339047"    "LOC388499"   
[26] "LOC392196"    "LOC399753"    "LOC440895"    "LOC441294"    "LOC441455"   

$GS3
 [1] "SNORA17"     "SNORA23"     "SNORA25"     "SNORA2B"     "SNORA31"    
 [6] "SNORA36C"    "SNORA64"     "SNORD11"     "SNORD113-5"  "SNORD113-7" 
[11] "SNORD114-1"  "SNORD114-16" "SNORD114-17" "SNORD114-18" "SNORD114-21"
[16] "SNORD114-27" "SNORD114-28" "SNORD114-5"  "SNORD114-6"  "SNORD114-8" 
[21] "SNORD114-9"  "SNORD116-16" "SNORD116-26" "SNORD116-29" "SNORD12"    
[26] "SNORD125"    "SNORD126"    "SNORD16"     "SNORD38B"    "SNORD50A"   

Below is an example of running methylglm with parallel option

library(BiocParallel)
res_p = methylglm(cpg.pval = cpg.pval, minsize = 200, 
                  maxsize = 500, GS.type = "KEGG", parallel = TRUE)

methylglm and methylRRA support user supplied CpG ID to gene mapping. The mapping is expected to be a matrix, or a data frame or a list. For a matrix or data frame, 1st column should be CpG ID and 2nd column should be gene name. For a list, entry names should be gene names and elements correpond to CpG IDs. Below an example of user supplied CpG to gene mapping.

data(CpG2Genetoy)
head(CpG2Gene)   
         CpG   Gene
1 cg00050873  TSPY4
2 cg00212031 TTTY14
3 cg00214611 TMSB4Y
4 cg01707559  TBL1Y
5 cg02004872 TMSB4Y
6 cg02011394  TSPY4

To use user supplied mapping in methylglm or methylRRA, first preprocess the mapping by prepareAnnot function

FullAnnot = prepareAnnot(CpG2Gene) 

Test the gene sets using “ORA” in methylRRA, use FullAnnot argument to provide the preprocessed CpG ID to gene mapping

GS.list = GS.list[1:10]
res5 = methylRRA(cpg.pval = cpg.pval, FullAnnot = FullAnnot, method = "ORA", 
                    GS.list = GS.list, GS.idtype = "SYMBOL", 
                    minsize = 100, maxsize = 300)
head(res5, 10)
       ID Count Size pvalue padj
GS1   GS1     0  157      1    1
GS2   GS2     0  257      1    1
GS3   GS3     0  181      1    1
GS4   GS4     0  274      1    1
GS5   GS5     0  285      1    1
GS6   GS6     0  108      1    1
GS7   GS7     0  202      1    1
GS8   GS8     0  273      1    1
GS9   GS9     0  206      1    1
GS10 GS10     0  187      1    1

Below is another example testing Reactome pathways using methylglm.

res6 = methylglm(cpg.pval = cpg.pval, array.type = "450K", 
                    GS.type = "Reactome", minsize = 100, maxsize = 110)
head(res6, 10)

Visualization

Following bar plot implemented in enrichplot [12], we also provide bar plot to visualize the gene set analysis results. The input of barplot function can be any result returned by methylglm, methylRRA, or methylgometh. Various options are provided for users to customize the plot.

Example

Below is an example of using barplot to visualize the result of methylglm.

barplot(res1, num = 8, colorby = "pvalue")

Session info

sessionInfo()
R version 4.3.1 (2023-06-16)
Platform: x86_64-pc-linux-gnu (64-bit)
Running under: Ubuntu 22.04.3 LTS

Matrix products: default
BLAS:   /home/biocbuild/bbs-3.18-bioc/R/lib/libRblas.so 
LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.10.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] parallel  stats4    stats     graphics  grDevices utils     datasets 
[8] methods   base     

other attached packages:
 [1] org.Hs.eg.db_3.18.0                               
 [2] AnnotationDbi_1.64.0                              
 [3] IlluminaHumanMethylation450kanno.ilmn12.hg19_0.6.1
 [4] minfi_1.48.0                                      
 [5] bumphunter_1.44.0                                 
 [6] locfit_1.5-9.8                                    
 [7] iterators_1.0.14                                  
 [8] foreach_1.5.2                                     
 [9] Biostrings_2.70.0                                 
[10] XVector_0.42.0                                    
[11] SummarizedExperiment_1.32.0                       
[12] Biobase_2.62.0                                    
[13] MatrixGenerics_1.14.0                             
[14] matrixStats_1.0.0                                 
[15] GenomicRanges_1.54.0                              
[16] GenomeInfoDb_1.38.0                               
[17] IRanges_2.36.0                                    
[18] S4Vectors_0.40.0                                  
[19] BiocGenerics_0.48.0                               
[20] methylGSA_1.20.0                                  

loaded via a namespace (and not attached):
  [1] fs_1.6.3                                           
  [2] bitops_1.0-7                                       
  [3] enrichplot_1.22.0                                  
  [4] HDO.db_0.99.1                                      
  [5] httr_1.4.7                                         
  [6] RColorBrewer_1.1-3                                 
  [7] tools_4.3.1                                        
  [8] doRNG_1.8.6                                        
  [9] utf8_1.2.4                                         
 [10] R6_2.5.1                                           
 [11] HDF5Array_1.30.0                                   
 [12] lazyeval_0.2.2                                     
 [13] rhdf5filters_1.14.0                                
 [14] withr_2.5.1                                        
 [15] prettyunits_1.2.0                                  
 [16] gridExtra_2.3                                      
 [17] base64_2.0.1                                       
 [18] preprocessCore_1.64.0                              
 [19] cli_3.6.1                                          
 [20] scatterpie_0.2.1                                   
 [21] labeling_0.4.3                                     
 [22] sass_0.4.7                                         
 [23] IlluminaHumanMethylationEPICanno.ilm10b4.hg19_0.6.0
 [24] readr_2.1.4                                        
 [25] genefilter_1.84.0                                  
 [26] askpass_1.2.0                                      
 [27] Rsamtools_2.18.0                                   
 [28] yulab.utils_0.1.0                                  
 [29] gson_0.1.0                                         
 [30] siggenes_1.76.0                                    
 [31] illuminaio_0.44.0                                  
 [32] DOSE_3.28.0                                        
 [33] scrime_1.3.5                                       
 [34] limma_3.58.0                                       
 [35] RSQLite_2.3.1                                      
 [36] generics_0.1.3                                     
 [37] gridGraphics_0.5-1                                 
 [38] BiocIO_1.12.0                                      
 [39] dplyr_1.1.3                                        
 [40] GO.db_3.18.0                                       
 [41] Matrix_1.6-1.1                                     
 [42] fansi_1.0.5                                        
 [43] abind_1.4-5                                        
 [44] lifecycle_1.0.3                                    
 [45] yaml_2.3.7                                         
 [46] rhdf5_2.46.0                                       
 [47] qvalue_2.34.0                                      
 [48] SparseArray_1.2.0                                  
 [49] BiocFileCache_2.10.0                               
 [50] grid_4.3.1                                         
 [51] blob_1.2.4                                         
 [52] promises_1.2.1                                     
 [53] crayon_1.5.2                                       
 [54] lattice_0.22-5                                     
 [55] cowplot_1.1.1                                      
 [56] GenomicFeatures_1.54.0                             
 [57] annotate_1.80.0                                    
 [58] KEGGREST_1.42.0                                    
 [59] pillar_1.9.0                                       
 [60] knitr_1.44                                         
 [61] beanplot_1.3.1                                     
 [62] fgsea_1.28.0                                       
 [63] rjson_0.2.21                                       
 [64] codetools_0.2-19                                   
 [65] fastmatch_1.1-4                                    
 [66] glue_1.6.2                                         
 [67] ggfun_0.1.3                                        
 [68] data.table_1.14.8                                  
 [69] vctrs_0.6.4                                        
 [70] png_0.1-8                                          
 [71] treeio_1.26.0                                      
 [72] gtable_0.3.4                                       
 [73] cachem_1.0.8                                       
 [74] xfun_0.40                                          
 [75] S4Arrays_1.2.0                                     
 [76] mime_0.12                                          
 [77] tidygraph_1.2.3                                    
 [78] RobustRankAggreg_1.2.1                             
 [79] survival_3.5-7                                     
 [80] statmod_1.5.0                                      
 [81] interactiveDisplayBase_1.40.0                      
 [82] ellipsis_0.3.2                                     
 [83] nlme_3.1-163                                       
 [84] ggtree_3.10.0                                      
 [85] bit64_4.0.5                                        
 [86] progress_1.2.2                                     
 [87] filelock_1.0.2                                     
 [88] bslib_0.5.1                                        
 [89] nor1mix_1.3-0                                      
 [90] colorspace_2.1-0                                   
 [91] DBI_1.1.3                                          
 [92] tidyselect_1.2.0                                   
 [93] bit_4.0.5                                          
 [94] compiler_4.3.1                                     
 [95] curl_5.1.0                                         
 [96] xml2_1.3.5                                         
 [97] DelayedArray_0.28.0                                
 [98] shadowtext_0.1.2                                   
 [99] rtracklayer_1.62.0                                 
[100] scales_1.2.1                                       
[101] quadprog_1.5-8                                     
[102] rappdirs_0.3.3                                     
[103] stringr_1.5.0                                      
[104] digest_0.6.33                                      
[105] rmarkdown_2.25                                     
[106] GEOquery_2.70.0                                    
[107] htmltools_0.5.6.1                                  
[108] pkgconfig_2.0.3                                    
[109] sparseMatrixStats_1.14.0                           
[110] dbplyr_2.3.4                                       
[111] fastmap_1.1.1                                      
[112] rlang_1.1.1                                        
[113] shiny_1.7.5.1                                      
[114] DelayedMatrixStats_1.24.0                          
[115] farver_2.1.1                                       
[116] jquerylib_0.1.4                                    
[117] jsonlite_1.8.7                                     
[118] BiocParallel_1.36.0                                
[119] mclust_6.0.0                                       
[120] GOSemSim_2.28.0                                    
[121] RCurl_1.98-1.12                                    
[122] magrittr_2.0.3                                     
[123] GenomeInfoDbData_1.2.11                            
[124] ggplotify_0.1.2                                    
[125] patchwork_1.1.3                                    
[126] Rhdf5lib_1.24.0                                    
[127] munsell_0.5.0                                      
[128] Rcpp_1.0.11                                        
[129] ape_5.7-1                                          
[130] viridis_0.6.4                                      
[131] stringi_1.7.12                                     
[132] ggraph_2.1.0                                       
[133] zlibbioc_1.48.0                                    
[134] MASS_7.3-60                                        
[135] AnnotationHub_3.10.0                               
[136] plyr_1.8.9                                         
[137] HPO.db_0.99.2                                      
[138] ggrepel_0.9.4                                      
[139] graphlayouts_1.0.1                                 
[140] splines_4.3.1                                      
[141] multtest_2.58.0                                    
[142] hms_1.1.3                                          
[143] igraph_1.5.1                                       
[144] rngtools_1.5.2                                     
[145] reshape2_1.4.4                                     
[146] biomaRt_2.58.0                                     
[147] BiocVersion_3.18.0                                 
[148] missMethyl_1.36.0                                  
[149] XML_3.99-0.14                                      
[150] evaluate_0.22                                      
[151] BiocManager_1.30.22                                
[152] tzdb_0.4.0                                         
[153] tweenr_2.0.2                                       
[154] httpuv_1.6.12                                      
[155] tidyr_1.3.0                                        
[156] openssl_2.1.1                                      
[157] purrr_1.0.2                                        
[158] polyclip_1.10-6                                    
[159] reshape_0.8.9                                      
[160] ggplot2_3.4.4                                      
[161] ggforce_0.4.1                                      
[162] xtable_1.8-4                                       
[163] restfulr_0.0.15                                    
[164] reactome.db_1.86.0                                 
[165] tidytree_0.4.5                                     
[166] MPO.db_0.99.7                                      
[167] later_1.3.1                                        
[168] viridisLite_0.4.2                                  
[169] tibble_3.2.1                                       
[170] clusterProfiler_4.10.0                             
[171] aplot_0.2.2                                        
[172] memoise_2.0.1                                      
[173] GenomicAlignments_1.38.0                           

References

[1] Geeleher, Paul, Lori Hartnett, Laurance J Egan, Aaron Golden, Raja Affendi Raja Ali, and Cathal Seoighe. 2013. Gene-Set Analysis Is Severely Biased When Applied to Genome-Wide Methylation Data. Bioinformatics 29 (15). Oxford University Press: 1851–7.

[2] Kolde, Raivo, Sven Laur, Priit Adler, and Jaak Vilo. 2012. Robust Rank Aggregation for Gene List Integration and Meta-Analysis. Bioinformatics 28 (4). Oxford University Press: 573–80.

[3] Subramanian, Aravind, Pablo Tamayo, Vamsi K Mootha, Sayan Mukherjee, Benjamin L Ebert, Michael A Gillette, Amanda Paulovich, et al. 2005. Gene Set Enrichment Analysis: A Knowledge-Based Approach for Interpreting Genome-Wide Expression Profiles. Proceedings of the National Academy of Sciences 102 (43). National Acad Sciences: 15545–50.

[4] Phipson, Belinda, Jovana Maksimovic, and Alicia Oshlack. 2015. MissMethyl: An R Package for Analyzing Data from Illumina’s Humanmethylation450 Platform. Bioinformatics 32 (2). Oxford University Press: 286–88.

[5] Carlson M (2018). org.Hs.eg.db: Genome wide annotation for Human. R package version 3.6.0.

[6] Ligtenberg W (2018). reactome.db: A set of annotation maps for reactome. R package version 1.64.0.

[7] Hansen, KD. (2016). IlluminaHumanMethylation450kanno.ilmn12.hg19: Annotation for Illumina’s 450k Methylation Arrays. R Package, Version 0.6.0 1.

[8] Hansen, KD. (2017). IlluminaHumanMethylationEPICanno.ilm10b4.hg19: Annotation for Illumina’s Epic Methylation Arrays. R Package, Version 0.6.0 1.

[9] Mi, Gu, Yanming Di, Sarah Emerson, Jason S Cumbie, and Jeff H Chang. 2012. Length Bias Correction in Gene Ontology Enrichment Analysis Using Logistic Regression. PloS One 7 (10). Public Library of Science: e46128.

[10] Benjamini, Yoav, and Yosef Hochberg. 1995. Controlling the False Discovery Rate: A Practical and Powerful Approach to Multiple Testing. Journal of the Royal Statistical Society. Series B (Methodological). JSTOR, 289–300.

[11] Young, Matthew D, Matthew J Wakefield, Gordon K Smyth, and Alicia Oshlack. 2012. Goseq: Gene Ontology Testing for Rna-Seq Datasets. R Bioconductor.

[12] Yu G (2018). enrichplot: Visualization of Functional Enrichment Result. R package version 1.0.2, https://github.com/GuangchuangYu/enrichplot.