Skip to main content
Genomics, Proteomics & Bioinformatics logoLink to Genomics, Proteomics & Bioinformatics
. 2022 Aug 29;21(2):337–348. doi: 10.1016/j.gpb.2022.08.004

TIGER: A Web Portal of Tumor Immunotherapy Gene Expression Resource

Zhihang Chen 1,#, Ziwei Luo 1,#, Di Zhang 2,#, Huiqin Li 1,#, Xuefei Liu 1,#, Kaiyu Zhu 1, Hongwan Zhang 1, Zongping Wang 3, Penghui Zhou 1,, Jian Ren 1,, An Zhao 4,5,, Zhixiang Zuo 1,
PMCID: PMC10626175  PMID: 36049666

Abstract

Immunotherapy is a promising cancer treatment method; however, only a few patients benefit from it. The development of new immunotherapy strategies and effective biomarkers of response and resistance is urgently needed. Recently, high-throughput bulk and single-cell gene expression profiling technologies have generated valuable resources. However, these resources are not well organized and systematic analysis is difficult. Here, we present TIGER, a tumor immunotherapy gene expression resource, which contains bulk transcriptome data of 1508 tumor samples with clinical immunotherapy outcomes and 11,057 tumor/normal samples without clinical immunotherapy outcomes, as well as single-cell transcriptome data of 2,116,945 immune cells from 655 samples. TIGER provides many useful modules for analyzing collected and user-provided data. Using the resource in TIGER, we identified a tumor-enriched subset of CD4+ T cells. Patients with melanoma with a higher signature score of this subset have a significantly better response and survival under immunotherapy. We believe that TIGER will be helpful in understanding anti-tumor immunity mechanisms and discovering effective biomarkers. TIGER is freely accessible at http://tiger.canceromics.org/.

Keywords: Immunotherapy, Biomarker, Gene expression, Single-cell RNA-seq, Web server

Introduction

Immunotherapy is a promising cancer treatment method that utilizes the immune defense system against cancer. Among the different types of immunotherapy techniques, immune checkpoint blockade (ICB) has revolutionized the treatment of advanced cancers. ICB has shown durable responses in patients with various cancer types [1], [2]; however, most patients with cancer cannot benefit from ICB because of the low response rates in many cancer types. Although considerable progress has been achieved, efforts are still needed to explore new immunotherapy methods and discover effective biomarkers of response and resistance.

Gene expression data have shown broad applications in identifying biomarkers to predict drug responses in cancer treatment [3], [4]. In recent years, advances in high-throughput technologies have generated large amounts of transcriptomic gene expression data from cancer samples, providing valuable resources for research related to cancer immunotherapy. Some cancer projects, such as The Cancer Genome Atlas (TCGA) [5], have generated transcriptomic gene expression data for thousands of tumor samples without the use of immunotherapy information across multiple cancer types. Although these transcriptomic gene expression data were not originally designed to study cancer immunotherapy, recent studies have reported that analyses of these data could improve our understanding of tumor–immune cell interactions, thus facilitating the identification of cancer immunotherapy response biomarkers [6], [7]. More recently, the amount of transcriptomic gene expression data with clinical information of cancer immunotherapy has grown rapidly, which enables the use of gene expression signatures to predict immunotherapy responses [8], [9]. Despite these efforts, the effectiveness of immunotherapy response biomarkers remains an open question because of the small sample size of each dataset. Recent explosively growing single-cell transcriptome studies have provided a better understanding of immune cell profiles in the tumor microenvironment (TME) before and after immunotherapy at a single-cell resolution [10], [11], [12], [13], [14], [15], [16], [17]. We hypothesized that integrative analysis of large-scale public bulk and single-cell cancer transcriptome data would be helpful for comprehensively exploring tumor–immune cell interactions and developing reliable immunotherapy response prediction biomarkers.

