1 Introduction

Biological molecules in a living organism seldom work individually. They usually interact each other in a cooperative way. Biological process is too complicated to understand without considering such interactions. These associations can be conveniently represented as networks (graphs) with nodes (vertices) for molecules and links (edges) for interactions between them. Thus, network-based procedures can be seen as powerful methods for studying complex process. For example, cancer may be better characterized by frequently mutated or dysregulated pathways than driver mutations. However, many methods are devised for analyzing individual genes. It is said that techniques based on biological networks such as gene co-expression are more precise ways to represent information than those using lists of genes only. This package is aimed to integrate the gene expression and biological network. A biological network is constructed from gene expression data and it is used for Gene Set Enrichment Analysis.

Recently, network module-based methods have been proposed as a powerful tool to analyze and interpret gene expression data. For example, a co-expression gene network exhibit distinctive connection structures, including their topologies. In particular, the highly connected genes, or hub genes located at the functional center of the network, should have a high tendency to be associated with their phenotypic outcome. In case that a pathway is represented as a network with nodes and edges, its topology is essential for evaluating the importance of the pathway. However, the widely used statistical methods were designed for individual genes, which may detect too many irrelevant significantly genes or too few genes to describe the phenotypic changes. One possible reason is that most of the existing functional enrichment analyses ignore topological information. Therfore, they are limited for applicability. To overcome this limitation, the original functional enrichment method is extended by assigning network centralities such as node weights. The rationale behind this is that all nodes are not equally important because of hub genes. A fundamental problem in the analysis of complex networks is the determination of how important a certain node is. Centrality measures such as node strength show how influential that node is in the overall network. It assigns relative scores to all nodes within the graph. For simplicity, degree centrality or node strength is used as a centrality measure by default. For over-representation analysis, the label propagation algorithm is employed to score nodes in this package.



2 Example

2.1 GSEA with the list of genes, based on the label propagation

Label propagation is a semi-supervised learning that assigns labels for unlabelled nodes in a network. Each node will be labeled, based on the corresponding score. These score can be used as a statistic for GSEA. Thus ORA can be performed by GSEA. For the example of GSEA for the label propagation, consider Lung Adenocarcinoma data from TCGA. We have set our threshold to 0.7, so only those nodes with similarities higher than 0.7 will be considered neighbors. Consider recurrently mutated genes from MutSig and KEGG pathways. In the result, we can see that these mutated genes are enriched at cancer relevant signaling pathways such as ERBB and MAPK pathways. The warning message indicates that there are many genes that have the same score and so are ranked equally, which means that they are not affected by recurrently mutated genes.

library(gsean)
library(TCGAbiolinks)
library(SummarizedExperiment)
# TCGA LUAD
query <- GDCquery(project = "TCGA-LUAD",
                  data.category = "Gene expression",
                  data.type = "Gene expression quantification",
                  platform = "Illumina HiSeq", 
                  file.type  = "normalized_results",
                  experimental.strategy = "RNA-Seq",
                  legacy = TRUE)
GDCdownload(query, method = "api")
invisible(capture.output(data <- GDCprepare(query)))
exprs.LUAD <- assay(data)
# remove duplicated gene names
exprs.LUAD <- exprs.LUAD[-which(duplicated(rownames(exprs.LUAD))),]
# list of genes
recur.mut.gene <- c("KRAS", "TP53", "STK11", "RBM10", "SPATA31C1", "KRTAP4-11",
                    "DCAF8L2", "AGAP6", "KEAP1", "SETD2", "ZNF679", "FSCB",
                    "BRAF", "ZNF770", "U2AF1", "SMARCA4", "HRNR", "EGFR")

# KEGG_hsa
load(system.file("data", "KEGG_hsa.rda", package = "gsean"))

# GSEA
set.seed(1)
result.GSEA <- gsean(KEGG_hsa, recur.mut.gene, exprs.LUAD, threshold = 0.7)
invisible(capture.output(p <- GSEA.barplot(result.GSEA, category = 'pathway',
                                           score = 'NES', pvalue = 'padj',
                                           sort = 'padj', top = 20)))
