Title: | Inferring miRNA sponge modules in heterogeneous data |
---|---|
Description: | The package aims to identify miRNA sponge or ceRNA modules in heterogeneous data. It provides several functions to study miRNA sponge modules at single-sample and multi-sample levels, including popular methods for inferring gene modules (candidate miRNA sponge or ceRNA modules), and two functions to identify miRNA sponge modules at single-sample and multi-sample levels, as well as several functions to conduct modular analysis of miRNA sponge modules. |
Authors: | Junpeng Zhang [aut, cre] |
Maintainer: | Junpeng Zhang <[email protected]> |
License: | GPL-3 |
Version: | 2.3.0 |
Built: | 2024-11-20 06:29:09 UTC |
Source: | https://github.com/bioc/miRSM |
BRCA genes
BRCA_genes: A SummarizedExperiment object with 4819 BRCA related genes (including lncRNAs and mRNAs).
The BRCA related lncRNAs are from LncRNADisease v2.0, Lnc2Cancer v2.0 and MNDR v2.0. The BRCA related mRNAs are from DisGeNET v5.0 and COSMIC v86.
Bao Z, Yang Z, Huang Z, Zhou Y, Cui Q, Dong D. (2019) "LncRNADisease 2.0: an updated database of long non-coding RNA-associated diseases". Nucleic Acids Res., 47(D1):D1034-D1037.
Cui T, Zhang L, Huang Y, Yi Y, Tan P, Zhao Y, Hu Y, Xu L, Li E, Wang D. (2018) "MNDR v2.0: an updated resource of ncRNA-disease associa-tions in mammals". Nucleic Acids Res., 46, D371-D374.
Gao Y, Wang P, Wang Y, Ma X, Zhi H, Zhou D, Li X, Fang Y, Shen W, Xu Y, Shang S, Wang L, Wang L, Ning S, Li X. (2019) "Lnc2Cancer v2.0: updated database of experimentally supported long non-coding RNAs in human cancers". Nucleic Acids Res., 47, D1028-D1033.
Forbes SA, Beare D, Boutselakis H, Bamford S, Bindal N, Tate J, Cole CG, Ward S, Dawson E, Ponting L, Stefancsik R, Harsha B, Kok CY, Jia M, Jubb H, Sondka Z, Thompson S, De T, Campbell PJ. (2017) "COSMIC: somatic cancer genetics at high-resolution". Nucleic Acids Res., 45, D777-D783
Pinero J, Bravo A, Queralt-Rosinach N, Gutierrez-Sacristan A, Deu-Pons J, Centeno E, Garcia-Garcia J, Sanz F, Furlong LI. (2017) "DisGeNET: a comprehensive platform integrating infor-mation on human disease-associated genes and variants". Nucleic Acids Res., 45, D833-D839.
ceRNA expression data
ceRExp: A SummarizedExperiment object with 72 BRCA and 72 normal samples (rows) and 305 lncRNAs (columns).
The matched breast invasive carcinoma (BRCA) miRNA, lncRNA and mRNA expression data is obtained from TCGA (http://cancergenome.nih.gov/). lncRNA expression data is regarded as ceRNA expression data. The data focuses on 72 individuals for which the complete sets of tumor and matched normal (i.e., normal tissue taken from the same patient) profiles are available. A lncRNA which has missing values in more than 10 are imputed using the k-nearest neighbours (KNN) algorithm from the impute R package. We use the limma R package to infer differentially expressed lncRNAs between tumour and normal samples. After the analysis, we select top 305 lncRNAs which are differentially expressed at a significant level (adjusted p-value < 1E-02, adjusted by Benjamini & Hochberg method).
Generation of positively correlated binary matrix between ceRNAs, or ceRNAs and mRNAs
cor_binary( ceRExp, mRExp = NULL, cor.method = "pearson", pos.p.value.cutoff = 0.01 )
cor_binary( ceRExp, mRExp = NULL, cor.method = "pearson", pos.p.value.cutoff = 0.01 )
ceRExp |
A SummarizedExperiment object. ceRNA expression data: rows are samples and columns are ceRNAs. |
mRExp |
NULL (default) or a SummarizedExperiment object. mRNA expression data: rows are samples and columns are mRNAs. |
cor.method |
The method of calculating correlation selected, including 'pearson' (default), 'kendall', 'spearman'. |
pos.p.value.cutoff |
The significant p-value cutoff of positive correlation. |
A binary matrix.
Junpeng Zhang (https://www.researchgate.net/profile/Junpeng-Zhang-2)
Langfelder P, Horvath S. WGCNA: an R package for weighted correlation network analysis. BMC Bioinformatics. 2008, 9:559.
data(BRCASampleData) cor_binary_matrix <- cor_binary(ceRExp, mRExp)
data(BRCASampleData) cor_binary_matrix <- cor_binary(ceRExp, mRExp)
Inferring differential modules between two list of module groups
diff_module( Module.group1, Module.group2, sim.cutoff = 0.8, sim.method = "Simpson" )
diff_module( Module.group1, Module.group2, sim.cutoff = 0.8, sim.method = "Simpson" )
Module.group1 |
List object, the first list of module group. |
Module.group2 |
List object, the second list of module group. |
sim.cutoff |
Similarity cutoff between modules, the interval is [0 1]. |
sim.method |
Methods for calculating similatiry between two modules, select one of three methods (Simpson, Jaccard and Lin). Default method is Simpson. |
A list of differential modules
Junpeng Zhang (https://www.researchgate.net/profile/Junpeng-Zhang-2)
library(GSEABase) data(BRCASampleData) modulegenes_WGCNA_all <- module_WGCNA(ceRExp, mRExp) modulegenes_WGCNA_1 <- module_WGCNA(ceRExp[-1, ], mRExp[-1, ]) Differential_module <- diff_module(geneIds(modulegenes_WGCNA_all), geneIds(modulegenes_WGCNA_1))
library(GSEABase) data(BRCASampleData) modulegenes_WGCNA_all <- module_WGCNA(ceRExp, mRExp) modulegenes_WGCNA_1 <- module_WGCNA(ceRExp[-1, ], mRExp[-1, ]) Differential_module <- diff_module(geneIds(modulegenes_WGCNA_all), geneIds(modulegenes_WGCNA_1))
miRNA expression data
miRExp: A SummarizedExperiment object with 72 BRCA and 72 normal samples (rows) and 226 miRNAs (columns).
The matched breast invasive carcinoma (BRCA) miRNA, lncRNA and mRNA expression data is obtained from TCGA (http://cancergenome.nih.gov/). The data focuses on 72 individuals for which the complete sets of tumor and matched normal (i.e., normal tissue taken from the same patient) profiles are available. A miRNA which has missing values in more than 10 are imputed using the k-nearest neighbours (KNN) algorithm from the impute R package. We use the limma R package to infer differentially expressed miRNAs, ceRNAs and mRNAs between tumour and normal samples. After the analysis, we select top 226 miRNAs which are differentially expressed at a significant level (adjusted p-value < 1E-02, adjusted by Benjamini & Hochberg method).
Identify miRNA sponge modules using sensitivity canonical correlation (SCC), sensitivity distance correlation (SDC), sensitivity RV coefficient (SRVC), sensitivity similarity index (SSI), sensitivity generalized coefficient of determination (SGCD), sensitivity Coxhead's or Rozeboom's coefficient (SCRC), and sponge module (SM) methods.
miRSM( miRExp = NULL, ceRExp, mRExp = NULL, miRTarget, CandidateModulegenes, typex = "standard", typez = "standard", nperms = 100, method = c("SCC", "SDC", "SRVC", "SM", "SSI", "SGCD", "SCRC"), num_shared_miRNAs = 3, pvalue.cutoff = 0.05, MC.cutoff = 0.8, SMC.cutoff = 0.1, RV_method = c("RV", "RV2", "RVadjMaye", "RVadjGhaziri"), BCmethod = "BCPlaid", CRC_method = c("Coxhead", "Rozeboom") )
miRSM( miRExp = NULL, ceRExp, mRExp = NULL, miRTarget, CandidateModulegenes, typex = "standard", typez = "standard", nperms = 100, method = c("SCC", "SDC", "SRVC", "SM", "SSI", "SGCD", "SCRC"), num_shared_miRNAs = 3, pvalue.cutoff = 0.05, MC.cutoff = 0.8, SMC.cutoff = 0.1, RV_method = c("RV", "RV2", "RVadjMaye", "RVadjGhaziri"), BCmethod = "BCPlaid", CRC_method = c("Coxhead", "Rozeboom") )
miRExp |
NULL (default) or a SummarizedExperiment object. miRNA expression data: rows are samples and columns are miRNAs. |
ceRExp |
A SummarizedExperiment object. ceRNA expression data: rows are samples and columns are ceRNAs. |
mRExp |
NULL (default) or a SummarizedExperiment object. mRNA expression data: rows are samples and columns are mRNAs. |
miRTarget |
A SummarizedExperiment object. Putative miRNA-target binding information. |
CandidateModulegenes |
List object: a list of candidate miRNA sponge modules. Only for the SCC, SDC, SRVC, SSI, SGCD and SCRC methods. |
typex |
The columns of x unordered (type='standard') or ordered (type='ordered'). Only for the SCC method. |
typez |
The columns of z unordered (type='standard') or ordered (type='ordered'). Only for the SCC method. |
nperms |
The number of permutations. Only for the SCC method. |
method |
The method selected to identify miRNA sponge modules, including 'SCC', 'SDC', 'SRVC', 'SM', 'SSI', 'SGCD' and 'SCRC'. |
num_shared_miRNAs |
The number of common miRNAs shared by a group of ceRNAs and mRNAs. Only for the SCC, SDC, SRVC, SSI, SGCD and SCRC methods. |
pvalue.cutoff |
The p-value cutoff of significant sharing of common miRNAs by a group of ceRNAs and mRNAs or significant correlation. |
MC.cutoff |
The cutoff of matrix correlation (canonical correlation, distance correlation and RV coefficient). Only for the SCC, SDC, SRVC, SSI, SGCD and SCRC methods. |
SMC.cutoff |
The cutoff of sensitivity matrix correlation (sensitivity canonical correlation, sensitivity distance correlation and sensitivity RV coefficient). Only for the SCC, SDC, SRVC, SSI, SGCD and SCRC methods when miRExp is not NULL. |
RV_method |
the method of calculating RV coefficients. Select one of 'RV', 'RV2', 'RVadjMaye' and 'RVadjGhaziri' methods. Only for the SRVC method. |
BCmethod |
Specification of the biclustering method, including 'BCBimax', 'BCCC', 'BCPlaid' (default), 'BCQuest', 'BCSpectral', 'BCXmotifs'. Only for the SM method. |
CRC_method |
the method of calculating matrix correlation. Select one of 'Coxhead' and 'Rozeboom' methods. Only for the SCRC method. |
List object: Group competition of miRNA sponge modules, and miRNA sponge modules.
Junpeng Zhang (https://www.researchgate.net/profile/Junpeng-Zhang-2)
Witten DM, Tibshirani R, Hastie T. A penalized matrix decomposition, with applications to sparse principal components and canonical correlation analysis. Biostatistics. 2009, 10(3):515-34.
Szekely GJ, Rizzo ML. Partial distance correlation with methods for dissimilarities. Annals of Statistics. 2014, 42(6):2382-2412.
Szekely GJ, Rizzo ML, Bakirov NK. Measuring and Testing Dependence by Correlation of Distances, Annals of Statistics, 2007, 35(6):2769-2794.
Robert P, Escoufier Y. A unifying tool for linear multivariate statistical methods: the RV-Coefficient. Applied Statistics, 1976, 25(3):257-265.
Smilde AK, Kiers HA, Bijlsma S, Rubingh CM, van Erk MJ. Matrix correlations for high-dimensional data: the modified RV-coefficient. Bioinformatics, 2009, 25(3):401-405.
Maye CD, Lorent J, Horgan GW. Exploratory analysis of multiple omics datasets using the adjusted RV coefficient". Stat Appl Genet Mol Biol., 2011, 10, 14.
EIGhaziri A, Qannari EM. Measures of association between two datasets; Application to sensory data, Food Quality and Preference, 2015, 40(A):116-124.
Indahl UG, Næs T, Liland KH. A similarity index for comparing coupled matrices. Journal of Chemometrics. 2018; 32:e3049.
Yanai H. Unification of various techniques of multivariate analysis by means of generalized coefficient of determination (GCD). Journal of Behaviormetrics, 1974, 1(1): 45-54.
Coxhead P. Measuring the relationship between two sets of variables. British journal of mathematical and statistical psychology, 1974, 27(2): 205-212.
Rozeboom WW. Linear correlations between sets of variables. Psychometrika, 1965, 30(1): 57-71.
data(BRCASampleData) modulegenes_igraph <- module_igraph(ceRExp[, seq_len(10)], mRExp[, seq_len(10)]) # Identify miRNA sponge modules using sensitivity RV coefficient (SRVC) miRSM_igraph_SRVC <- miRSM(miRExp, ceRExp, mRExp, miRTarget, modulegenes_igraph, method = "SRVC", SMC.cutoff = 0.01, RV_method = "RV")
data(BRCASampleData) modulegenes_igraph <- module_igraph(ceRExp[, seq_len(10)], mRExp[, seq_len(10)]) # Identify miRNA sponge modules using sensitivity RV coefficient (SRVC) miRSM_igraph_SRVC <- miRSM(miRExp, ceRExp, mRExp, miRTarget, modulegenes_igraph, method = "SRVC", SMC.cutoff = 0.01, RV_method = "RV")
Inferring sample-specific miRNA sponge modules
miRSM_SS( Modulelist.all, Modulelist.exceptk, sim.cutoff = 0.8, sim.method = "Simpson" )
miRSM_SS( Modulelist.all, Modulelist.exceptk, sim.cutoff = 0.8, sim.method = "Simpson" )
Modulelist.all |
List object, modules using all of samples. |
Modulelist.exceptk |
List object, modules using all of samples excepting sample k. |
sim.cutoff |
Similarity cutoff between modules, the interval is [0 1]. |
sim.method |
Methods for calculating similatiry between two modules, select one of three methods (Simpson, Jaccard and Lin). Default method is Simpson. |
A list of sample-specific miRNA sponge modules
Junpeng Zhang (https://www.researchgate.net/profile/Junpeng-Zhang-2)
data(BRCASampleData) nsamples <- 3 modulegenes_all <- module_igraph(ceRExp[, 151:300], mRExp[, 151:300]) modulegenes_exceptk <- lapply(seq(nsamples), function(i) module_WGCNA(ceRExp[-i, seq(150)], mRExp[-i, seq(150)])) miRSM_SRVC_all <- miRSM(miRExp, ceRExp[, 151:300], mRExp[, 151:300], miRTarget, modulegenes_all, method = "SRVC", SMC.cutoff = 0.01, RV_method = "RV") miRSM_SRVC_exceptk <- lapply(seq(nsamples), function(i) miRSM(miRExp[-i, ], ceRExp[-i, seq(150)], mRExp[-i, seq(150)], miRTarget, modulegenes_exceptk[[i]], method = "SRVC", SMC.cutoff = 0.01, RV_method = "RV")) Modulegenes_all <- miRSM_SRVC_all[[2]] Modulegenes_exceptk <- lapply(seq(nsamples), function(i) miRSM_SRVC_exceptk[[i]][[2]]) Modules_SS <- miRSM_SS(Modulegenes_all, Modulegenes_exceptk)
data(BRCASampleData) nsamples <- 3 modulegenes_all <- module_igraph(ceRExp[, 151:300], mRExp[, 151:300]) modulegenes_exceptk <- lapply(seq(nsamples), function(i) module_WGCNA(ceRExp[-i, seq(150)], mRExp[-i, seq(150)])) miRSM_SRVC_all <- miRSM(miRExp, ceRExp[, 151:300], mRExp[, 151:300], miRTarget, modulegenes_all, method = "SRVC", SMC.cutoff = 0.01, RV_method = "RV") miRSM_SRVC_exceptk <- lapply(seq(nsamples), function(i) miRSM(miRExp[-i, ], ceRExp[-i, seq(150)], mRExp[-i, seq(150)], miRTarget, modulegenes_exceptk[[i]], method = "SRVC", SMC.cutoff = 0.01, RV_method = "RV")) Modulegenes_all <- miRSM_SRVC_all[[2]] Modulegenes_exceptk <- lapply(seq(nsamples), function(i) miRSM_SRVC_exceptk[[i]][[2]]) Modules_SS <- miRSM_SS(Modulegenes_all, Modulegenes_exceptk)
miRNA-target ineractions
miRTarget: A SummarizedExperiment object with 29901 miRNA-target interactions.
The miRNA-target binding information is from miRTarBase v8.0 (http://mirtarbase.mbc.nctu.edu.tw/php/index.php), and LncBase v2.0 (http://carolina.imis.athena-innovation.gr/diana_tools/web/index.php?r=lncbasev2/index). Among 226 miRNAs, 305 lncRNAs and 500 mRNAs which are differentially expressed, we obtain 29901 miRNA-target interactions (including miRNA-lncRNA and miRNA-mRNA interactions).
Hastie T, Tibshirani R, Narasimhan B, Chu G. impute: Imputation for microarray data. R package version 1.54.0. doi: 10.18129/B9.bioc.impute.
Ritchie ME, Phipson B, Wu D, Hu Y, Law CW, Shi W, et al. limma powers differential expression analyses for RNA-sequencing and microarray studies. Nucleic Acids Res. 2015; 43(7):e47.
Identification of gene modules from matched ceRNA and mRNA expression data or single gene expression data using a series of biclustering packages, including biclust, iBBiG, fabia, BicARE, isa2, s4vd, BiBitR and rqubic
module_biclust( ceRExp, mRExp = NULL, BCmethod = "fabia", num.modules = 10, num.ModuleceRs = 2, num.ModulemRs = 2 )
module_biclust( ceRExp, mRExp = NULL, BCmethod = "fabia", num.modules = 10, num.ModuleceRs = 2, num.ModulemRs = 2 )
ceRExp |
A SummarizedExperiment object. ceRNA expression data: rows are samples and columns are ceRNAs. |
mRExp |
NULL (default) or a SummarizedExperiment object. mRNA expression data: rows are samples and columns are mRNAs. |
BCmethod |
Specification of the biclustering method, including 'BCBimax', 'BCCC', 'BCPlaid' (default), 'BCQuest', 'BCSpectral', 'BCXmotifs', iBBiG', 'fabia', 'fabiap', 'fabias', 'mfsc', 'nmfdiv', 'nmfeu', 'nmfsc', 'FLOC', 'isa', 'BCs4vd', 'BCssvd', 'bibit' and 'quBicluster'. |
num.modules |
The number of modules to be identified. For the 'BCPlaid', 'BCSpectral', 'isa' and 'bibit' methods, no need to set the parameter. For the 'quBicluster' method, the parameter is used to set the number of biclusters that should be reported. |
num.ModuleceRs |
The minimum number of ceRNAs in each module. |
num.ModulemRs |
The minimum number of mRNAs in each module. |
GeneSetCollection object: a list of module genes.
Junpeng Zhang (https://www.researchgate.net/profile/Junpeng-Zhang-2)
Preli\'c A, Bleuler S, Zimmermann P, Wille A, B\'uhlmann P, Gruissem W, Hennig L, Thiele L, Zitzler E. A systematic comparison and evaluation of biclustering methods for gene expression data. Bioinformatics. 2006, 22(9):1122-9.
Cheng Y, Church GM. Biclustering of expression data. Proc Int Conf Intell Syst Mol Biol. 2000, 8:93-103.
Turner H, Bailey T, Krzanowski W. Improved biclustering of microarray data demonstrated through systematic performance tests. Comput Stat Data Anal. 2003, 48(2): 235-254.
Murali TM, Kasif S. Extracting conserved gene expression motifs from gene expression data. Pac Symp Biocomput. 2003:77-88.
Kluger Y, Basri R, Chang JT, Gerstein M. Spectral biclustering of microarray data: coclustering genes and conditions. Genome Res. 2003, 13(4):703-16.
Gusenleitner D, Howe EA, Bentink S, Quackenbush J, Culhane AC. iBBiG: iterative binary bi-clustering of gene sets. Bioinformatics. 2012, 28(19):2484-92.
Hochreiter S, Bodenhofer U, Heusel M, Mayr A, Mitterecker A, Kasim A, Khamiakova T, Van Sanden S, Lin D, Talloen W, Bijnens L, G\'ohlmann HW, Shkedy Z, Clevert DA. FABIA: factor analysis for bicluster acquisition. Bioinformatics. 2010, 26(12):1520-7.
Yang J, Wang H, Wang W, Yu, PS. An improved biclustering method for analyzing gene expression. Int J Artif Intell Tools. 2005, 14(5): 771-789.
Bergmann S, Ihmels J, Barkai N. Iterative signature algorithm for the analysis of large-scale gene expression data. Phys Rev E Stat Nonlin Soft Matter Phys. 2003, 67(3 Pt 1):031902.
Sill M, Kaiser S, Benner A, Kopp-Schneider A. Robust biclustering by sparse singular value decomposition incorporating stability selection. Bioinformatics. 2011, 27(15):2089-97.
Lee M, Shen H, Huang JZ, Marron JS. Biclustering via sparse singular value decomposition. Biometrics. 2010, 66(4):1087-95.
Rodriguez-Baena DS, Perez-Pulido AJ, Aguilar-Ruiz JS. A biclustering algorithm for extracting bit-patterns from binary datasets. Bioinformatics. 2011, 27(19):2738-45.
Li G, Ma Q, Tang H, Paterson AH, Xu Y. QUBIC: a qualitative biclustering algorithm for analyses of gene expression data. Nucleic Acids Res. 2009, 37(15):e101.
data(BRCASampleData) modulegenes_biclust <- module_biclust(ceRExp[, seq_len(30)], mRExp[, seq_len(30)])
data(BRCASampleData) modulegenes_biclust <- module_biclust(ceRExp[, seq_len(30)], mRExp[, seq_len(30)])
Cancer enrichment analysis of miRNA sponge modules using hypergeometric distribution test
module_CEA(ceRExp, mRExp = NULL, Cancergenes, Modulelist)
module_CEA(ceRExp, mRExp = NULL, Cancergenes, Modulelist)
ceRExp |
A SummarizedExperiment object. ceRNA expression data: rows are samples and columns are ceRNAs. |
mRExp |
NULL (default) or a SummarizedExperiment object. mRNA expression data: rows are samples and columns are mRNAs. |
Cancergenes |
A SummarizedExperiment object: a list of cancer genes given. |
Modulelist |
List object: a list of the identified miRNA sponge modules. |
Cancer enrichment significance p-values of the identified miRNA sponge modules
Junpeng Zhang (https://www.researchgate.net/profile/Junpeng-Zhang-2)
Johnson NL, Kotz S, Kemp AW (1992) "Univariate Discrete Distributions", Second Edition. New York: Wiley.
data(BRCASampleData) modulegenes_WGCNA <- module_WGCNA(ceRExp, mRExp) # Identify miRNA sponge modules using sensitivity RV coefficient (SRVC) miRSM_WGCNA_SRVC <- miRSM(miRExp, ceRExp, mRExp, miRTarget, modulegenes_WGCNA, method = "SRVC", SMC.cutoff = 0.01, RV_method = "RV") miRSM_WGCNA_SRVC_genes <- miRSM_WGCNA_SRVC[[2]] miRSM.CEA.pvalue <- module_CEA(ceRExp, mRExp, BRCA_genes, miRSM_WGCNA_SRVC_genes)
data(BRCASampleData) modulegenes_WGCNA <- module_WGCNA(ceRExp, mRExp) # Identify miRNA sponge modules using sensitivity RV coefficient (SRVC) miRSM_WGCNA_SRVC <- miRSM(miRExp, ceRExp, mRExp, miRTarget, modulegenes_WGCNA, method = "SRVC", SMC.cutoff = 0.01, RV_method = "RV") miRSM_WGCNA_SRVC_genes <- miRSM_WGCNA_SRVC[[2]] miRSM.CEA.pvalue <- module_CEA(ceRExp, mRExp, BRCA_genes, miRSM_WGCNA_SRVC_genes)
Identification of gene modules from matched ceRNA and mRNA expression data or single gene expression data using a series of clustering packages, including stats, flashClust, dbscan, subspace, mclust, SOMbrero and ppclust packages.
module_clust( ceRExp, mRExp = NULL, cluster.method = "kmeans", num.modules = 10, num.ModuleceRs = 2, num.ModulemRs = 2 )
module_clust( ceRExp, mRExp = NULL, cluster.method = "kmeans", num.modules = 10, num.ModuleceRs = 2, num.ModulemRs = 2 )
ceRExp |
A SummarizedExperiment object. ceRNA expression data: rows are samples and columns are ceRNAs. |
mRExp |
NULL (default) or a SummarizedExperiment object. mRNA expression data: rows are samples and columns are mRNAs. |
cluster.method |
Specification of the clustering method, including 'kmeans'(default), 'hclust', 'dbscan' , 'clique', 'gmm', 'som' and 'fcm'. |
num.modules |
Parameter of the number of modules to be identified for the 'kmeans', 'hclust', 'gmm' and 'fcm' methods. Parameter of the number of intervals for the 'clique' method. For the 'dbscan' and 'som' methods, no need to set the parameter. |
num.ModuleceRs |
The minimum number of ceRNAs in each module. |
num.ModulemRs |
The minimum number of mRNAs in each module. |
GeneSetCollection object: a list of module genes.
Junpeng Zhang (https://www.researchgate.net/profile/Junpeng-Zhang-2)
Forgy EW. Cluster analysis of multivariate data: efficiency vs interpretability of classifications. Biometrics, 1965, 21:768-769.
Hartigan JA, Wong MA. Algorithm AS 136: A K-means clustering algorithm. Applied Statistics, 1979, 28:100-108.
Lloyd SP. Least squares quantization in PCM. Technical Note, Bell Laboratories. Published in 1982 in IEEE Transactions on Information Theory, 1982, 28:128-137.
MacQueen J. Some methods for classification and analysis of multivariate observations. In Proceedings of the Fifth Berkeley Symposium on Mathematical Statistics and Probability, eds L. M. Le Cam & J. Neyman, 1967, 1, pp.281-297. Berkeley, CA: University of California Press.
Langfelder P, Horvath S. Fast R Functions for Robust Correlations and Hierarchical Clustering. Journal of Statistical Software. 2012, 46(11):1-17.
Ester M, Kriegel HP, Sander J, Xu X. A density-based algorithm for discovering clusters in large spatial databases with noise, Proceedings of 2nd International Conference on Knowledge Discovery and Data Mining (KDD-96), 1996, 96(34): 226-231.
Campello RJGB, Moulavi D, Sander J. Density-based clustering based on hierarchical density estimates, Pacific-Asia conference on knowledge discovery and data mining. Springer, Berlin, Heidelberg, 2013: 160-172.
Agrawal R, Gehrke J, Gunopulos D, Raghavan P. Automatic subspace clustering of high dimensional data for data mining applications. In Proc. ACM SIGMOD, 1998.
Scrucca L, Fop M, Murphy TB, Raftery AE. mclust 5: clustering, classification and density estimation using Gaussian finite mixture models The R Journal 8/1, 2016, pp. 205-233.
Kohonen T. Self-Organizing Maps. Berlin/Heidelberg: Springer-Verlag, 3rd edition, 2001.
Dunn JC. A fuzzy relative of the ISODATA process and its use in detecting compact well-separated clusters. Journal of Cybernetics, 1973, 3(3):32-57.
Bezdek JC. Cluster validity with fuzzy sets. Journal of Cybernetics, 1974, 3: 58-73.
Bezdek JC. Pattern recognition with fuzzy objective function algorithms. Plenum, NY, 1981.
data(BRCASampleData) modulegenes_clust <- module_clust(ceRExp[, seq_len(30)], mRExp[, seq_len(30)])
data(BRCASampleData) modulegenes_clust <- module_clust(ceRExp[, seq_len(30)], mRExp[, seq_len(30)])
Co-expression analysis of each miRNA sponge module and its corresponding random miRNA sponge modules
module_Coexpress( ceRExp, mRExp = NULL, Modulelist, resample = 1000, method = c("mean", "median"), test.method = c("t.test", "wilcox.test") )
module_Coexpress( ceRExp, mRExp = NULL, Modulelist, resample = 1000, method = c("mean", "median"), test.method = c("t.test", "wilcox.test") )
ceRExp |
A SummarizedExperiment object. ceRNA expression data: rows are samples and columns are ceRNAs. |
mRExp |
NULL (default) or a SummarizedExperiment object. mRNA expression data: rows are samples and columns are mRNAs. |
Modulelist |
List object: a list of the identified miRNA sponge modules. |
resample |
The number of random miRNA sponge modules generated, and 1000 times in default. |
method |
The method used to evaluate the co-expression level of each miRNA sponge module. Users can select "mean" or "median" to calculate co-expression value of each miRNA sponge module and its corresponding random miRNA sponge module. |
test.method |
The method used to evaluate statistical significance p-value of co-expression level higher than random miRNA sponge modules. Users can select "t.test" or "wilcox.test" to calculate statistical significance p-value of co-expression level higher than random miRNA sponge modules. |
List object: co-expression values of miRNA sponge modules and their corresponding random miRNA sponge modules, and statistical significance p-value of co-expression level higher than random miRNA sponge modules.
Junpeng Zhang (https://www.researchgate.net/profile/Junpeng-Zhang-2)
data(BRCASampleData) modulegenes_WGCNA <- module_WGCNA(ceRExp, mRExp) # Identify miRNA sponge modules using sensitivity RV coefficient (SRVC) miRSM_WGCNA_SRVC <- miRSM(miRExp, ceRExp, mRExp, miRTarget, modulegenes_WGCNA, method = "SRVC", SMC.cutoff = 0.01, RV_method = "RV") miRSM_WGCNA_SRVC_genes <- miRSM_WGCNA_SRVC[[2]] miRSM_WGCNA_Coexpress <- module_Coexpress(ceRExp, mRExp, miRSM_WGCNA_SRVC_genes, resample = 10, method = "mean", test.method = "t.test")
data(BRCASampleData) modulegenes_WGCNA <- module_WGCNA(ceRExp, mRExp) # Identify miRNA sponge modules using sensitivity RV coefficient (SRVC) miRSM_WGCNA_SRVC <- miRSM(miRExp, ceRExp, mRExp, miRTarget, modulegenes_WGCNA, method = "SRVC", SMC.cutoff = 0.01, RV_method = "RV") miRSM_WGCNA_SRVC_genes <- miRSM_WGCNA_SRVC[[2]] miRSM_WGCNA_Coexpress <- module_Coexpress(ceRExp, mRExp, miRSM_WGCNA_SRVC_genes, resample = 10, method = "mean", test.method = "t.test")
Functional analysis of miRNA sponge modules, including functional enrichment and disease enrichment analysis
module_FA( Modulelist, GOont = "BP", KEGGorganism = "hsa", Reactomeorganism = "human", OrgDb = "org.Hs.eg.db", padjustvaluecutoff = 0.05, padjustedmethod = "BH", Analysis.type = c("FEA", "DEA") )
module_FA( Modulelist, GOont = "BP", KEGGorganism = "hsa", Reactomeorganism = "human", OrgDb = "org.Hs.eg.db", padjustvaluecutoff = 0.05, padjustedmethod = "BH", Analysis.type = c("FEA", "DEA") )
Modulelist |
List object: a list of miRNA sponge modules. |
GOont |
One of 'MF', 'BP', and 'CC' subontologies. |
KEGGorganism |
Organism, supported organism listed in http://www.genome.jp/kegg/catalog/org_list.html. |
Reactomeorganism |
Organism, one of 'human', 'rat', ' mouse', 'celegans', 'yeast', 'zebrafish', 'fly'. |
OrgDb |
OrgDb |
padjustvaluecutoff |
A cutoff value of adjusted p-values. |
padjustedmethod |
Adjusted method of p-values, can select one of 'holm', 'hochberg', 'hommel', 'bonferroni', 'BH', 'BY', 'fdr', 'none'. |
Analysis.type |
The type of functional analysis selected, including 'FEA' (functional enrichment analysis) and 'DEA' (disease enrichment analysis). |
List object: a list of enrichment analysis results.
Junpeng Zhang (https://www.researchgate.net/profile/Junpeng-Zhang-2)
Zhang J, Liu L, Xu T, Xie Y, Zhao C, Li J, Le TD (2019). “miRspongeR: an R/Bioconductor package for the identification and analysis of miRNA sponge interaction networks and modules.” BMC Bioinformatics, 20, 235.
Zhang J, Liu L, Zhang W, Li X, Zhao C, Li S, Li J, Le TD. miRspongeR 2.0: an enhanced R package for exploring miRNA sponge regulation. Bioinform Adv. 2022 Sep 2;2(1):vbac063.
Yu G, Wang L, Han Y, He Q (2012). “clusterProfiler: an R package for comparing biological themes among gene clusters.” OMICS: A Journal of Integrative Biology, 16(5), 284-287.
## Not run: data(BRCASampleData) modulegenes_WGCNA <- module_WGCNA(ceRExp, mRExp) # Identify miRNA sponge modules using sensitivity RV coefficient (SRVC) miRSM_WGCNA_SRVC <- miRSM(miRExp, ceRExp, mRExp, miRTarget, modulegenes_WGCNA, method = "SRVC", SMC.cutoff = 0.01, RV_method = "RV") miRSM_WGCNA_SRVC_genes <- miRSM_WGCNA_SRVC[[2]] miRSM_WGCNA_SRVC_FEA <- module_FA(miRSM_WGCNA_SRVC_genes, Analysis.type = 'FEA') miRSM_WGCNA_SRVC_DEA <- module_FA(miRSM_WGCNA_SRVC_genes, Analysis.type = 'DEA') ## End(Not run)
## Not run: data(BRCASampleData) modulegenes_WGCNA <- module_WGCNA(ceRExp, mRExp) # Identify miRNA sponge modules using sensitivity RV coefficient (SRVC) miRSM_WGCNA_SRVC <- miRSM(miRExp, ceRExp, mRExp, miRTarget, modulegenes_WGCNA, method = "SRVC", SMC.cutoff = 0.01, RV_method = "RV") miRSM_WGCNA_SRVC_genes <- miRSM_WGCNA_SRVC[[2]] miRSM_WGCNA_SRVC_FEA <- module_FA(miRSM_WGCNA_SRVC_genes, Analysis.type = 'FEA') miRSM_WGCNA_SRVC_DEA <- module_FA(miRSM_WGCNA_SRVC_genes, Analysis.type = 'DEA') ## End(Not run)
Identification of gene modules from matched ceRNA and mRNA expression data or single gene expression data using GFA package
module_GFA( ceRExp, mRExp = NULL, StrengthCut = 0.9, iter.max = 5000, num.ModuleceRs = 2, num.ModulemRs = 2 )
module_GFA( ceRExp, mRExp = NULL, StrengthCut = 0.9, iter.max = 5000, num.ModuleceRs = 2, num.ModulemRs = 2 )
ceRExp |
A SummarizedExperiment object. ceRNA expression data: rows are samples and columns are ceRNAs. |
mRExp |
NULL (default) or a SummarizedExperiment object. mRNA expression data: rows are samples and columns are mRNAs. |
StrengthCut |
Desired minimum strength (absolute value of association with interval [0 1]) for each bicluster. |
iter.max |
The total number of Gibbs sampling steps (default 1000). |
num.ModuleceRs |
The minimum number of ceRNAs in each module. |
num.ModulemRs |
The minimum number of mRNAs in each module. |
GeneSetCollection object: a list of module genes.
Junpeng Zhang (https://www.researchgate.net/profile/Junpeng-Zhang-2)
Bunte K, Lepp\'aaho E, Saarinen I, Kaski S. Sparse group factor analysis for biclustering of multiple data sources. Bioinformatics. 2016, 32(16):2457-63.
Lepp\'aaho E, Ammad-ud-din M, Kaski S. GFA: exploratory analysis of multiple data sources with group factor analysis. J Mach Learn Res. 2017, 18(39):1-5.
data(BRCASampleData) modulegenes_GFA <- module_GFA(ceRExp[seq_len(20), seq_len(15)], mRExp[seq_len(20), seq_len(15)], iter.max = 3000)
data(BRCASampleData) modulegenes_GFA <- module_GFA(ceRExp[seq_len(20), seq_len(15)], mRExp[seq_len(20), seq_len(15)], iter.max = 3000)
Calculating similarity between two list of module groups
module_group_sim(Module.group1, Module.group2, sim.method = "Simpson")
module_group_sim(Module.group1, Module.group2, sim.method = "Simpson")
Module.group1 |
List object, the first list of module group. |
Module.group2 |
List object, the second list of module group. |
sim.method |
Methods for calculating similatiry between two modules, select one of three methods (Simpson, Jaccard and Lin). Default method is Simpson. |
Similarity between two list of module groups
Junpeng Zhang (https://www.researchgate.net/profile/Junpeng-Zhang-2)
Simpson E H. Measurement of diversity. Nature, 1949, 163(4148): 688-688.
Jaccard P. The distribution of the flora in the alpine zone. 1. New phytologist, 1912, 11(2): 37-50.
Lin D. An information-theoretic definition of similarity. in: Icml. 1998, 98(1998): 296-304.
library(GSEABase) data(BRCASampleData) modulegenes_WGCNA <- module_WGCNA(ceRExp, mRExp) modulegenes_igraph <- module_igraph (ceRExp, mRExp) Sim <- module_group_sim(geneIds(modulegenes_WGCNA), geneIds(modulegenes_igraph))
library(GSEABase) data(BRCASampleData) modulegenes_WGCNA <- module_WGCNA(ceRExp, mRExp) modulegenes_igraph <- module_igraph (ceRExp, mRExp) Sim <- module_group_sim(geneIds(modulegenes_WGCNA), geneIds(modulegenes_igraph))
Identification of gene modules from matched ceRNA and mRNA expression data or single gene expression data using igraph package
module_igraph( ceRExp, mRExp = NULL, cor.method = "pearson", pos.p.value.cutoff = 0.01, cluster.method = "greedy", num.ModuleceRs = 2, num.ModulemRs = 2 )
module_igraph( ceRExp, mRExp = NULL, cor.method = "pearson", pos.p.value.cutoff = 0.01, cluster.method = "greedy", num.ModuleceRs = 2, num.ModulemRs = 2 )
ceRExp |
A SummarizedExperiment object. ceRNA expression data: rows are samples and columns are ceRNAs. |
mRExp |
NULL (default) or a SummarizedExperiment object. mRNA expression data: rows are samples and columns are mRNAs. |
cor.method |
The method of calculating correlation selected, including 'pearson' (default), 'kendall', 'spearman'. |
pos.p.value.cutoff |
The significant p-value cutoff of positive correlation. |
cluster.method |
The clustering method selected in igraph package, including 'betweenness', 'greedy' (default), 'infomap', 'prop', 'eigen', 'louvain', 'walktrap'. |
num.ModuleceRs |
The minimum number of ceRNAs in each module. |
num.ModulemRs |
The minimum number of mRNAs in each module. |
GeneSetCollection object: a list of module genes.
Junpeng Zhang (https://www.researchgate.net/profile/Junpeng-Zhang-2)
Csardi G, Nepusz T. The igraph software package for complex network research, InterJournal, Complex Systems. 2006:1695.
data(BRCASampleData) modulegenes_igraph <- module_igraph(ceRExp[, seq_len(10)], mRExp[, seq_len(10)])
data(BRCASampleData) modulegenes_igraph <- module_igraph(ceRExp[, seq_len(10)], mRExp[, seq_len(10)])
miRNA distribution analysis of sharing miRNAs by the identified miRNA sponge modules
module_miRdistribute(share_miRs)
module_miRdistribute(share_miRs)
share_miRs |
List object: a list of common miRNAs of each miRNA sponge module generated by share_miRs function. |
Matrix object: miRNA distribution in each miRNA sponge module.
Junpeng Zhang (https://www.researchgate.net/profile/Junpeng-Zhang-2)
data(BRCASampleData) modulegenes_WGCNA <- module_WGCNA(ceRExp, mRExp) # Identify miRNA sponge modules using sensitivity RV coefficient (SRVC) miRSM_WGCNA_SRVC <- miRSM(miRExp, ceRExp, mRExp, miRTarget, modulegenes_WGCNA, method = "SRVC", SMC.cutoff = 0.01, RV_method = "RV") miRSM_WGCNA_SRVC_genes <- miRSM_WGCNA_SRVC[[2]] miRSM_WGCNA_share_miRs <- share_miRs(miRExp, miRTarget, miRSM_WGCNA_SRVC_genes) miRSM_WGCNA_miRdistribute <- module_miRdistribute(miRSM_WGCNA_share_miRs)
data(BRCASampleData) modulegenes_WGCNA <- module_WGCNA(ceRExp, mRExp) # Identify miRNA sponge modules using sensitivity RV coefficient (SRVC) miRSM_WGCNA_SRVC <- miRSM(miRExp, ceRExp, mRExp, miRTarget, modulegenes_WGCNA, method = "SRVC", SMC.cutoff = 0.01, RV_method = "RV") miRSM_WGCNA_SRVC_genes <- miRSM_WGCNA_SRVC[[2]] miRSM_WGCNA_share_miRs <- share_miRs(miRExp, miRTarget, miRSM_WGCNA_SRVC_genes) miRSM_WGCNA_miRdistribute <- module_miRdistribute(miRSM_WGCNA_share_miRs)
Extract miRNA sponge interactions of each miRNA sponge module
module_miRsponge(Modulelist)
module_miRsponge(Modulelist)
Modulelist |
List object: a list of the identified miRNA sponge modules. |
List object: miRNA sponge interactions of each miRNA sponge module.
Junpeng Zhang (https://www.researchgate.net/profile/Junpeng-Zhang-2)
data(BRCASampleData) modulegenes_WGCNA <- module_WGCNA(ceRExp, mRExp) # Identify miRNA sponge modules using sensitivity RV coefficient (SRVC) miRSM_WGCNA_SRVC <- miRSM(miRExp, ceRExp, mRExp, miRTarget, modulegenes_WGCNA, method = "SRVC", SMC.cutoff = 0.01, RV_method = "RV") miRSM_WGCNA_SRVC_genes <- miRSM_WGCNA_SRVC[[2]] miRSM_WGCNA_miRsponge <- module_miRsponge(miRSM_WGCNA_SRVC_genes)
data(BRCASampleData) modulegenes_WGCNA <- module_WGCNA(ceRExp, mRExp) # Identify miRNA sponge modules using sensitivity RV coefficient (SRVC) miRSM_WGCNA_SRVC <- miRSM(miRExp, ceRExp, mRExp, miRTarget, modulegenes_WGCNA, method = "SRVC", SMC.cutoff = 0.01, RV_method = "RV") miRSM_WGCNA_SRVC_genes <- miRSM_WGCNA_SRVC[[2]] miRSM_WGCNA_miRsponge <- module_miRsponge(miRSM_WGCNA_SRVC_genes)
Extract miRNA-target interactions of each miRNA sponge module
module_miRtarget(share_miRs, Modulelist)
module_miRtarget(share_miRs, Modulelist)
share_miRs |
List object: a list of common miRNAs of each miRNA sponge module generated by share_miRs function. |
Modulelist |
List object: a list of the identified miRNA sponge modules. |
List object: miRNA-target interactions of each miRNA sponge module.
Junpeng Zhang (https://www.researchgate.net/profile/Junpeng-Zhang-2)
data(BRCASampleData) modulegenes_WGCNA <- module_WGCNA(ceRExp, mRExp) # Identify miRNA sponge modules using sensitivity RV coefficient (SRVC) miRSM_WGCNA_SRVC <- miRSM(miRExp, ceRExp, mRExp, miRTarget, modulegenes_WGCNA, method = "SRVC", SMC.cutoff = 0.01, RV_method = "RV") miRSM_WGCNA_SRVC_genes <- miRSM_WGCNA_SRVC[[2]] miRSM_WGCNA_share_miRs <- share_miRs(miRExp, miRTarget, miRSM_WGCNA_SRVC_genes) miRSM_WGCNA_miRtarget <- module_miRtarget(miRSM_WGCNA_share_miRs, miRSM_WGCNA_SRVC_genes)
data(BRCASampleData) modulegenes_WGCNA <- module_WGCNA(ceRExp, mRExp) # Identify miRNA sponge modules using sensitivity RV coefficient (SRVC) miRSM_WGCNA_SRVC <- miRSM(miRExp, ceRExp, mRExp, miRTarget, modulegenes_WGCNA, method = "SRVC", SMC.cutoff = 0.01, RV_method = "RV") miRSM_WGCNA_SRVC_genes <- miRSM_WGCNA_SRVC[[2]] miRSM_WGCNA_share_miRs <- share_miRs(miRExp, miRTarget, miRSM_WGCNA_SRVC_genes) miRSM_WGCNA_miRtarget <- module_miRtarget(miRSM_WGCNA_share_miRs, miRSM_WGCNA_SRVC_genes)
Identification of gene modules from matched ceRNA and mRNA expression data or single gene expression data using NMF package
module_NMF( ceRExp, mRExp = NULL, NMF.algorithm = "brunet", num.modules = 10, num.ModuleceRs = 2, num.ModulemRs = 2 )
module_NMF( ceRExp, mRExp = NULL, NMF.algorithm = "brunet", num.modules = 10, num.ModuleceRs = 2, num.ModulemRs = 2 )
ceRExp |
A SummarizedExperiment object. ceRNA expression data: rows are samples and columns are ceRNAs. |
mRExp |
NULL (default) or a SummarizedExperiment object. mRNA expression data: rows are samples and columns are mRNAs. |
NMF.algorithm |
Specification of the NMF algorithm, including 'brunet' (default), 'Frobenius', 'KL', 'lee', 'nsNMF', 'offset', 'siNMF', 'snmf/l', 'snmf/r'. |
num.modules |
The number of modules to be identified. |
num.ModuleceRs |
The minimum number of ceRNAs in each module. |
num.ModulemRs |
The minimum number of mRNAs in each module. |
GeneSetCollection object: a list of module genes.
Junpeng Zhang (https://www.researchgate.net/profile/Junpeng-Zhang-2)
Gaujoux R, Seoighe C. A flexible R package for nonnegative matrix factorization. BMC Bioinformatics. 2010, 11:367.
data(BRCASampleData) # Reimport NMF package to avoid conflicts with DelayedArray package library(NMF) modulegenes_NMF <- module_NMF(ceRExp[, seq_len(10)], mRExp[, seq_len(10)])
data(BRCASampleData) # Reimport NMF package to avoid conflicts with DelayedArray package library(NMF) modulegenes_NMF <- module_NMF(ceRExp[, seq_len(10)], mRExp[, seq_len(10)])
Identification of gene modules from matched ceRNA and mRNA expression data or single gene expression data using ProNet package
module_ProNet( ceRExp, mRExp = NULL, cor.method = "pearson", pos.p.value.cutoff = 0.01, cluster.method = "MCL", num.ModuleceRs = 2, num.ModulemRs = 2 )
module_ProNet( ceRExp, mRExp = NULL, cor.method = "pearson", pos.p.value.cutoff = 0.01, cluster.method = "MCL", num.ModuleceRs = 2, num.ModulemRs = 2 )
ceRExp |
A SummarizedExperiment object. ceRNA expression data: rows are samples and columns are ceRNAs. |
mRExp |
NULL (default) or a SummarizedExperiment object. mRNA expression data: rows are samples and columns are mRNAs. |
cor.method |
The method of calculating correlation selected, including 'pearson' (default), 'kendall', 'spearman'. |
pos.p.value.cutoff |
The significant p-value cutoff of positive correlation |
cluster.method |
The clustering method selected in ProNet package, including 'FN', 'MCL' (default), 'LINKCOMM', 'MCODE'. |
num.ModuleceRs |
The minimum number of ceRNAs in each module. |
num.ModulemRs |
The minimum number of mRNAs in each module. |
GeneSetCollection object: a list of module genes.
Junpeng Zhang (https://www.researchgate.net/profile/Junpeng-Zhang-2)
Clauset A, Newman ME, Moore C. Finding community structure in very large networks. Phys Rev E Stat Nonlin Soft Matter Phys., 2004, 70(6 Pt 2):066111.
Enright AJ, Van Dongen S, Ouzounis CA. An efficient algorithm for large-scale detection of protein families. Nucleic Acids Res., 2002, 30(7):1575-84.
Kalinka AT, Tomancak P. linkcomm: an R package for the generation, visualization, and analysis of link communities in networks of arbitrary size and type. Bioinformatics, 2011, 27(14):2011-2.
Bader GD, Hogue CW. An automated method for finding molecular complexes in large protein interaction networks. BMC Bioinformatics, 2003, 4:2.
data(BRCASampleData) modulegenes_ProNet <- module_ProNet(ceRExp[, seq_len(10)], mRExp[, seq_len(10)])
data(BRCASampleData) modulegenes_ProNet <- module_ProNet(ceRExp[, seq_len(10)], mRExp[, seq_len(10)])
Validation of miRNA sponge interactions in each miRNA sponge module
module_Validate(Modulelist, Groundtruth)
module_Validate(Modulelist, Groundtruth)
Modulelist |
List object: a list of the identified miRNA sponge modules. |
Groundtruth |
Matrix object: a list of experimentally validated miRNA sponge interactions. |
List object: a list of validated miRNA sponge interactions in each miRNA sponge module
Junpeng Zhang (https://www.researchgate.net/profile/Junpeng-Zhang-2)
data(BRCASampleData) modulegenes_WGCNA <- module_WGCNA(ceRExp, mRExp) # Identify miRNA sponge modules using sensitivity RV coefficient (SRVC) miRSM_WGCNA_SRVC <- miRSM(miRExp, ceRExp, mRExp, miRTarget, modulegenes_WGCNA, method = "SRVC", SMC.cutoff = 0.01, RV_method = "RV") miRSM_WGCNA_SRVC_genes <- miRSM_WGCNA_SRVC[[2]] Groundtruthcsv <- system.file("extdata", "Groundtruth_high.csv", package="miRSM") Groundtruth <- read.csv(Groundtruthcsv, header=TRUE, sep=",") miRSM.Validate <- module_Validate(miRSM_WGCNA_SRVC_genes, Groundtruth)
data(BRCASampleData) modulegenes_WGCNA <- module_WGCNA(ceRExp, mRExp) # Identify miRNA sponge modules using sensitivity RV coefficient (SRVC) miRSM_WGCNA_SRVC <- miRSM(miRExp, ceRExp, mRExp, miRTarget, modulegenes_WGCNA, method = "SRVC", SMC.cutoff = 0.01, RV_method = "RV") miRSM_WGCNA_SRVC_genes <- miRSM_WGCNA_SRVC[[2]] Groundtruthcsv <- system.file("extdata", "Groundtruth_high.csv", package="miRSM") Groundtruth <- read.csv(Groundtruthcsv, header=TRUE, sep=",") miRSM.Validate <- module_Validate(miRSM_WGCNA_SRVC_genes, Groundtruth)
Identification of co-expressed gene modules from matched ceRNA and mRNA expression data or single gene expression data using WGCNA package
module_WGCNA( ceRExp, mRExp = NULL, RsquaredCut = 0.9, num.ModuleceRs = 2, num.ModulemRs = 2 )
module_WGCNA( ceRExp, mRExp = NULL, RsquaredCut = 0.9, num.ModuleceRs = 2, num.ModulemRs = 2 )
ceRExp |
A SummarizedExperiment object. ceRNA expression data: rows are samples and columns are ceRNAs. |
mRExp |
NULL (default) or a SummarizedExperiment object. mRNA expression data: rows are samples and columns are mRNAs. |
RsquaredCut |
Desired minimum scale free topology fitting index R^2 with interval [0 1]. |
num.ModuleceRs |
The minimum number of ceRNAs in each module. |
num.ModulemRs |
The minimum number of mRNAs in each module. |
GeneSetCollection object: a list of module genes.
Junpeng Zhang (https://www.researchgate.net/profile/Junpeng-Zhang-2)
Langfelder P, Horvath S. WGCNA: an R package for weighted correlation network analysis. BMC Bioinformatics. 2008, 9:559.#'
data(BRCASampleData) modulegenes_WGCNA <- module_WGCNA(ceRExp[, seq_len(80)], mRExp[, seq_len(80)])
data(BRCASampleData) modulegenes_WGCNA <- module_WGCNA(ceRExp[, seq_len(80)], mRExp[, seq_len(80)])
mRNA expression data
mRExp: A SummarizedExperiment object with 72 BRCA and 72 normal samples (rows) and 226 miRNAs (columns).
The matched breast invasive carcinoma (BRCA) miRNA, lncRNA and mRNA expression data is obtained from TCGA (http://cancergenome.nih.gov/). The data focuses on 72 individuals for which the complete sets of tumor and matched normal (i.e., normal tissue taken from the same patient) profiles are available. A mRNA which has missing values in more than 10 are imputed using the k-nearest neighbours (KNN) algorithm from the impute R package. We use the limma R package to infer differentially expressed mRNAs between tumour and normal samples. After the analysis, we select top 500 mRNAs which are differentially expressed at a significant level (adjusted p-value < 1E-02, adjusted by Benjamini & Hochberg method).