Currently, several web servers have been developed for the analysis of gene expression resources related to cancer immunotherapy. Tools such as CIBERSORT [18], the Cancer Imaging Archive (TCIA) [7], Tumor Immune Estimation Resource (TIMER) [19], and ImmuCellAI [20] provide useful functions for mining the immune cell infiltration in solid cancers based on TCGA or user-provided bulk gene expression data. Tumor Immune Dysfunction and Exclusion (TIDE) [21] and TISIDB [22] allow users to comprehensively evaluate biomarkers of immunotherapy response and resistance based on public bulk gene expression datasets with or without clinical immunotherapy information. Tumor Immune Single Cell Hub (TISCH) (https://tisch.comp-genomics.org) [23] and Single Cell Portal (https://singlecell.broadinstitute.org) provide interfaces for visualizing and analyzing the public single-cell RNA sequencing (scRNA-seq) datasets of human tumors. Although these tools are very useful in exploring cancer immunology, an integrative resource of cancer bulk and single-cell transcriptome data specialized for cancer immunotherapy research is still lacking. In addition, although Single Cell Portal and TISCH have implemented single-cell analysis methods such as clustering analysis, differential gene expression analysis, and cell type annotation, it lacks many additional frequently used single-cell analysis functions. For example, differential analysis between tumor and normal, gene co-expression analysis, trajectory analysis, and cell–cell communication analysis are important for understanding anti-tumor immunity, but these functions are not available in Single Cell Portal and TISCH. Therefore, we developed Tumor Immunotherapy Gene Expression Resource (TIGER; http://tiger.canceromics.org/), a web-accessible portal for the integrative analysis of bulk and single-cell cancer transcriptome data, which is dedicated to facilitating the development of new immunotherapy methods and effective biomarkers.

Web server content and methods

Data sources

Preprocessed TCGA bulk RNA sequencing (RNA-seq) data of tumor and normal samples were downloaded from the website of the UCSC Xena project (https://xena.ucsc.edu). The bulk RNA-seq and gene expression microarray data of tumor samples with clinical immunotherapy information were collected from the Gene Expression Omnibus (GEO; https://ncbi.nlm.nih.gov/geo) and Sequence Read Archive (SRA; https://ncbi.nlm.nih.gov/sra) databases by searching for keywords such as immunotherapy, programmed cell death protein 1 (PD-1) inhibitors, and cytotoxic T-lymphocyte antigen 4 (CLTA4) inhibitors. Preprocessed data were used if raw data were not available. scRNA-seq data of human tumors were collected from the GEO, Genome Sequence Archive (GSA; https://ngdc.cncb.ac.cn/gsa-human/), European Molecular Biology Laboratory’s European Bioinformatics Institute (EMBL-EBI; https://www.ebi.ac.uk), and Single Cell Portal databases by searching for keywords such as single-cell, scRNA-seq, 10x Genomics, inDrop, and Smart-seq2. The clustered regularly interspaced short palindromic repeats (CRISPR) data related to tumor immunology were collected from the GEO and SRA databases.

Analysis of scRNA-seq data

Data preprocessing

STAR was used to align the FASTQ format reads to the human reference genome (hg38 and GRCh38) [24], and then Cell Ranger was used to export the gene expression matrix. Quality control was performed for each scRNA-seq dataset using the procedure implemented in Seurat (v3.1.3) R toolkit [25]. First, cells with more than 10% mitochondrial RNA content were considered dead or dying and were removed. Cells with feature counts less than 200 or more than 3000 were also excluded. Cells expressing more than one of these three markers (CD2, CD79A, and CD68) simultaneously were defined as doublets and removed. Secondly, the filtered gene expression matrix for each sample was normalized by the “NormalizeData” function of Seurat, and the highly variable genes were retained by the “FindVariableFeatures” function. Lastly, “FindIntegrationAnchors” and “Integratedata” functions were used to integrate the gene expression matrices of all samples, in which batch effects between different samples were adjusted.

Single-cell clustering and cell type annotation

Seurat (v3.1.3) was used to cluster the cells based on single-cell expression profiles. First, “RunPCA” function in Seurat was used to perform the principal component analysis (PCA), and “FindNeighbors” function in Seurat was used to construct a K-nearest neighbor graph. Next, the most representative principal components (PCs) selected based on PCA were used for clustering analysis with “FindCluster” function in Seurat. Finally, a Uniform Manifold Approximation and Projection (UMAP) algorithm [26] was used to visualize the different clusters.

We then used classical cell markers to annotate the cell types. According to the results of differential expression analysis among cell types, cells with significantly up-regulated genes such as CD2, CD3D, and CD3E were annotated as T cells, cells with significantly up-regulated genes such as CD79A, CD19, and MS4A1 were annotated as B cells, cells with significantly up-regulated genes such as IGHA1, TNFRSF17, and SDC1 were annotated as plasma cells, cells with significantly up-regulated genes such as CD14, FCGR3A, and CD68 were annotated as myeloid cells, cells with significantly up-regulated genes such as VWF, CDH5, and FLT1 were annotated as endothelial cells, cells with significantly up-regulated genes such as DCN, COL1A1, and ACTA2 were annotated as fibroblast cells, cells with significantly up-regulated genes such as KRT18, KRT8, and EPCAM were annotated as malignant/epithelial cells, cells with significantly up-regulated genes such as MS4A2, CPA3, and TPSB2 were annotated as mast cells, and cells with significantly up-regulated genes such as NCAM1, KLRB1, and NCR3 were annotated as natural killer (NK)/natural killer T (NKT) cells. CD4 and CD8 gene expression levels were used to differentiate between CD4+ and CD8+ T cells. To get higher resolution clusters in CD4+ T cell, CD8+ T cell, B cell, and myeloid cell, the “resolution” parameter used in “FindCluster” was set from 0.5 to 0.8.

Differential expression analysis

The differential expression analysis for deriving cell type markers and differentially expressed genes between different sample groups such as tumor and normal was performed with “wilcoxauc” function in Presto [27].

Pathway/gene set analysis

Pathway/gene set enrichment analysis was performed using the Correlation Adjusted MEan RAnk gene set test (CAMERA) [28], which was implemented in the singleseqgset (version 0.1.2) R package. In brief, the log2 fold change in the mean expression level of a specific gene between the specific cell cluster and other cells was used as the test statistic. The 50 hallmark gene sets in the MSigDB database (https://www.gsea-msigdb.org/gsea/msigdb) were used for the CAMERA analysis.

Correlation analysis

Spearman’s rank or Pearson’s correlation coefficient was used to evaluate the correlation between different gene pairs in a specific cell type.

Trajectory analysis

Monocle 2 [29] was used to reconstruct the single-cell trajectories. Briefly, the “negbinomial.size” function was used to create a “CellDataSet” object from the unique molecular identifier (UMI) count matrices with default settings. The variable genes were defined using the following cutoff: dispersion_empirical > dispersion_fit, and mean expression > 0.001. Dimensional reduction was performed using the “DDRTree” method, and cell ordering was performed using the “orderCells” function.

Cell–cell communication analysis

CellPhoneDB (version 2.0.6) was used for ligand–receptor analysis to investigate potential cell–cell communication between different cell types [30]. The algorithm used by CellPhoneDB only considers receptors and ligands that are highly expressed in the test cell type and then calculates the cell type-specific likelihood of a given receptor–ligand complex with a sufficient number of arrangements. In addition, we permuted the change in cell type label for each cell 1000 times to calculate the significance of each pair. The P value of the cell–cell communication was calculated using the ratio of the mean for a particular receptor–ligand pair to the mean distribution for a random arrangement.

Analysis of bulk gene expression data

Data preprocessing

TCGA raw data were preprocessed using the UCSC Xena project. The bulk RNA-seq raw data from other sources were preprocessed using FastQC to check the quality of the sequencing reads. Samples with low sequencing quality were removed. Sequencing reads were processed using Cutadapt [31] to remove adapters and low-quality end bases. The processed reads were aligned to human reference genomes (hg38 and GRCh38) using STAR [24]. featureCounts [32] was used to derive the read counts for each gene, which were normalized to fragments per kilobase of transcript per million (FPKM) values.

Differential expression analysis

For the bulk RNA-seq and gene expression microarray data, differential expression analysis was performed using the Wilcoxon rank-sum test. The value of the interactive heatmap in the differential expression analysis of the immunotherapy response module was calculated using the following formula: -SIGN(log2FC)×log10(P), where FC represents the fold change and P represents the P value derived from the Wilcoxon rank-sum test.

Survival analysis

The association between gene expression and overall survival in the immunotherapy data was calculated using univariate Cox regression analysis. The value of the interactive heatmap in the survival analysis of the immunotherapy response module was calculated using the following formula: -SIGN(log2HR)×log10(P), where HR represents the hazard ratio and P represents the P value derived from univariate Cox regression analysis.

Correlation analysis

The correlation between the expression of gene–gene pairs was calculated using Spearman’s rank or Pearson’s correlation coefficient.

Gene set score

The average expression of all the genes in the gene set represents the gene set score.

Prediction of immunotherapy response

The gene signatures for predicting immunotherapy responses were obtained from the literature. The score of each gene signature was calculated according to the parameters used in the original study. We applied a robust rank aggregation algorithm [33] to integrate all gene signature scores in an unbiased manner. The aggregation rank score was used to predict the immunotherapy response in patients with cancer.

Web server implementations

All data in TIGER were stored and managed in MySQL tables, JSON files, Rds, and RData files. Web interfaces were implemented using PHP, HTML, JavaScript, and CSS. Statistical diagrams were generated using ECharts and Rscripts.

Results

Data summary

TIGER contains bulk transcriptome gene expression data of 1508 tumor samples of 8 cancer types with clinical immunotherapy information from 20 published studies and 11,057 tumor/normal samples of 33 cancer types without the clinical immunotherapy information of TCGA. Moreover, TIGER contains scRNA-seq data of 2,116,945 immune cells from 655 samples of 25 cancer types, including clinical immunotherapy information of 119,039 immune cells from 63 samples. In addition, we collected 31 CRISPR screening datasets from studies that identified genes responsible for the anti-tumor immune response.

Web interface and usage

TIGER integrates the collected data into four modules: single-cell immunity, immunotherapy response, response signature, and immune screening. It provides user-friendly web interfaces to access the four modules (Figure 1; Video S1).

Figure 1.

Figure 1

Overall design and construction of TIGER

TIGER aims to help researchers unearth potential mechanisms in anti-tumor immunity and discover potential biomarkers by integrating tumor immunology-related bulk transcriptome, single-cell transcriptome, and immune screening data. TIGER provides four functional analysis modules, including single-cell immunity, immunotherapy response, response signature, and immune screening, to allow users to access the resources in TIGER. TIGER, tumor immunotherapy gene expression resource; RNA-seq, RNA sequencing; scRNA-seq, single-cell RNA sequencing; AUC, area under the curve; FC, fold change; FPKM, fragments per kilobase of transcript per million.

Single-cell immunity

This module provides users with plentiful scRNA-seq data analysis functions in six tabs, including “overview”, “cell type marker”, “differential expression analysis”, “co-expression analysis”, “trajectory analysis”, and “cell–cell communication” tabs. We provided a total of 40 datasets of 18 cancer types for user selection (Figure 2A). First, users can obtain basic information regarding the selected dataset and number of immune cells of each type in the dataset (Figure 2B). Users can obtain the dataset source, cell number, cell type information, and quality control density graph in the “overview” tab. In the “cell type marker” tab, an interactive heatmap in a sub-tab showing the fold changes in gene expression between a cell cluster and other cells is presented to allow users to explore the markers and functions of each cell type (Figure 2C). In the interactive heatmap, a selection box is provided to allow users to quickly locate the main lineage cell types of interest, and a text box is provided to allow users to search for genes of interest (Figure 2C). Moreover, users can sort genes based on fold changes in the cell type of interest. By clicking on a cell in the interactive heatmap, users will obtain detailed information on the expression of the selected gene in the selected cell type. For detailed information, UMAP plots and a boxplot are available to visualize the clustering results of selected main lineage cells and the expression of selected genes in the selected main lineage cells (Figure 2C). To further help users explore the functions of each cell type, an interactive heatmap is implemented in a sub-tab to display the pathway enrichment score for each cell type. In the “differential expression analysis” tab, an interactive heatmap in a sub-tab showing the differential expression of genes in each cell type between tumor and normal or between immunotherapy responders and non-responders is presented to allow users to explore anti-tumor immunity and immunotherapy biomarkers (Figure 2D). For detailed information, UMAP plots and barplots are available to visualize the differential expression of the selected gene between different groups in the selected cell type (Figure 2D). Similarly, an interactive heatmap is implemented in a sub-tab to display the difference in pathway enrichment scores between different groups in each cell type. In the “co-expression analysis” tab, users can calculate the correlation between the expression of a gene of interest and that of other genes or calculate the expression of gene pairs in different cell types (Figure 2E). In the “trajectory analysis” tab, users can obtain the expression of genes of interest in the pseudotemporal ordering of cells inferred by Monocle 2 (Figure 2F). The “cell–cell communication” tab allows users to obtain crosstalk between different cell types inferred by receptor–ligand expression (Figure 2G).

Figure 2.

Figure 2

Web interface and usage of “single-cell immunity” module in TIGER

A. The interface for users to select the ones that they are interested in. B. Overview tab. First in the first row: dataset information. Second in the first row: density plot showing quality control. Third in the first row: UMAP plot showing the pre-analyzed clustering results of selected main lineage cells. Fourth in the first row: pie plot showing the proportion of each of main lineage cells. Fifth in the first row: heatmap showing the classical cell markers of each of the main lineage cells. Sixth in the first row: boxplot comparing the percentage of cell number of the main lineage cells between normal and tumor. C. Cell type marker tab. First in the first row: heatmap showing the expression of gene markers in each cell type. Second in the first row: UMAP plot showing the cell types of the main lineage cells (color-coded for cell types). First in the second row: UMAP plot showing the expression of the selected gene in the selected main lineage cells (color-coded for gene expression abundance). Second in the second row: boxplot showing the differential expression of the selected gene in different cell types of the selected main lineage cells. Third in the second row: gene information. D. Differential expression analysis tab. First in the first row: heatmap showing the differential expression of all genes in each cell type between tumor and normal or between response and non-response. Second in the first row: UMAP plot showing the cell types of the selected main lineage cells (color-coded for cell types). Third in the first row: UMAP plot showing the tissue types of the selected main lineage cells (color-coded for tissue types). First in the second row: UMAP plot showing the expression of the selected gene in the selected main lineage cells (color-coded for gene expression abundance). Second in the second row: barplot showing the selected cell type distribution difference between tumor and normal. Third in the second row: barplot showing the differential expression of the selected gene between tumor and normal. Fourth in the second row: gene information. E. Co-expression analysis tab. Top: table of the correlation of the selected gene and relevant gene in selected dataset. Bottom: a plot visualizing the correlation of the selected gene and relevant gene. F. Trajectory analysis tab. The trajectory analysis showing the expression of the genes of interest in the pseudotemporal ordering of cells. G. Cell–cell communication tab. UMAP, uniform manifold approximation and projection.

Immunotherapy response

This module provides many functions for the analysis of bulk transcriptome gene expression data using clinical immunotherapy information. This module consists of three tabs including “differential expression analysis”, “survival analysis”, and “gene set query”. In the “differential expression analysis” tab, users can browse the data source information and obtain an overview of the differential expression analysis results. Two interactive heatmaps displaying differentially expressed genes between responders and non-responders or between pre- and post-therapy conditions are presented to allow users to explore immunotherapy response biomarkers and resistance mechanisms (Figure 3A). By clicking a cell on the heatmap, users will obtain detailed information on the differential expression of the selected gene between responders and non-responders or between pre- and post-therapy conditions in the selected dataset. For detailed information, a boxplot is presented to visualize the differential expression (Figure 3A). In addition, users can adjust parameters, such as group, gene normalization, data scale, and clinical classification for differential expression analysis (Figure 3A). A table is displayed to allow users to compare the performance of the selected gene with that of the known immunotherapy prediction signature (Figure 3A). In the “survival analysis” tab, users can browse the data source information and obtain an overview of the survival analysis results (Figure 3B). The “survival analysis” tab presents an interactive heatmap displaying the survival analysis results to allow users to evaluate immunotherapy response biomarkers (Figure 3B). Detailed information is presented when users click on a cell in the interactive heatmap. For detailed information, a Kaplan–Meier (KM) plot is provided for visualization (Figure 3B). Moreover, users can adjust the survival analysis parameters and compare their performance with those of known signatures (Figure 3B). To allow users to evaluate their own gene signatures using our collected immunotherapy gene expression datasets, we designed the “gene set query” tab.

Figure 3.

Figure 3

Web interface and usage of “immunotherapy response”, “response signature”, and “immune screening” modules in TIGER

A. Differential expression analysis tab in the “immunotherapy response” module. First in the first row: data source information. Second in the first row: overview of differential expression analysis results. Third in the first row: heatmap showing the results of differential expression analysis between responder and non-responder or between pre-treatment and post-treatment. First in the second row: panel showing the parameter options. Second in the second row: boxplot visualizing the differential expression of the selected gene. Third in the second row: table displaying the performance of the known immunotherapy prediction signature. B. Survival analysis tab in the “immunotherapy response” module. First in the first row: data source information. Second in the first row: overview of the survival analysis results. Third in the first row: heatmap displaying the survival analysis results in all datasets. First in the second row: panel showing the parameter options. Second in the second row: KM plot visualizing the survival difference of the selected gene in the selected dataset. Third in the second row: table displaying the performance of the known immunotherapy prediction signature. C. Overview tab in the “response signature” module. Left panel showing an overview of known immunotherapy response signature. Right panel showing an overview of AUC table in 40 datasets receiving immunotherapy. D. Interface of the “response signature” module for the correlation analysis between the gene of interest and the known gene signature using the TCGA gene expression data. E. Interface of the “response signature” module for comparing the performance of user-defined biomarkers with known immunotherapy response signatures using the immunotherapy gene expression data by AUC metric. F. Interface of the “response signature” module for comparing the performance of user-defined biomarkers with known immunotherapy response signatures using the immunotherapy gene expression data by HR. KM plot visualizing the survival difference of the selected gene in the selected dataset is shown at the lower-right corner. G. Interface of the “response signature” module for predicting the immunotherapy response based on user-provided gene expression data. H. Interface of the “immune screening” module for exploring CRISPR datasets related to immunotherapy. KM, Kaplan–Meier; TCGA, The Cancer Genome Atlas; HR, hazard ratio; GEP, gene expression profile; CAF, cancer-associated fibroblast; TLS, tertiary lymphoid structure; TAM M2, tumor-associated macrophage M2; CRISPR, clustered regularly interspaced short palindromic repeats.

Response signature

The “response signature” module contains analysis functions for exploring cancer immunotherapy using known immunotherapy response signatures collected from public literature. Users can select a published signature and click on the details to determine the performance of the signature in 23 independent datasets. The area under the curve (AUC) metric was used (Figure 3C). First, users can check whether the genes of interest correlate with the known immunotherapy response signature using TCGA gene expression data without clinical immunotherapy information (Figure 3D). Second, users can compare the performance of their own biomarkers with known immunotherapy response signatures using gene expression data with clinical immunotherapy information (Figure 3E and F). Third, users can predict patient immunotherapy responses by applying published gene signatures to user-provided baseline gene expression profiles (Figure 3G).

Immune screening

The “immune screening” module presents the basic information of all immune screens in a table. This table contains “Screen ID”, “Article name”, “PMID”, “Cancer type”, “Dataset type”, “Cell line”, “Species”, “Condition”, “Analysis”, and “Size”. Users can view the specific content on the screen by selecting a screen ID. After selection, the article source of the data and specific information of the article are displayed to the user. Because the screen data are mainly analyzed using two different pipelines, different display schemes for the data from different analysis sources have been provided (Figure 3H).

Quick search

Users can quickly obtain comprehensive analytical results of the aforementioned four modules by searching for a gene of interest.

Integrative analysis using TIGER reveals an effective predictor of immunotherapy response

We next performed a systematic analysis using TIGER to show its value in facilitating research related to cancer immunotherapy. Current immunotherapy studies have mainly focused on CD8+ T cells to explore the mechanisms of immunotherapy-induced anti-tumor immunity and discover effective immunotherapy response biomarkers. Among the tumor-infiltrating T lymphocytes (TILs), apart from CD8+ T cells, it is also known that CD4+ T cells play important roles in anti-tumor immunity, e.g., the activation and growth of cytotoxic CD8+ T cells. However, the role of CD4+ T cell response to immunotherapy in TME has seldom been studied. Here, we integrated bulk and single-cell transcriptome gene expression data in TIGER to comprehensively explore the anti-tumor immunity of CD4+ T cells under immunotherapy.

To this end, we selected cancer types with at least 10,000 CD4+ T cells for pan-cancer analyses. As a result, 176,371 CD4+ T cells from 8 cancer types were used for downstream analysis. We could determine 79 cell types by separately clustering the CD4+ T cells in each cancer type, ranging from 7 to 12 cell types in each cancer type (Figure 4A). Unsupervised clustering of the 79 CD4+ T cell types revealed 10 super cell types across different cancer types (Figure 4B). Differential expression analysis revealed that SC-1 cells are effector cells, as they highly express effector markers (GZMA, IFNG, and GNLY); SC-4 cells are naïve cells, as they highly express naïve markers (TCF7 and CCR7); SC-9 cells are proliferating cells, as they highly express proliferating markers (MKI67 and STMN1); and SC-10 cells are Treg cells, as they highly express Treg markers (FOXP3 and IL2RA) (Figure 4C). SC-2, SC-9, and SC-10 cells were exhausted, as indicated by the high expression of exhaustion markers (TOX2 and TIGIT) (Figure 4C). Interestingly, in addition to SC-10 cells (Treg cells), SC-2 cells were universally found in all cancer types and were consistently enriched in tumor samples (Figure 4D). SC-2 cells are enriched and exhausted in tumors, suggesting that these cells might play a regulatory role in anti-tumor immunity. Then, a pan-cancer differential expression analysis was performed, and we found that genes such as CXCL13, ITM2A, NR3C1, SRGN, COTL1, and PDCD1 were significantly up-regulated in SC-2 cells compared with other cells in at least five cancer types, but not in SC-10 cells (Figure 4E). These genes were used as gene signatures to represent the SC-2 cells. By applying this SC-2 gene signature to TCGA dataset, we found that patients with higher SC-2 gene signature scores had a significantly higher tumor mutation burden (Figure 4F), further indicating the regulatory role of SC-2 cells in anti-tumor immunity. Interestingly, we also observed the expression of effector markers, such as IFNG in SC-2 cells (Figure 4C), indicating that SC-2 cells might function as cytotoxic T cells to directly kill tumor cells, as reported in a previous study [8]. Moreover, CXCL13 is highly expressed in the tertiary lymphoid structure (TLS) and plays a central role in its formation. TLS has been found to modulate anti-tumor immune activity and is associated with immunotherapy responses [34], [35], [36]. We hypothesized that SC-2 CD4+ cells with high CXCL13 expression might also regulate anti-tumor immunity by assisting TLS formation. Indeed, we found that the SC-2 gene signature was strongly positively correlated with the TLS gene signature in TCGA pan-cancer datasets (Pearson’s correlation = 0.803) (Figure 4G).

Figure 4.

Figure 4

Tumor-enriched CD4+ T cells revealed by pan-cancer analysis of TIGER resource

A. UMAP plots showing the cell types of CD4+ T cells derived from the clustering of scRNA-seq data of eight cancer types. B. Heatmap showing the hierarchical clustering of all the cell types of CD4+ T cells of the eight cancer types. The 10 super cell types are highlighted in black boxes. C. Heatmap showing the expression of classical immune cell markers for naïve, memory, effector, exhausted, Treg, and proliferating cells in each super cell type. D. Boxplots showing the two CD4+ cell types (SC-10 and SC-2) that are universally found in all cancer types and consistently enriched in tumor samples. *, P < 0.05; **, P < 0.01; ***, P < 0.001; ****, P < 0.0001; ns, not significant (t-test). E. Genes that are significantly up-regulated in the SC-2 CD4+ T cells in at least four cancer types (FC > 1.5, P < 0.05). F. The difference in TMB between TCGA tumor samples with low and high SC-2 gene signature scores. G. The correlation between TLS gene signature (CCL9, CCL21, CXCL13, CCR7, SELL, LAMP3, CXCL4, CD86, and BCL6) and SC-2 signature. BTCC, bladder transitional cell carcinoma; CRC, colorectal cancer; HNSCC, head-neck squamous cell carcinoma; NSCLC, non-small-cell lung carcinoma; NPC, nasopharyngeal carcinoma; UCEC, uterine corpus endometrial carcinoma; BC, breast cancer; ESCC, esophageal squamous cell carcinoma; TMB, tumor mutational burden; TLS, tertiary lymphoid structure.

Next, we explored whether SC-2 CD4+ T cells played a role in response to immunotherapy. By analyzing 16,194 CD4+ cells from scRNA-seq data of basal cell carcinoma (BCC) and immunotherapy response data, we revealed that the SC-2 CD4+ cells existed in the TME of BCC (Figure 5A and B). Differential expression analysis between pre- and post-therapy conditions in SC-2 CD4+ T cells of immunotherapy responders revealed that effector genes such as GNLY and IFITM3 were significantly up-regulated in post-therapy cells (Figure 5C). Moreover, immune activation pathways such as T cell activation and response to type I interferon were obviously enriched in SC-2 CD4+ T cells after immunotherapy (FC = 1.38) (Figure 5D). However, these genes were only slightly up-regulated in the SC-2 CD4+ T cells of non-responders after immunotherapy (FC = 1.06) (Figure 5E). These results suggest that SC-2 CD4+ T cells may play an important role in response to immunotherapy. By applying the gene signature of SC-2 CD4+ T cells to TCGA dataset, we found that the average gene signature score of cancer types was significantly associated with the objective response rate (ORR) of the corresponding cancer types (Pearson correlation = 0.66) (Figure 5F). We then applied the SC-2 gene signature to five melanoma immunotherapy datasets, including 263 samples with anti-PD1 or anti-CTLA4 therapies, and found that a higher gene signature score was not only significantly associated with better responses (Figure 5G), but was also significantly associated with better survival under immunotherapy (Figure 5H). This gene signature was superior to that of other known biomarkers, such as CD8 and PD-L1 (Figure 5I). Taken together, we discovered a subset of CD4+ T cells that can modulate anti-tumor immunity and predict immunotherapy responses by the integrative analysis of the resources in TIGER.

Figure 5.

Figure 5

A gene signature of a subset of tumor-enriched CD4+ T cells predicts immunotherapy response

A. UMAP plot showing the clustering results of CD4+ T cells of BCC. B. The expression of marker genes for SC-2 and SC-10 in the subsets of CD4+ T cells of BCC. C. Differentially expressed genes between SC-2 cells of post-therapy and pre-therapy responder samples. D. Significantly enriched pathways in post-therapy SC-2 cells. E. Differential expression of the up-regulated genes upon therapy in responders between pre-therapy and post-therapy non-responder samples. ****, P < 0.0001 (t-test). F. The correlation between immunotherapy response ORR and SC-2 score. G. The differential SC-2 gene signature score between immunotherapy (anti-PD-1 or anti-CTLA4) responders and non-responders. H. Survival difference between patients with high and low SC-2 scores. I. Response prediction performance comparison among SC-2 score, CD8 (average of CD8A and CD8B) expression, and PD-L1 (CD274) expression. BCC, basal cell carcinoma; ORR, objective response rate.

Discussion

TIGER is an interactive web-accessible portal for the integrative analysis of bulk and single-cell transcriptomic gene expression data related to cancer immunotherapy.

Compared with other existing tools, such as TCIA, TIDE, and TISCH, TIGER has several advantages. First, TIGER is the first web server to integrate bulk and single-cell gene expression data to discover anti-tumor immunity mechanisms and response biomarkers in cancer immunotherapy. Second, TIGER holds the most comprehensive transcriptomic gene expression data related to cancer immunotherapy, with non-immunotherapy bulk gene expression data for 11,057 tumor/normal samples across 33 cancer types, immunotherapy bulk gene expression data for 1508 tumor samples across 8 cancer types, and single-cell gene expression data for 2,116,945 cells of 655 samples across 25 cancer types. Third, TIGER contains more analysis and visualization functions for both bulk and single-cell gene expression analyses than the other tools. In particular, differential analysis between tumor and normal cells and between different cell types using scRNA-seq data allows users to explore anti-tumor immunity and develop gene signatures of specific cell types. The analysis of immunotherapy gene expression data, together with public gene signatures, allows users to comprehensively evaluate biomarkers of immunotherapy responses.

In conclusion, the analysis of bulk and single-cell data in the same platform specialized for cancer immunotherapy research will facilitate users to gain more insights into cancer immunotherapy. In the future, we will continually update the TIGER database by integrating new bulk and single-cell gene expression data. We plan to add T cell receptor (TCR) and B cell receptor (BCR) sequencing data to TIGER to further facilitate the understanding of tumor immunology. Continuous efforts will be made to implement new analytical and visualization functions to improve the performance of TIGER.

Data availability

TIGER is freely accessible at http://tiger.canceromics.org/.

Competing interests

The authors have declared no competing interests.

CRediT authorship contribution statement

Zhihang Chen: Formal analysis, Investigation, Data curation. Ziwei Luo: Investigation, Visualization. Di Zhang: Data curation. Huiqin Li: Software. Xuefei Liu: Formal analysis, Investigation, Data curation, Writing – original draft. Kaiyu Zhu: Software, Formal analysis, Investigation. Hongwan Zhang: Data curation. Zongping Wang: Data curation. Penghui Zhou: Conceptualization, Writing – review & editing. Jian Ren: Conceptualization, Writing – review & editing. An Zhao: Conceptualization, Writing – review & editing. Zhixiang Zuo: Conceptualization, Supervision, Writing – review & editing. All authors have read and approved the final manuscript.

Acknowledgments

This work was supported by grants from the National Natural Science Foundation of China (Grant No. 81772614), the National Key R&D Program of China (Grant No. 2017YFA0106700), the Program for Guangdong Introducing Innovative and Entrepreneurial Teams (Grant No. 2017ZT07S096), the Zhejiang Qianjiang Talent Project (Grant No. QJD1602025), and the Guangdong Basic and Applied Basic Research Foundation (Grant No. 2021B1515020108), China.

Handled by Song Liu

Footnotes

Peer review under responsibility of Beijing Institute of Genomics, Chinese Academy of Sciences / China National Center for Bioinformation and Genetics Society of China.

Supplementary data to this article can be found online at https://doi.org/10.1016/j.gpb.2022.08.004.

Contributor Information

Penghui Zhou, Email: zhouph@sysucc.org.cn.

Jian Ren, Email: renjian@sysucc.org.cn.

An Zhao, Email: zhaoan@zjcc.org.cn.

Zhixiang Zuo, Email: zuozhx@sysucc.org.cn.

Supplementary material

The following are the Supplementary material to this article:

Video S1

Instructional video for TIGER This video introduces the usage of TIGER in detail. TIGER, tumor immunotherapy gene expression resource.

Download video file (7.1MB, mp4)

References

  • 1.Wolchok J.D., Chiarion-Sileni V., Gonzalez R., Grob J.J., Rutkowski P., Lao C.D., et al. Long-term outcomes with nivolumab plus ipilimumab or nivolumab alone versus ipilimumab in patients with advanced melanoma. J Clin Oncol. 2022;40:127–137. doi: 10.1200/JCO.21.02229. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 2.Pujol J.L. Durvalumab induces sustained survival benefit after concurrent chemoradiotherapy in stage III non-small-cell lung cancer. J Clin Oncol. 2022;40:1271–1274. doi: 10.1200/JCO.22.00204. [DOI] [PubMed] [Google Scholar]
  • 3.van’t Veer L.J., Dai H., van de Vijver M.J., He Y.D., Hart A.A.M., Mao M., et al. Gene expression profiling predicts clinical outcome of breast cancer. Nature. 2002;415:530–536. doi: 10.1038/415530a. [DOI] [PubMed] [Google Scholar]
  • 4.Geeleher P., Cox N.J., Huang R.S. Clinical drug response can be predicted using baseline gene expression levels and in vitro drug sensitivity in cell lines. Genome Biol. 2014;15:R47. doi: 10.1186/gb-2014-15-3-r47. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 5.The Cancer Genome Atlas Research Network, Weinstein J.N., Collisson E.A., Mills G.B., Shaw K.R.M., Ozenberger B.A., et al. The Cancer Genome Atlas Pan-Cancer analysis project. Nat Genet. 2013;45:1113–1120. doi: 10.1038/ng.2764. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 6.Jiang P., Gu S., Pan D., Fu J., Sahu A., Hu X., et al. Signatures of T cell dysfunction and exclusion predict cancer immunotherapy response. Nat Med. 2018;24:1550–1558. doi: 10.1038/s41591-018-0136-1. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 7.Charoentong P., Finotello F., Angelova M., Mayer C., Efremova M., Rieder D., et al. Pan-cancer immunogenomic analyses reveal genotype-immunophenotype relationships and predictors of response to checkpoint blockade. Cell Rep. 2017;18:248–262. doi: 10.1016/j.celrep.2016.12.019. [DOI] [PubMed] [Google Scholar]
  • 8.Ayers M., Lunceford J., Nebozhyn M., Murphy E., Loboda A., Kaufman D.R., et al. IFN-γ-related mRNA profile predicts clinical response to PD-1 blockade. J Clin Invest. 2017;127:2930–2940. doi: 10.1172/JCI91190. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 9.Auslander N., Zhang G., Lee J.S., Frederick D.T., Miao B., Moll T., et al. Robust prediction of response to immune checkpoint blockade therapy in metastatic melanoma. Nat Med. 2018;24:1545–1549. doi: 10.1038/s41591-018-0157-9. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 10.Oh D.Y., Kwek S.S., Raju S.S., Li T., McCarthy E., Chow E., et al. Intratumoral CD4+ T cells mediate anti-tumor cytotoxicity in human bladder cancer. Cell. 2020;181:1612–1625. doi: 10.1016/j.cell.2020.05.017. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 11.Jerby-Arnon L., Shah P., Cuoco M.S., Rodman C., Su M.J., Melms J.C., et al. A cancer cell program promotes T cell exclusion and resistance to checkpoint blockade. Cell. 2018;175:984–997. doi: 10.1016/j.cell.2018.09.006. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 12.Xiong D., Wang Y., You M. A gene expression signature of TREM2hi macrophages and γδ T cells predicts immunotherapy response. Nat Commun. 2020;11:5084. doi: 10.1038/s41467-020-18546-x. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 13.Yost K.E., Satpathy A.T., Wells D.K., Qi Y., Wang C., Kageyama R., et al. Clonal replacement of tumor-specific T cells following PD-1 blockade. Nat Med. 2019;25:1251–1259. doi: 10.1038/s41591-019-0522-3. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 14.Sade-Feldman M., Yizhak K., Bjorgaard S.L., Ray J.P., de Boer C.G., Jenkins R.W., et al. Defining T cell states associated with response to checkpoint immunotherapy in melanoma. Cell. 2019;176:404. doi: 10.1016/j.cell.2018.12.034. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 15.Zhang Q., He Y., Luo N., Patel S.J., Han Y., Gao R., et al. Landscape and dynamics of single immune cells in hepatocellular carcinoma. Cell. 2019;179:829–845. doi: 10.1016/j.cell.2019.10.003. [DOI] [PubMed] [Google Scholar]
  • 16.Zheng C., Zheng L., Yoo J.K., Guo H., Zhang Y., Guo X., et al. Landscape of infiltrating T cells in liver cancer revealed by single-cell sequencing. Cell. 2017;169:1342–1356. doi: 10.1016/j.cell.2017.05.035. [DOI] [PubMed] [Google Scholar]
  • 17.Ma K.Y., Schonnesen A.A., Brock A., Van Den Berg C., Eckhardt S.G., Liu Z., et al. Single-cell RNA sequencing of lung adenocarcinoma reveals heterogeneity of immune response-related genes. JCI Insight. 2019;4:e121387. doi: 10.1172/jci.insight.121387. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 18.Newman A.M., Liu C.L., Green M.R., Gentles A.J., Feng W., Xu Y., et al. Robust enumeration of cell subsets from tissue expression profiles. Nat Methods. 2015;12:453–457. doi: 10.1038/nmeth.3337. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 19.Li T., Fu J., Zeng Z., Cohen D., Li J., Chen Q., et al. TIMER2.0 for analysis of tumor-infiltrating immune cells. Nucleic Acids Res. 2020;48:W509–W514. doi: 10.1093/nar/gkaa407. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 20.Miao Y.R., Zhang Q., Lei Q., Luo M., Xie G.Y., Wang H., et al. ImmuCellAI: a unique method for comprehensive T-cell subsets abundance prediction and its application in cancer immunotherapy. Adv Sci (Weinh) 2020;7:1902880. doi: 10.1002/advs.201902880. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 21.Fu J., Li K., Zhang W., Wan C., Zhang J., Jiang P., et al. Large-scale public data reuse to model immunotherapy response and resistance. Genome Med. 2020;12:21. doi: 10.1186/s13073-020-0721-z. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 22.Ru B., Wong C.N., Tong Y., Zhong J.Y., Zhong S.S.W., Wu W.C., et al. TISIDB: an integrated repository portal for tumor-immune system interactions. Bioinformatics. 2019;35:4200–4202. doi: 10.1093/bioinformatics/btz210. [DOI] [PubMed] [Google Scholar]
  • 23.Sun D., Wang J., Han Y., Dong X., Ge J., Zheng R., et al. TISCH: a comprehensive web resource enabling interactive single-cell transcriptome visualization of tumor microenvironment. Nucleic Acids Res. 2021;49:D1420–D1430. doi: 10.1093/nar/gkaa1020. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 24.Dobin A., Davis C.A., Schlesinger F., Drenkow J., Zaleski C., Jha S., et al. STAR: ultrafast universal RNA-seq aligner. Bioinformatics. 2013;29:15–21. doi: 10.1093/bioinformatics/bts635. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 25.Stuart T., Butler A., Hoffman P., Hafemeister C., Papalexi E., Mauck W.M., 3rd, et al. Comprehensive integration of single-cell data. Cell. 2019;177:1888–1902. doi: 10.1016/j.cell.2019.05.031. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 26.Becht E., McInnes L., Healy J., Dutertre CA, Kwok I.W.H., Ng L.G., et al. Dimensionality reduction for visualizing single-cell data using UMAP. Nat Biotechnol. 2019;37:38–44. doi: 10.1038/nbt.4314. [DOI] [PubMed] [Google Scholar]
  • 27.Korsunsky I., Nathan A., Millard N., Raychaudhuri S. Presto scales Wilcoxon and auROC analyses to millions of observations. bioRxiv. 2019 [Google Scholar]
  • 28.Wu D., Smyth G.K. Camera: a competitive gene set test accounting for inter-gene correlation. Nucleic Acids Res. 2012;40:e133. doi: 10.1093/nar/gks461. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 29.Qiu X., Mao Q., Tang Y., Wang L., Chawla R., Pliner H.A., et al. Reversed graph embedding resolves complex single-cell trajectories. Nat Methods. 2017;14:979–982. doi: 10.1038/nmeth.4402. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 30.Efremova M., Vento-Tormo M., Teichmann S.A., Vento-Tormo R. Cell PhoneDB: inferring cell–cell communication from combined expression of multi-subunit ligand–receptor complexes. Nat Protoc. 2020;15:1484–1506. doi: 10.1038/s41596-020-0292-x. [DOI] [PubMed] [Google Scholar]
  • 31.Martin M. Cutadapt removes adapter sequences from high-throughput sequencing reads. EMBnet J. 2011;17:10–12. [Google Scholar]
  • 32.Liao Y., Smyth G.K., Shi W. featureCounts: an efficient general purpose program for assigning sequence reads to genomic features. Bioinformatics. 2014;30:923–930. doi: 10.1093/bioinformatics/btt656. [DOI] [PubMed] [Google Scholar]
  • 33.Kolde R., Laur S., Adler P., Vilo J. Robust rank aggregation for gene list integration and meta-analysis. Bioinformatics. 2012;28:573–580. doi: 10.1093/bioinformatics/btr709. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 34.Helmink B.A., Reddy S.M., Gao J., Zhang S., Basar R., Thakur R., et al. B cells and tertiary lymphoid structures promote immunotherapy response. Nature. 2020;577:549–555. doi: 10.1038/s41586-019-1922-8. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 35.Petitprez F., de Reyniès A., Keung E.Z., Chen T.W.W., Sun C.M., Calderaro J., et al. B cells are associated with survival and immunotherapy response in sarcoma. Nature. 2020;577:556–560. doi: 10.1038/s41586-019-1906-8. [DOI] [PubMed] [Google Scholar]
  • 36.Cabrita R., Lauss M., Sanna A., Donia M., Larsen M.S., Mitra S., et al. Tertiary lymphoid structures improve immunotherapy and survival in melanoma. Nature. 2020;577:561–565. doi: 10.1038/s41586-019-1914-8. [DOI] [PubMed] [Google Scholar]

Associated Data

This section collects any data citations, data availability statements, or supplementary materials included in this article.

Supplementary Materials

Video S1

Instructional video for TIGER This video introduces the usage of TIGER in detail. TIGER, tumor immunotherapy gene expression resource.

Download video file (7.1MB, mp4)

Data Availability Statement

TIGER is freely accessible at http://tiger.canceromics.org/.


Articles from Genomics, Proteomics & Bioinformatics are provided here courtesy of Oxford University Press

RESOURCES