p <- GSEA.barplot(result.GSEA, category = 'pathway', score = 'NES',
                  pvalue = 'padj', sort = 'padj', top = 20)
p + theme(plot.margin = margin(10, 10, 10, 75))


2.2 GSEA with statistics, based on the degree centrality

Gene expression data are analyzed to identify differentially expressed genes. Consider pasilla RNA-seq count data. By using the Wald statistic in this example, GSEA can be performed with Gene Ontology terms from http://www.go2msig.org/cgi-bin/prebuilt.cgi?taxid=7227. Thus, it is expected that we may find the biological functions related to change in phenotype from the network, rather than individual genes.

library(gsean)
library(pasilla)
library(DESeq2)
# pasilla count data
pasCts <- system.file("extdata", "pasilla_gene_counts.tsv",
                      package = "pasilla", mustWork = TRUE)
cts <- as.matrix(read.csv(pasCts, sep="\t", row.names = "gene_id"))
condition <- factor(c(rep("untreated", 4), rep("treated", 3)))
dds <- DESeqDataSetFromMatrix(
  countData = cts,
  colData   = data.frame(condition),
  design    = ~ 0 + condition)
# filtering
keep <- rowSums(counts(dds)) >= 10
dds <- dds[keep,]
# differentially expressed genes
dds <- DESeq(dds)
resultsNames(dds)
## [1] "conditiontreated"   "conditionuntreated"
res <- results(dds, contrast = list("conditiontreated", "conditionuntreated"), listValues = c(1, -1))
statistic <- res$stat
names(statistic) <- rownames(res)
exprs.pasilla <- counts(dds, normalized = TRUE)

# convert gene id
library(org.Dm.eg.db)
gene.id <- AnnotationDbi::select(org.Dm.eg.db, names(statistic), "ENTREZID", "FLYBASE")
names(statistic) <- gene.id[,2]
rownames(exprs.pasilla) <- gene.id[,2]

# GO_dme
load(system.file("data", "GO_dme.rda", package = "gsean"))

# GSEA
set.seed(1)
result.GSEA <- gsean(GO_dme, statistic, exprs.pasilla)
## log2 transformed for correlation
invisible(capture.output(p <- GSEA.barplot(result.GSEA, category = 'pathway',
                                           score = 'NES', top = 50, pvalue = 'padj',
                                           sort = 'padj', numChar = 110) + 
  theme(plot.margin = margin(10, 10, 10, 50))))
plotly::ggplotly(p)



