Abstract
Simple Summary
With the influx of multi-omics profiling, effective integration of these data remains the bottleneck for omics-driven discovery. Thus, we developed DRPPM-EASY, an R Shiny framework for integrative multi-omics analysis of cancer datasets. Our tool enables the exploration of multi-omics data by providing a simple user interface that minimizes the need for computational experience. Furthermore, the interface can be deployed locally or on a webserver to facilitate scientific collaboration and discovery.
Abstract
High-throughput transcriptomic and proteomic analyses are now routinely applied to study cancer biology. However, complex omics integration remains challenging and often time-consuming. Here, we developed DRPPM-EASY, an R Shiny framework for integrative multi-omics analysis. We applied our application to analyze RNA-seq data generated from a USP7 knockdown in T-cell acute lymphoblastic leukemia (T-ALL) cell line, which identified upregulated expression of a TAL1-associated proliferative signature in T-cell acute lymphoblastic leukemia cell lines. Next, we performed proteomic profiling of the USP7 knockdown samples. Through DRPPM-EASY-Integration, we performed a concurrent analysis of the transcriptome and proteome and identified consistent disruption of the protein degradation machinery and spliceosome in samples with USP7 silencing. To further illustrate the utility of the R Shiny framework, we developed DRPPM-EASY-CCLE, a Shiny extension preloaded with the Cancer Cell Line Encyclopedia (CCLE) data. The DRPPM-EASY-CCLE app facilitates the sample querying and phenotype assignment by incorporating meta information, such as genetic mutation, metastasis status, sex, and collection site. As proof of concept, we verified the expression of TP53 associated DNA damage signature in TP53 mutated ovary cancer cells. Altogether, our open-source application provides an easy-to-use framework for omics exploration and discovery.
Keywords: R Shiny application, RNA-seq, proteomics, multi-omics analysis, T-cell acute lymphoblastic leukemia, CCLE
1. Introduction
Multi-omics profiling of cancer patient samples and cell lines is becoming a staple of cancer research [1]. These technologies have a high potential for advancing our understanding of tumor biology and, in turn, reveal novel targets for treatment and diagnosis [2,3]. To date, a brief survey of the existing database reveals more than 500K cancer samples from GEO [4,5] and 90K pre-computed cancer expression data from recount3 [6]. Additionally, there are close to 4K mass spectrometry profiling of cancer patient samples from the Clinical Proteomic Tumor Analysis Consortium (CPTAC) data [7]. Large consortium projects, such as the Cancer Cell Line Encyclopedia (CCLE), have also generated many high-throughput datasets, such as transcript expression, RNA splicing, proteome profiling, drug response, and genetic screening data [8].
With the influx of multi-omics profiling, effective integration of these data remains the bottleneck for omics-driven discovery. The development of a simple user interface that minimizes the need for computational experience is of high interest to the community [9]. Several web-based tools are now available to perform general expression analysis of proteomics (e.g., POMAShiny [10]) and transcriptome data (e.g., TCC-GUI [11], START App [12], and GENAVi [13]). Multi-omics approaches for network analysis (e.g., MiBiOmics [14] and JUMPn [15]) are also available as a Shiny app. Web tools also exist for analyzing large datasets from the Gene Expression Omnibus (GEO) data (e.g., shinyGEO [16], ImaGEO [17]) and the cancer dependency map (e.g., shinyDepMap [18]). However, these applications tend to have limited features for analyzing complex heterogeneous phenotypes in cell lines and patients, such as mutation of genomic drivers, cell line characteristics, sex, or metastasis status. Additionally, none of these tools provides a streamlined pipeline to assess similarities and differences between omics datasets, such as transcriptome and proteome comparisons, or comparisons between mouse and human cancer models.
To address these challenges, we have developed DRPPM-EASY, a Shiny app built with an open-source R programming language that can be run as a local instance or deployed online. Here, our app is divided into two major modules: (1) a one-stop expression analysis for gene expression analysis and (2) an integrative framework for comparing omics data. As a proof of concept, we further implemented an app for querying and automating extraction of sample groupings of CCLE data for downstream analysis. The source code of our application can be downloaded from https://github.com/shawlab-moffitt/DRPPM-EASY-ExprAnalysisShinY (accessed on 1 February 2022).
2. Materials and Methods
2.1. Module 1. DRPPM-EASY APP Implementation
The DRPPM-EASY app is a Shiny web app built with an open-source R programming language (V.4.1.0). The Shiny framework leverages existing RNA-seq analysis packages to put together a one-stop analysis framework (Figure 1A) for data exploration (Table 1), differential expression analysis (Table 2), and gene set enrichment analysis (Table 3). The data exploration section allows the user to perform unsupervised and supervised hierarchical clustering. Clustering can be further evaluated by different types of distance calculations (i.e., ward, average, complete, centroid) or variable gene ranking strategy (mean absolute deviation or variance). The relative gene expression can be examined across sample groups by a boxplot or scatter plot to examine the gene expression of the positive control associated with the experimental design. Differential gene expression is performed by LIMMA [19] and can be visualized as a volcano plot and MA-plot. The list of differentially expressed genes can be further examined by pathway enrichment analysis (Figure 1A). Finally, the user can perform gene set enrichment analysis (GSEA), which ranks the genes based on signal-to-noise between the user-selected phenotype to examine enriched genes associated with a gene set signature (Figure 1A). A complementary strategy to estimate enrichment scores for individual samples can be performed by single-sample GSEA (ssGSEA) implemented in the GSVA library [20]. Finally, these single-sample enrichment scores can be downloaded as a tab-delimited table or visualized as a boxplot.
Table 1.
App Function | Description | |
---|---|---|
E1 | Unsupervised Heatmap |
|
E2 | Scatter Plot |
|
E3 | Custom Heatmap |
|
E4 | Box Plot |
|
Table 2.
App Function | Description | |
---|---|---|
DEA1 | Volcano Plot |
|
DEA2 | MA Plot |
|
DEA4 | Pathway Enrichment Analysis |
|
Table 3.
App Function | Description | |
---|---|---|
GA1 | Enrichment Plot |
|
GA2 | Gene Expression Heatmap |
|
GA3 | GSEA Summary Table |
|
GA4 | Generate Summary Table |
|
GA5 | ssGSEA Boxplots |
|
2.2. Module 2. The DRPPM-EASY-Integration App Implementation
The DRPPM-EASY-Integration provides an explorer for the user to upload normalized RNA expression, proteomic quantification, or ssGSEA scores to evaluate the potential relationship between these features (Figure 1B). These can be evaluated by either a 1:1 scatter plot or 1:n rank of Spearman correlation rho values (Table 4). The integrative app also allows the user to perform concurrent differential expression analysis and integration of two expression matrices, for example, to compare RNA and protein expression matrices. The fold change can be compared between the two datasets (Table 4), and differentially expressed genes can be compared by reciprocal GSEA or ssGSEA. Direct overlap between the differentially expressed genes is shown as a Venn diagram and further compared to existing gene set databases by Fisher’s exact test, Cohen’s kappa score, and the Jaccard index.
Table 4.
App Function | Description | |
---|---|---|
IA1 | Scatter Plot Comparison |
|
IA2 | Correlation Rank Plot |
|
IA3 | Matrix Comparison File Upload |
|
IA4 | Log2FC Comparison Scatter Plot |
|
IA5 | Reciprocal GSEA |
|
IA6 | Reciprocal ssGSEA |
|
IA7 | Venn Diagram |
|
2.3. Installation and User Guide
The source code and user guide are available for download on the project’s GitHub page. The GitHub page includes the list of individual R packages and their version along with an installation script for all package dependencies.
2.4. RNA Sequencing Analysis
USP7 samples were prepared as described in Shaw et al. [21]. Briefly, human T-ALL cell lines Jurkat (ATCC) cells were transduced with USP7 shRNA lentivirus and sorted for GFP positive cells or selected by puromycin. RNA samples were isolated using RNeasy Mini Kit (QIAGEN) and subjected to paired-end 2 × 151 base-pair RNA-seq sequencing (Illumina), 10 Jurkat samples—of which 6 were treated with shRNA and 4 were treated with a scramble RNA—were profiled by RNA-seq. RNA-seq data were processed by a custom pipeline (WRAP, https://github.com/gatechatl/DRPPM_Example_Input_Output/tree/master/WRAP:Wrapper-for-my-RNAseq-Analysis-Pipeline (accessed on 1 August 2021. RNA-seq reads were aligned using the STAR 2.7.1a aligner [22] in the two-pass mode to the human hg38 genome build using gene annotations provided by the Gencode v31 gene models. Read count for each gene was obtained with HT-seq [23]. Reads were normalized to fragments per kilobase million (FPKM) for each gene.
2.5. Whole Proteomics Mass Spectrometry and Data Analysis
The 10-plex TMT labeled mass spectrometry experiment was performed with a previously published protocol with slight modification [24,25] (See Supplementary Method, Supplementary Figure S3 for the experimental design). Protein for each sample was digested by trypsin (Promega). The TMT labeled samples were mixed equally, desalted, and fractionated on an offline HPLC (Agilent 1220) using basic pH reverse-phase liquid chromatography (pH 8.0, XBridge C18 column, 4.6 mm × 25 cm, 3.5 μm particle size, Waters). In total, 20 fractions were derived, and the eluted peptides were ionized by electrospray ionization and detected by an inline Orbitrap Fusion mass spectrometer (Thermo Scientific. Waltham, MA, USA). The MS/MS raw files were processed by a tag-based hybrid search engine JUMP [26]. The data were searched against the UniProt human concatenated with a reversed decoy database for evaluating false discovery rate. Searches were performed using a 25 ppm mass tolerance for precursor ions and 25 ppm mass tolerance for fragment ions, fully tryptic restriction with two maximal missed cleavages, three maximal modification sites, and the assignment of a, b, and y ions. TMT tags on lysine residues and N-termini (+229.162932 Da) were used for static modifications, and Met oxidation (+15.99492 Da) was considered as a dynamic modification. MS/MS spectra were filtered by mass accuracy and matching scores to reduce the protein false discovery rate to approximately 1%. Proteins were quantified by summing up reporter ion counts across all matched PSMs using the JUMP software suite [25,26].
2.6. Pre-Processing of the GSEA Analysis
To optimize the user experience, we provided a script to pre-generate a GSEA result table (Supplementary Figure S1). The GitHub page contains “Getting Started Scripts”, which allows the user to pre-process GSEA results for downstream table visualization. Enriched signature tables can take a long time to process depending on the number of samples or the size of the GMT file provided by the user. At the top of the script, there are key input parameters, such as file path and name to the expression matrix, metadata, and gene set file, as well as the preferred output file path of the output table(s). Additionally, the getting started scripts include a script to generate an R Data list of the ssGSEA analysis. Large gene sets may require several minutes, so pre-computing can facilitate a better user experience.
3. Results
3.1. DRPPM-EASY Analysis of RNA-seq and Proteomics Data Use Case 1
We previously identified that USP7 knockdown in T-ALL reduces the activity of E-proteins in a TAL1 dependent manner [21]. To highlight the functions of the DRPPM-EASY application, we re-examined the RNA sequencing profiling data of Jurkat cells after USP7 shRNA silencing. RNA-seq sample grouping was assessed by unsupervised hierarchical clustering (Figure 2A). Notably, altering the clustering methods and the number of (selected) top variables did not change the clustering result, suggesting robust grouping of our data (Supplementary Figure S2). Differential gene expression was then performed by LIMMA and visualized as a Volcano and MA plot. As expected, differential gene expression analysis found downregulated USP7 expression after silencing (Figure 2B,C). Notably, MYC, NOTCH1, TRIB2, and EOMES were upregulated after USP7 knockdown (Figure 2B). In the pathway analysis view, enriched pathways can be examined with preloaded gene sets from MsigDB, cell marker, and L1000 drug response. By GSEA and single-sample GSEA, we found USP7 knockdown upregulated with MYC and TAL1 associated targets (Figure 2D,E) and found downregulated apoptotic gene signature from the Hallmark database (Figure 2F). Overall, the RNA-seq analysis supports our previous finding that USP7 is implicated in the negative regulation of TAL1-dependent leukemia growth [21].
Next, tandem-mass-tagged proteomics profiling was performed on the same set of samples with RNA-seq profiling (Figure 3A; Supplementary Figure S3). A joint analysis of the transcriptome and proteome data was carried out by the DRPPM-EASY-Integration pipeline, identifying genes with altered protein abundance and unaltered mRNA levels, such as TRIM27, NOTCH2, UBR3, and USP22 (Figure 3B). Consistent with our previous observation, TRIM27, a known target of USP7 [27], observed decreased protein abundance in T-ALL cell lines with a haploinsufficient USP7 [21]. The altered abundance of UBR3 and USP22 suggests an altered ubiquitin ligase network. Furthermore, our result suggests that USP7 loss-of-function alters NOTCH2 protein abundance. Of note, NOTCH1 [28] protein abundance was unaltered after USP7 knockdown (Figure 3B). Thus, the precise mechanism of USP7 to drive the NOTCH association leukemia signature will need to be carefully examined in future studies.
The DRPPM-EASY-Integration includes features assessing the consistency between two datasets. Using the RNA-seq and proteomic data as proof of concept, DRPPM-EASY-Integration found 987 genes consistently upregulated, and 622 genes consistently downregulated in both datasets (Figure 3C–E). A connectivity map-inspired strategy [29,30] was applied to compare the consistency between the two datasets using reciprocal enrichment. Specifically, differential expressed genes in one dataset was used to derive a gene signature for GSEA to test in the other dataset. For example, differentially expressed proteins (Figure 3F) were applied as a GSEA gene set and tested for enrichment in the transcriptome data (Figure 3G). Similarly, gene sets derived from differentially expressed transcripts (Figure 3C) were tested for enrichment in the proteome data (Figure 3H). We then compared the significance of the overlapping differentially expressed genes against other pathway databases, such as Hallmark and KEGG. The overlap was evaluated by Fisher’s exact test, Cohen’s kappa, and Jaccard index. Consistently, the RNA and protein were most significantly overlapped compared to other gene sets. Moreover, the spliceosome and ubiquitin-mediated proteolysis pathways from KEGG and the unfolded protein response and MYC pathway from Hallmark were consistently enriched in both datasets (Supplementary Figure S3B,C; Supplementary Tables S1 and S2).
3.2. DRPPM-EASY-CCLE Use Case 2
To further illustrate the DRPPM-EASY functionality, we developed DRRPM-EASY-CCLE, an extended app with features to select samples from the Cancer Cell Line Encyclopedia (CCLE) data. The app is preloaded with 1379 CCLE samples spanning 37 lineages, 96 lineage sub-types, and 33 diseases. For the genetic characterization, 299 cancer drivers [31] were selected and further divided based on the damaging and non-damaging variant status from DepMap [32] (see Supplementary Table S3 for the complete phenotype categories). As an example, we extracted ovary cancer cell lines and performed expression analysis comparing TP53 mutation status to its wild-type counterpart (Figure 4A). In TP53 mutated ovary cancer cells, we found a decreased DNA damage response gene signature (Figure 4B), thereby solidifying the role of TP53 loss-of-function for regulating DNA damage in these ovarian cancer cells.
Previously, KRAS was found to be frequently mutated in non-small cell lung cancer (NSCLC) and is associated with drug resistance [33]. Thus, we analyzed NSCLC cell lines and compared KRAS mutation status to its wild-type counterpart (Figure 4C). By pathway analysis, the MsigDB defined KRAS signature was consistently upregulated in our KRAS mutated samples (Supplementary Figure S4A). Interestingly, top pathways enriched in the KRAS mutated samples are associated with an anti-apoptosis signature (Supplementary Figure S4B). By ssGSEA, amplified expression in KRAS mutated NSCLC cells were enriched with genes that negatively regulate apoptosis (Figure 4D) and upregulating genes that associated with stress granule assembly and disassembly (Figure 4E), which is a dynamic process fundamental to surviving under stress [34]. Interestingly, oncogenic KRAS-driven stress granules were previously identified in pancreatic and colorectal adenocarcinoma [35]; thus, our result suggests a similar stress response in NSCLC cells.
To further expand our functionality for exploring these large project data, we have also implemented features that enable users to upload their own expression matrix to perform an integrative analysis in CCLE and lung squamous cell carcinoma CPTAC datasets https://github.com/shawlab-moffitt/DRPPM-EASY-LargeProject-Integration (accessed on 1 February 2022) (Supplementary Figures S5A–C). Altogether, our framework provides a user-friendly environment to categorize the samples for downstream analysis with a high potential for novel discovery.
4. Discussion
An effective method for visualization and data analysis is key to the analysis of multi-omics data that captures the molecular processes of cancer initiation and progression. Several Shiny apps have been published to date and can be categorized into the following three categories: (1) tools that focus on pairwise differential expression and biomarker discovery (e.g., POMAShiny 10], TCC-GUI [11], and START App [12]), (2) tools that perform pathway and network analysis (e.g., iOmics [14] and JUMPn [15]), and (3) tools that facilitate the query of large datasets, such as from public repositories or consortium deposited datasets and deposited expression data (e.g., shinyGEO [16], ImaGEO [17], and GENAVi [13]). While numerous web tools have been developed thus far, there is a lack of tools that directly address challenges associated with multi-data integration, such as evaluating the consistency between omics datasets.
Here, we developed an interactive software tool, DRPPM-EASY, that allows users to perform complex omics data integration in both small (pairwise comparison) and large (consortium) projects. DRPPM-EASY puts together an interactive flexible interface that enables the exploration of biomarkers and enriched pathways across multiple datasets. DRPPM-EASY can perform routine gene analysis, such as hierarchical clustering, differential gene expression, pathway analysis, GSEA, and ssGSEA. Additionally, DRPPM-EASY can perform a joint analysis of two expression datasets. As an example, we have highlighted the application’s ability to evaluate the consistency between transcriptome and protein datasets. This is made possible by deriving a gene set feature in one dataset (i.e., transcriptomics), which is applied in the GSEA analysis of the other dataset (i.e., proteomics). DRPPM-EASY can be easily adapted for large consortium data, which we highlight as an example in CCLE cancer cell lines and lung squamous cell carcinoma CPTAC proteome data. Finally, to further expand the utility of our tool, the user can upload their own expression data and use it to compare against CCLE cell lines and lung squamous cell carcinoma proteome data. One major limitation of our application requires the user to normalize their gene expression matrix prior to using our application. Existing pipelines are available to streamline the normalization procedure, such as Shiny-Seq [36]. A normalization procedure will be included in future updates of our application.
Finally, the ability to run the application with a user interface on a local desktop reduces the need for computational domain knowledge of expression analysis. The DRPPM-EASY application can be set up on the server in real-time, enabling collaborative discussion on potential hypotheses derived from the high-throughput data. Our tool also ensures reproducibility of the data analysis, which is one of the most significant issues in omics research [37]. While the current application is highlighted to work in RNA-seq and proteomics data, our framework could easily be adapted to incorporate drug response, genetic screening, or splicing associated features in future versions of our application. Thus, we believe DRPPM-EASY will be a useful and valuable tool for the biomedical research community.
Acknowledgments
This work has been supported in part by the Biostatistics and Bioinformatics Shared Resource at the Moffitt Cancer Center (NCI P30 CA076292) and the Moffitt Cancer Center Department of Biostatistics and Bioinformatics Pilot Project (PI: T.S.). We would like to thank Rodrigo Carvajal and Guillermo Gonzalez-Calderon for their help in setting up the internal web server. We would like to thank Dongliang Du and Ling Cen for their help in the USP7 RNAseq analysis.
Supplementary Materials
The following supporting information can be downloaded at: https://www.mdpi.com/article/10.3390/biology11020260/s1, Supplementary Method. Supplementary Table S1. KEGG Pathways Jointly Enriched in the Transcriptome and Proteome. Supplementary Table S2. Hallmark Pathways Jointly Enriched in the Transcriptome and Proteome. Supplementary Table S3. CCLE Sample Meta-Information. Supplementary Figure S1. Schematic of the GSEA pre-processing. Supplementary Figure S2. Unsupervised hierarchical clustering of Jurkat samples after USP7 knockdown. Supplementary Figure S3. Experimental design of the total proteome profiling of the USP7 knockdown experiment. Supplementary Figure S4. Pathway enrichment analysis of genes differentially upregulated in KRAS mutated samples in NSCLC. Supplementary Figure S5. Screen shot showing the user option to upload user data in the DRPPM-Large Project Integration.
Author Contributions
Conceptualization, T.I.S. and A.-C.T.; methodology, T.I.S., A.O.; software, T.I.S., A.O., Q.H. and J.D.N.; validation, L.D.; formal analysis, T.I.S.; data curation, M.G.; writing—original draft preparation, T.I.S., A.-C.T.; writing—review and editing, T.I.S., A.-C.T., P.R., T.J.R. and M.T.; supervision, T.I.S.; funding acquisition, T.I.S. All authors have read and agreed to the published version of the manuscript.
Funding
Moffitt Cancer Center (NCI P30 CA076292) and the Moffitt Cancer Center Department of Biostatistics and Bioinformatics Pilot Projects (PI: T.S.).
Institutional Review Board Statement
Not applicable.
Informed Consent Statement
Not applicable.
Data Availability Statement
The developed software and processed data can be downloaded from the following GitHub page https://github.com/shawlab-moffitt/DRPPM-EASY-ExprAnalysisShinY (accessed on 1 February 2022).
Conflicts of Interest
The funders had no role in the design of the study; in the collection, analyses, or interpretation of data; in the writing of the manuscript, or in the decision to publish the results.
Footnotes
Publisher’s Note: MDPI stays neutral with regard to jurisdictional claims in published maps and institutional affiliations.
References
- 1.De Anda-Jauregui G., Hernandez-Lemus E. Computational Oncology in the Multi-Omics Era: State of the Art. Front. Oncol. 2020;10:423. doi: 10.3389/fonc.2020.00423. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 2.Menyhart O., Gyorffy B. Multi-omics approaches in cancer research with applications in tumor subtyping, prognosis, and diagnosis. Comput. Struct. Biotechnol. J. 2021;19:949–960. doi: 10.1016/j.csbj.2021.01.009. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 3.Chai A.W.Y., Tan A.C., Cheong S.C. Uncovering drug repurposing candidates for head and neck cancers: Insights from systematic pharmacogenomics data analysis. Sci. Rep. 2021;11:23933. doi: 10.1038/s41598-021-03418-1. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 4.Edgar R., Domrachev M., Lash A.E. Gene Expression Omnibus: NCBI gene expression and hybridization array data repository. Nucleic Acids Res. 2002;30:207–210. doi: 10.1093/nar/30.1.207. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 5.Barrett T., Wilhite S.E., Ledoux P., Evangelista C., Kim I.F., Tomashevsky M., Marshall K.A., Phillippy K.H., Sherman P.M., Holko M., et al. NCBI GEO: Archive for functional genomics data sets—Update. Nucleic Acids Res. 2013;41:D991–D995. doi: 10.1093/nar/gks1193. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 6.Wilks C., Zheng S.C., Chen F.Y., Charles R., Solomon B., Ling J.P., Imada E.L., Zhang D., Joseph L., Leek J.T., et al. Recount3: Summaries and queries for large-scale RNA-seq expression and splicing. Genome Biol. 2021;22:323. doi: 10.1186/s13059-021-02533-6. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 7.Edwards N.J., Oberti M., Thangudu R.R., Cai S., McGarvey P.B., Jacob S., Madhavan S., Ketchum K.A. The CPTAC Data Portal: A Resource for Cancer Proteomics Research. J. Proteome Res. 2015;14:2707–2713. doi: 10.1021/pr501254j. [DOI] [PubMed] [Google Scholar]
- 8.Ghandi M., Huang F.W., Jane-Valbuena J., Kryukov G.V., Lo C.C., McDonald E.R., 3rd, Barretina J., Gelfand E.T., Bielski C.M., Li H., et al. Next-generation characterization of the Cancer Cell Line Encyclopedia. Nature. 2019;569:503–508. doi: 10.1038/s41586-019-1186-3. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 9.Davis-Turak J., Courtney S.M., Hazard E.S., Glen W.B., Jr., da Silveira W.A., Wesselman T., Harbin L.P., Wolf B.J., Chung D., Hardiman G. Genomics pipelines and data integration: Challenges and opportunities in the research setting. Expert Rev. Mol. Diagn. 2017;17:225–237. doi: 10.1080/14737159.2017.1282822. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 10.Castellano-Escuder P., Gonzalez-Dominguez R., Carmona-Pontaque F., Andres-Lacueva C., Sanchez-Pla A. POMAShiny: A user-friendly web-based workflow for metabolomics and proteomics data analysis. PLoS Comput. Biol. 2021;17:e1009148. doi: 10.1371/journal.pcbi.1009148. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 11.Su W., Sun J., Shimizu K., Kadota K. TCC-GUI: A Shiny-based application for differential expression analysis of RNA-Seq count data. BMC Res. Notes. 2019;12:133. doi: 10.1186/s13104-019-4179-2. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 12.Nelson J.W., Sklenar J., Barnes A.P., Minnier J. The START App: A web-based RNAseq analysis and visualization resource. Bioinformatics. 2017;33:447–449. doi: 10.1093/bioinformatics/btw624. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 13.Reyes A.L.P., Silva T.C., Coetzee S.G., Plummer J.T., Davis B.D., Chen S., Hazelett D.J., Lawrenson K., Berman B.P., Gayther S.A., et al. GENAVi: A shiny web application for gene expression normalization, analysis and visualization. BMC Genom. 2019;20:745. doi: 10.1186/s12864-019-6073-7. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 14.Zoppi J., Guillaume J.F., Neunlist M., Chaffron S. MiBiOmics: An interactive web application for multi-omics data exploration and integration. BMC Bioinform. 2021;22:6. doi: 10.1186/s12859-020-03921-8. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 15.Vanderwall D., Suresh P., Fu Y., Cho J.H., Shaw T.I., Mishra A., High A.A., Peng J., Li Y. JUMPn: A Streamlined Application for Protein Co-Expression Clustering and Network Analysis in Proteomics. J. Vis. Exp. 2021:176. doi: 10.3791/62796. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 16.Dumas J., Gargano M.A., Dancik G.M. shinyGEO: A web-based application for analyzing gene expression omnibus datasets. Bioinformatics. 2016;32:3679–3681. doi: 10.1093/bioinformatics/btw519. [DOI] [PubMed] [Google Scholar]
- 17.Toro-Dominguez D., Martorell-Marugan J., Lopez-Dominguez R., Garcia-Moreno A., Gonzalez-Rumayor V., Alarcon-Riquelme M.E., Carmona-Saez P. ImaGEO: Integrative gene expression meta-analysis from GEO database. Bioinformatics. 2019;35:880–882. doi: 10.1093/bioinformatics/bty721. [DOI] [PubMed] [Google Scholar]
- 18.Shimada K., Bachman J.A., Muhlich J.L., Mitchison T.J. ShinyDepMap, a tool to identify targetable cancer genes and their functional connections from Cancer Dependency Map data. Elife. 2021;10:e57116. doi: 10.7554/eLife.57116. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 19.Ritchie M.E., Phipson B., Wu D., Hu Y., Law C.W., Shi W., Smyth G.K. Limma powers differential expression analyses for RNA-sequencing and microarray studies. Nucleic Acids Res. 2015;43:e47. doi: 10.1093/nar/gkv007. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 20.Hanzelmann S., Castelo R., Guinney J. GSVA: Gene set variation analysis for microarray and RNA-seq data. BMC Bioinform. 2013;14:7. doi: 10.1186/1471-2105-14-7. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 21.Shaw T.I., Dong L., Tian L., Qian C., Liu Y., Ju B., High A., Kavdia K., Pagala V.R., Shaner B., et al. Integrative network analysis reveals USP7 haploinsufficiency inhibits E-protein activity in pediatric T-lineage acute lymphoblastic leukemia (T-ALL) Sci. Rep. 2021;11:5154. doi: 10.1038/s41598-021-84647-2. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 22.Dobin A., Davis C.A., Schlesinger F., Drenkow J., Zaleski C., Jha S., Batut P., Chaisson M., Gingeras T.R. STAR: Ultrafast universal RNA-seq aligner. Bioinformatics. 2013;29:15–21. doi: 10.1093/bioinformatics/bts635. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 23.Anders S., Pyl P.T., Huber W. HTSeq—A Python framework to work with high-throughput sequencing data. Bioinformatics. 2015;31:166–169. doi: 10.1093/bioinformatics/btu638. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 24.Xu P., Duong D.M., Peng J. Systematical optimization of reverse-phase chromatography for shotgun proteomics. J. Proteome Res. 2009;8:3944–3950. doi: 10.1021/pr900251d. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 25.Pagala V.R., High A.A., Wang X., Tan H., Kodali K., Mishra A., Kavdia K., Xu Y., Wu Z., Peng J. Quantitative protein analysis by mass spectrometry. Methods Mol. Biol. 2015;1278:281–305. doi: 10.1007/978-1-4939-2425-7_17. [DOI] [PubMed] [Google Scholar]
- 26.Wang X., Li Y., Wu Z., Wang H., Tan H., Peng J. JUMP: A tag-based database search tool for peptide identification with high sensitivity and accuracy. Mol. Cell. Proteom. 2014;13:3663–3673. doi: 10.1074/mcp.O114.039586. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 27.Hao Y.H., Fountain M.D., Jr., Fon Tacer K., Xia F., Bi W., Kang S.H., Patel A., Rosenfeld J.A., Le Caignec C., Isidor B., et al. USP7 Acts as a Molecular Rheostat to Promote WASH-Dependent Endosomal Protein Recycling and Is Mutated in a Human Neurodevelopmental Disorder. Mol. Cell. 2015;59:956–969. doi: 10.1016/j.molcel.2015.07.033. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 28.Jin Q., Martinez C.A., Arcipowski K.M., Zhu Y., Gutierrez-Diaz B.T., Wang K.K., Johnson M.R., Volk A.G., Wang F., Wu J., et al. USP7 Cooperates with NOTCH1 to Drive the Oncogenic Transcriptional Program in T-Cell Leukemia. Clin. Cancer Res. 2019;25:222–239. doi: 10.1158/1078-0432.CCR-18-1740. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 29.Lamb J. The Connectivity Map: A new tool for biomedical research. Nat. Rev. Cancer. 2007;7:54–60. doi: 10.1038/nrc2044. [DOI] [PubMed] [Google Scholar]
- 30.Lamb J., Crawford E.D., Peck D., Modell J.W., Blat I.C., Wrobel M.J., Lerner J., Brunet J.P., Subramanian A., Ross K.N., et al. The Connectivity Map: Using gene-expression signatures to connect small molecules, genes, and disease. Science. 2006;313:1929–1935. doi: 10.1126/science.1132939. [DOI] [PubMed] [Google Scholar]
- 31.Bailey M.H., Tokheim C., Porta-Pardo E., Sengupta S., Bertrand D., Weerasinghe A., Colaprico A., Wendl M.C., Kim J., Reardon B., et al. Comprehensive Characterization of Cancer Driver Genes and Mutations. Cell. 2018;173:371–385. doi: 10.1016/j.cell.2018.02.060. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 32.Tsherniak A., Vazquez F., Montgomery P.G., Weir B.A., Kryukov G., Cowley G.S., Gill S., Harrington W.F., Pantel S., Krill-Burger J.M., et al. Defining a Cancer Dependency Map. Cell. 2017;170:564–576. doi: 10.1016/j.cell.2017.06.010. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 33.Adderley H., Blackhall F.H., Lindsay C.R. KRAS-mutant non-small cell lung cancer: Converging small molecules and immune checkpoint inhibition. EBioMedicine. 2019;41:711–716. doi: 10.1016/j.ebiom.2019.02.049. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 34.Wheeler J.R., Matheny T., Jain S., Abrisch R., Parker R. Distinct stages in stress granule assembly and disassembly. Elife. 2016;5:e18413. doi: 10.7554/eLife.18413. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 35.Grabocka E., Bar-Sagi D. Mutant KRAS Enhances Tumor Cell Fitness by Upregulating Stress Granules. Cell. 2016;167:1803–1813. doi: 10.1016/j.cell.2016.11.035. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 36.Sundararajan Z., Knoll R., Hombach P., Becker M., Schultze J.L., Ulas T. Shiny-Seq: Advanced guided transcriptome analysis. BMC Res. Notes. 2019;12:432. doi: 10.1186/s13104-019-4471-1. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 37.Krassowski M., Das V., Sahu S.K., Misra B.B. State of the Field in Multi-Omics Research: From Computational Needs to Data Mining and Sharing. Front. Genet. 2020;11:610798. doi: 10.3389/fgene.2020.610798. [DOI] [PMC free article] [PubMed] [Google Scholar]
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.
Supplementary Materials
Data Availability Statement
The developed software and processed data can be downloaded from the following GitHub page https://github.com/shawlab-moffitt/DRPPM-EASY-ExprAnalysisShinY (accessed on 1 February 2022).