3 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] stats4    stats     graphics  grDevices utils     datasets  methods  
## [8] base     
## 
## other attached packages:
##  [1] org.Dm.eg.db_3.18.0         pasilla_1.29.1             
##  [3] DEXSeq_1.48.0               RColorBrewer_1.1-3         
##  [5] AnnotationDbi_1.64.0        DESeq2_1.42.0              
##  [7] SummarizedExperiment_1.32.0 GenomicRanges_1.54.0       
##  [9] GenomeInfoDb_1.38.0         IRanges_2.36.0             
## [11] S4Vectors_0.40.0            MatrixGenerics_1.14.0      
## [13] matrixStats_1.0.0           Biobase_2.62.0             
## [15] BiocParallel_1.36.0         gsean_1.22.0               
## [17] PPInfer_1.28.0              yeastExpData_0.47.0        
## [19] graph_1.80.0                BiocGenerics_0.48.0        
## [21] STRINGdb_2.14.0             igraph_1.5.1               
## [23] ggplot2_3.4.4               kernlab_0.9-32             
## [25] biomaRt_2.58.0              fgsea_1.28.0               
## 
## loaded via a namespace (and not attached):
##   [1] rstudioapi_0.15.0       jsonlite_1.8.7          magrittr_2.0.3         
##   [4] farver_2.1.1            rmarkdown_2.25          zlibbioc_1.48.0        
##   [7] vctrs_0.6.4             memoise_2.0.1           Rsamtools_2.18.0       
##  [10] RCurl_1.98-1.12         base64enc_0.1-3         htmltools_0.5.6.1      
##  [13] S4Arrays_1.2.0          progress_1.2.2          dynamicTreeCut_1.63-1  
##  [16] plotrix_3.8-2           curl_5.1.0              Formula_1.2-5          
##  [19] SparseArray_1.2.0       sass_0.4.7              KernSmooth_2.23-22     
##  [22] bslib_0.5.1             htmlwidgets_1.6.2       gsubfn_0.7             
##  [25] plyr_1.8.9              plotly_4.10.3           impute_1.76.0          
##  [28] cachem_1.0.8            lifecycle_1.0.3         iterators_1.0.14       
##  [31] pkgconfig_2.0.3         Matrix_1.6-1.1          R6_2.5.1               
##  [34] fastmap_1.1.1           GenomeInfoDbData_1.2.11 digest_0.6.33          
##  [37] colorspace_2.1-0        chron_2.3-61            geneplotter_1.80.0     
##  [40] crosstalk_1.2.0         Hmisc_5.1-1             RSQLite_2.3.1          
##  [43] hwriter_1.3.2.1         labeling_0.4.3          filelock_1.0.2         
##  [46] fansi_1.0.5             httr_1.4.7              abind_1.4-5            
##  [49] compiler_4.3.1          bit64_4.0.5             withr_2.5.1            
##  [52] doParallel_1.0.17       backports_1.4.1         htmlTable_2.4.1        
##  [55] DBI_1.1.3               gplots_3.1.3            rappdirs_0.3.3         
##  [58] DelayedArray_0.28.0     gtools_3.9.4            caTools_1.18.2         
##  [61] tools_4.3.1             foreign_0.8-85          nnet_7.3-19            
##  [64] glue_1.6.2              grid_4.3.1              checkmate_2.2.0        
##  [67] cluster_2.1.4           generics_0.1.3          gtable_0.3.4           
##  [70] preprocessCore_1.64.0   tidyr_1.3.0             data.table_1.14.8      
##  [73] hms_1.1.3               WGCNA_1.72-1            xml2_1.3.5             
##  [76] utf8_1.2.4              XVector_0.42.0          foreach_1.5.2          
##  [79] pillar_1.9.0            stringr_1.5.0           genefilter_1.84.0      
##  [82] splines_4.3.1           dplyr_1.1.3             BiocFileCache_2.10.0   
##  [85] lattice_0.22-5          survival_3.5-7          bit_4.0.5              
##  [88] annotate_1.80.0         tidyselect_1.2.0        GO.db_3.18.0           
##  [91] locfit_1.5-9.8          Biostrings_2.70.0       knitr_1.44             
##  [94] gridExtra_2.3           sqldf_0.4-11            xfun_0.40              
##  [97] statmod_1.5.0           proto_1.0.0             stringi_1.7.12         
## [100] lazyeval_0.2.2          yaml_2.3.7              evaluate_0.22          
## [103] codetools_0.2-19        tibble_3.2.1            hash_2.2.6.3           
## [106] cli_3.6.1               rpart_4.1.21            xtable_1.8-4           
## [109] munsell_0.5.0           jquerylib_0.1.4         Rcpp_1.0.11            
## [112] dbplyr_2.3.4            png_0.1-8               XML_3.99-0.14          
## [115] fastcluster_1.2.3       parallel_4.3.1          ellipsis_0.3.2         
## [118] blob_1.2.4              prettyunits_1.2.0       bitops_1.0-7           
## [121] viridisLite_0.4.2       scales_1.2.1            purrr_1.0.2            
## [124] crayon_1.5.2            rlang_1.1.1             cowplot_1.1.1          
## [127] fastmatch_1.1-4         KEGGREST_1.42.0



4 References

Gu, Z., Liu, J., Cao, K., Zhang, J., & Wang, J. (2012). Centrality-based pathway enrichment: a systematic approach for finding significant pathways dominated by key genes. BMC systems biology, 6(1), 56.

Wu, J. (2016). Transcriptomics and Gene Regulation. Springer.

Zhang, W., Chien, J., Yong, J., & Kuang, R. (2017). Network-based machine learning and graph theory algorithms for precision oncology. npj Precision Oncology, 1(1), 25.