Request A Project Quote
Request A Project Quote

Overview of Single-Cell RNA Sequencing: Applications, Data Analysis, and Advantages

Single-cell RNA sequencing(scRNA-seq) is a technique for sequencing the RNA of a single cell and has rapidly developed in recent years. It has advantages in identifying cells at the molecular level and interpreting cellular heterogeneity, and it is now widely applied in medical and biological research.

Brief history of scRNA-seq development

Early in the 1990s, real-time fluorescence quantitative polymerase chain reaction (PCR) technology for a small number of genes in a single cell appeared [1]. The real scRNA-seq was proposed in 2009 by Tang et al, which sequenced the transcriptome of a small number of mouse primordial germ cells[2]. Since then, a multitude of scRNA-seq technologies have been developed, including STRT-seq[3], CEL-seq[4], SMART-seq[5], and subsequent nanodroplets, picowell technologies and in situ barcoding technologies for high-throughput sequencing. Before 2014, most scRNA-seq platforms were limited to analyzing fewer than 100 cells, and the sequencing cost was high. The emergence of subsequent technologies, such as Drop-Seq[6] and inDrop[7] have enabled high-throughput sequencing. In 2017, the emergence of two commercial high-throughput scRNA-seq platforms, 10X Genomics and BD Rhapsody have made scRNA-seq more widely used, which are still the most widely used platforms today. Since then, scRNA-seq technologies such as Microwell-seq[8] and DNBelab C4[9] have further reduced sequencing costs and increased cell throughput. I divided different technologies into two categories, namely, tag sequencing technology and full-length sequencing technology. Due to the iteration of technologies, sequencing methods proposed at different stages must have their advantages and limitations (Fig.1).

Timeline showcasing the evolution of single-cell transcriptome technologiesFig.1 Development timeline of single-cell transcriptome technologies[10]

Differences Between scRNA-seq and Bulk RNA-seq

Both scRNA-seq and Bulk RNA-seq sequence the transcriptome of a sample and share upstream processes such as RNA extraction, reverse transcription to cDNA, and library preparation for sequencing[11]. Their fundamental difference lies in the sample: scRNA-seq treats each individual cell as a separate sample, whereas Bulk RNA-seq uses a group of cells as one sample. To achieve single-cell isolation and transcriptome library preparation, scRNA-seq requires more advanced instruments, and it generates a significantly larger volume of data, making it more expensive. Due to its high-resolution data, scRNA-seq can detect rare cell types that Bulk RNA-seq might overlook, making it particularly advantageous in studies involving complex cell types, such as the tumor microenvironment (TME) (Fig.2). Each technique has its strengths, and the appropriate method should be chosen based on the specific research question.

Comparison of scRNA-seq and bulk RNA-seq methods for analyzing the tumor microenvironment (TME)Fig.2 scRNA-seq versus bulk RNA-seq for profiling the TME[12].

Data Analysis of scRNA-seq

Accurate and effective analyzing of scRNA-seq data is crucial for scientific research. Therefore, scRNA-seq data analysis methods are continuously being developed and refined. Here, we will outline the typical steps in single-cell data analysis (Fig.3).

Diagram illustrating a typical workflow for single-cell RNA sequencing (scRNA-seq) analysisFig.3 Schematic of a typical single-cell RNA-seq analysis workflow[13].

Quality Control and Preprocessing of scRNA-seq Data

After obtaining scRNA-seq data, the first task is to perform quality control. This step includes assessing the quality of the sequencing reads, filtering out low-quality cells, and removing ambient RNA contamination. Quality control tools designed for bulk RNA-seq data, such as Trimmomatic[14], Fastp[15], and Cutadapt[16], are also suitable for preprocessing scRNA-seq raw data. Typically, when processing scRNA-seq data downloaded from the web, I use TrimGalore, a tool that integrates Cutadapt and FastQC (https://github.com/FelixKrueger/TrimGalore). FastQC is another tool published on GitHub that can assess the quality of sequencing reads (https://github.com/s-andrews/FastQC).In the specific analysis process, I will use FastQC to first assess whether the raw sequencing data requires further quality control. If the assessment shows anomalies such as the presence of adapters, low-quality reads, or an excessive number of duplicated fragments, I then use TrimGalore for data cleaning. After quality control of the reads, the next step involves aligning the sequencing reads to the reference genome and generating a quantitative data matrix. For this process, I use integrated alignment and quantification tools such as CellRanger, developed by 10X Genomics[17]. It provides a comprehensive solution for generating single-cell transcriptome data matrices from raw sequencing data, offering a reliable data processing method for single-cell research.

After obtaining the data matrix, we typically need to identify doublets and empty cells. Abnormally high numbers of reads and genes may indicate the presence of doublets. I often use doublet detection tools such as DoubletDecon[18] and DoubletFinder[19] to exclude doublets. Additionally, a high proportion of mitochondrial genes and a low number of genes usually suggest poor cell quality. Ambient RNA contamination refers to RNA present in the single-cell suspension that is detected along with the cell's internal RNA during droplet formation, even though it is not actually present in the cell. To remove this contamination, I use DecontX[20] to quickly predict and correct for ambient RNA contamination, and then proceed with downstream analysis using the corrected data matrix.

Normalization is the first step in scRNA-seq matrix data processing and directly impacts the accuracy of downstream analysis results. A commonly used normalization method assumes that each cell has the same initial number of transcripts and simply normalizes the data to counts per million (CPM). Log normalization of unique molecular identifiers (UMI) based data, as implemented in Seurat, is one of the most widely used methods [21]. Other methods, such as sctransform[22], BayNorm[23], and SCnorm[24], can also be used to normalize scRNA-seq data. For full-length sequencing methods like SMART-seq, transcript length is usually taken into account during data processing.

Integrating Transcriptome Sequencing Data from Different Batches

Currently, scRNA-seq data has become highly abundant, and effectively integrating data from different batches has become a new challenge. Batch effects imply technical differences that arise when samples come from different batches, which may result from factors such as different time points, different operators, varying scRNA-seq protocols, or inconsistencies in the sequencing samples. Therefore, several methods have been developed specifically to eliminate batch effects in scRNA-seq data. Commonly used data integration methods include Seurat[21], MNN[25], Harmony[26], and Conos[27]. I most frequently use the CCA algorithm included in Seurat and Harmony. Harmony eliminates batch effects while preserving the biological differences between the two samples, whereas CCA applies a stronger correction, which may potentially erase biological differences between the samples.

Cell Type Identification and Annotation

In single-cell data analysis, the accurate identification and annotation of cell types is a critical step for all downstream analyses. This process includes steps such as feature selection, dimensionality reduction, clustering, and annotation. The first step in dimensionality reduction for scRNA-seq data is feature selection, where the dataset is filtered to retain only the genes that contribute significantly to the data's variability. These retained genes are known as highly variable genes[28] (HVGs).The number of HVGs typically ranges from 1,000 to 5,000 and needs to be adjusted based on the complexity of the dataset. After selecting the HVGs, the dimensionality of the scRNA-seq expression matrix needs to be further reduced, describing the data with far fewer dimensions than the number of genes, usually in two or three dimensions. Common dimensionality reduction methods now include both linear and nonlinear approaches, with Principal Component Analysis[29] (PCA) being the most popular linear method. PCA analysis is typically used as a preprocessing step for nonlinear dimensionality reduction, and the number of principal components (PCs) selected for the next step can affect the interpretation of subsequent results. Nonlinear dimensionality reduction methods allow for the visualization of data in two or three dimensions. The most commonly used methods include t-distributed stochastic neighbor embedding[30] (t-SNE) and uniform manifold approximation and projection[31] (UMAP).The purpose of cell clustering is to group cells based on the similarity of their gene expression patterns, in order to obtain biologically meaningful subpopulations. Clustering based directly on matrix distances is an unsupervised machine learning process, with k-means clustering being a widely used method[25]. Accurate annotation of the clusters obtained from clustering is a key step in scRNA-seq data analysis. Currently, this process is typically achieved through both manual annotation and automatic annotation methods. Manual annotation involves matching the characteristic genes of each cluster with published literature and databases, then assigning biologically meaningful cell identities to the clusters. For example, the table below summarizes some hallmark genes for various cell types (Table 1).

Annotation Gene signature Refs
Naive T cells CD45RA, IL7R, CD27, CCR7, CXCR5 [32]
Cytotoxic T GZMA ,NKG7 ,GZMB ,GZMK ,FASLG,ITGA1 ,CXCR6 [33]
Proliferation T RRM2 ,TK1 ,CENPF ,CENPM ,MKI67 ,MCM4 [34]
Early-stage T CCR7, IL7R , TCF7 ,CD28 [35]
Central memory cells CCR7, SELL, GPR183, GZMK [36]
CCR7 ,IL7R , SELL ,TCF7 [37]
Exhausted T CTLA4 ,LAG3 ,HAVCR2 ,TRPS1, PDCD1, FABP5, TRPS1, CREM, CEBPD [35]

Table.1 Hallmark Genes for Common T Cell Types

Common Applications of Downstream Data Analysis in Single-Cell Research

Multi-faceted interpretation of annotated cells is part of the downstream analysis of scRNA-seq data. Common analyses include changes in cell composition, differential analysis at the gene level, trajectory inference, and analysis of cell-to-cell communication.

Changes in cell composition refer to the variation in the proportions of various cell types between different groups (e.g., control and experimental groups). For example, there may be an increase in the proportion of neutrophil progenitor cells in the bone marrow of tumor-bearing wild-type mice[38]. Typically, visualizations such as bar charts, area plots, or pie charts are used to present the changes in cell proportions between different groups.

Differential analysis at the gene level encompasses several aspects, including the calculation of differentially expressed genes between groups, gene set enrichment analysis, and inference of transcription factor regulatory networks. Through these analyses, gene expression differences under varying contexts can be characterized, revealing changes at the gene level. To better interpret the biological significance of these genes, researchers them based on common biological processes. These gene sets typically come from databases such as MSigDB[39] and Gene Ontology[40], as well as pathway databases like KEGG[41] and Reactome[42]. Gene function is not carried out independently; transcription factors play a crucial role in the regulation of gene expression. By using transcription factor regulatory network analysis, interactions between transcription factors and other genes can be revealed. Currently, there are specialized tools for this analysis based on scRNA-seq, such as SCENIC[43].

To characterize the continuous changes between cells, dynamic models of gene expression need to be constructed, and these methods are referred to as trajectory inference (TI). TI arranges cells based on transcriptional changes, and this pathway is considered as pseudotime in cell development[44]. Since the creation of Monocle[45] for TI, various algorithms have been rapidly developed.

Cell-to-cell communication refers to interactions mediated by receptor-ligand or other auxiliary factors, which are crucial for biological processes such as cell development and disease progression. Predicting cell communication requires the scRNA-seq expression matrix and known receptor-ligand pairing relationships. Currently, commonly used tools for this purpose include CellphoneDB[46], CellChat[47], and NicheNet[48].

Applications of scRNA-seq

The applications of scRNA-seq are extensive, covering multiple fields of biology and medicine. Here, I summarize its applications in oncology, immunology, developmental biology, and neuroscience.

Applications of scRNA-seq in Oncology

scRNA-seq has been widely used in human tumor research, including studies on tumor heterogeneity, TME, and cell interactions. Tumor heterogeneity encompasses differences between tumors as well as variations within a single tumor. Accurately identifying tumor heterogeneity plays a crucial role in the diagnosis and treatment of diseases[49]. Durante et al. discovered previously unrecognized sub-clonal genomic complexity and transcriptional states in melanoma[50]. TME is a complex ecosystem composed of cancer cells, various non-malignant cells, extracellular matrix, secreted factors, and tumor vasculature. Zheng et al. revealed that exhausted T and NK cells, Treg cells, selectively activated macrophages, and tolerogenic dendritic cells dominate the TME in esophageal cancer[51]. The crosstalk between macrophages and Tregs contributes to potential immune suppression within the TME. Cell-to-cell interactions primarily focus on the interactions between malignant cells and the TME or cells originating from the TME. Wei Zhuo et al. discovered a mechanism in which Cadherin 11-mediated signaling between gastric cancer cells and fibroblasts promotes gastric cancer metastasis[52].

Applications of scRNA-seq in Immunology

scRNA-seq can be used to comprehensively analyze different cell types in the immune system, revealing functional differences among various immune cells in health and disease states. Among all immune cells, scRNA-seq studies on T cells are the most numerous, as disease is often associated with changes in T cell status. By conventional methods, classical T cell subsets have been identified, including naive, memory, and effector T cells. However, scRNA-seq of these classical subsets has revealed new findings of exhausted[53], cytotoxic, and immunosuppressive T cells[54]. In addition to identifying new cell types, scRNA-seq can also analyze the impact of diseases on immune cells and help understand disease mechanisms. For example, myeloid-derived suppressor cells, which differentiate from Granulocyte-Monocyte Progenitors, accumulate in large numbers within the TME[55]. These cells infiltrate tumors and directly promote angiogenesis and metastasis, while also suppressing immune responses and reducing the effectiveness of immunotherapy.

Applications of scRNA-seq in Developmental Biology

scRNA-seq can capture the gene expression profiles of cells at different stages of development, helping to construct developmental trajectories from stem cells to specialized cells and revealing gene regulatory networks during the developmental process. Lars M. Steinmetz et al. conducted a single-cell analysis of human bone marrow hematopoietic stem and progenitor cells (HSPCs), showing that the acquisition of lineage-specific fates is a continuous process[56]. During embryonic development, scRNA-seq can be used to trace cell fates and study how different tissues and organs gradually form during early development. The team at the Sanger Institute utilized scRNA-seq of thymic tissue during the embryonic stage to reveal the development of the human thymus and the maturation process of T cells. Their research found that the corresponding changes in thymic stromal cells reflect trends in T cell development[57].

Applications of scRNA-seq in Neuroscience

The brain contains various types of neurons, each differing in morphology, function, and gene expression. scRNA-seq can identify and classify these neurons, revealing their distinct gene expression patterns[58]. In addition to neurons, the brain also contains a large number of glial cells (such as astrocytes, oligodendrocytes, and microglia). scRNA-seq can reveal the gene expression characteristics of these non-neuronal cells, helping to understand their roles in neural support, protection, and repair. Elizabeth et al. conducted an analysis of human cortical samples based on single-cell RNA sequencing and purified viable microglial cell subpopulations from these samples, discovering that some cell subpopulations were enriched with genes and RNA markers associated with neurodegenerative diseases[59].

Summary and Outlook

In 2013, scRNA-seq was named Technology of the Year by Nature Methods[60], and in 2018, Science named scRNA-seq Breakthrough technology of the Year[61], whose rapid development has greatly broadened our understanding of cell heterogeneity and cell function. The rapid development of this technology has greatly expanded our understanding of cell heterogeneity and function. The instruments for single-cell sequencing are continuously being iterated and upgraded, while the development of data processing tools is also progressing rapidly, facilitating the widespread application of this technology in biology and medicine. scRNA-seq is evolving towards lower costs, higher throughput, and multi-omics capabilities, and it is expected to see even broader use in the fields of biology and pharmaceuticals in the future.

References:

  1. EBERWINE J, YEH H, MIYASHIRO K, et al. Analysis of gene expression in single live neurons. Proc Natl Acad Sci U S A, 1992, 89(7): 3010-4.
  2. TANG F, BARBACIORU C, WANG Y, et al. mRNA-Seq whole-transcriptome analysis of a single cell. Nat Methods, 2009, 6(5): 377-82.
  3. ISLAM S, KJALLQUIST U, MOLINER A, et al. Characterization of the single-cell transcriptional landscape by highly multiplex RNA-seq . Genome Res, 2011, 21(7): 1160-7.
  4. HASHIMSHONY T, WAGNER F, SHER N, et al. CEL-Seq: single-cell RNA-Seq by multiplexed linear amplification . Cell Rep, 2012, 2(3): 666-73.
  5. RAMSKOLD D, LUO S, WANG Y C, et al. Full-length mRNA-Seq from single-cell levels of RNA and individual circulating tumor cells. Nat Biotechnol, 2012, 30(8): 777-82.
  6. MACOSKO E Z, BASU A, SATIJA R, et al. Highly Parallel Genome-wide Expression Profiling of Individual Cells Using Nanoliter Droplets . Cell, 2015, 161(5): 1202-14.
  7. KLEIN A M, MAZUTIS L, AKARTUNA I, et al. Droplet barcoding for single-cell transcriptomics applied to embryonic stem cells. Cell, 2015, 161(5): 1187-201.
  8. HAN X, WANG R, ZHOU Y, et al. Mapping the Mouse Cell Atlas by Microwell-Seq. Cell, 2018, 173(5): 1307.
  9. LIU C, WU T, FAN F, et al. A portable and cost-effective microfluidic system for massively parallel single-cell transcriptome profiling. bioRxiv, 2019: 818450.
  10. ZHANG Y W, HUANG Y J, HU L P, et al. New insights into Human Hematopoietic Stem and Progenitor Cells via Single-Cell Omics. Stem Cell Rev Rep, 2022, 18(4): 1322-36.
  11. ZIEGENHAIN C, VIETH B, PAREKH S, et al. Comparative Analysis of Single-Cell RNA Sequencing Methods. Mol Cell, 2017, 65(4): 631-43 e4.
  12. GURUPRASAD P, LEE Y G, KIM K H, et al. The current landscape of single-cell transcriptomics for cancer immunotherapy. J Exp Med, 2021, 218(1).
  13. LUECKEN M D, THEIS F J. Current best practices in single-cell RNA-seq analysis: a tutorial. Mol Syst Biol, 2019, 15(6): e8746.
  14. BOLGER A M, LOHSE M, USADEL B. Trimmomatic: a flexible trimmer for Illumina sequence data . Bioinformatics, 2014, 30(15): 2114-20.
  15. CHEN S, ZHOU Y, CHEN Y, et al. fastp: an ultra-fast all-in-one FASTQ preprocessor. Bioinformatics, 2018, 34(17): i884-i90.
  16. MARTIN M. Cutadapt removes adapter sequences from high-throughput sequencing reads. EMBnetjournal, 2011, 17: 10-2.
  17. ZHENG G X, TERRY J M, BELGRADER P, et al. Massively parallel digital transcriptional profiling of single cells. Nat Commun, 2017, 8: 14049.
  18. DEPASQUALE E A K, SCHNELL D J, VAN CAMP P J, et al. DoubletDecon: Deconvoluting Doublets from Single-Cell RNA-Sequencing Data. Cell Rep, 2019, 29(6): 1718-27 e8.
  19. MCGINNIS C S, MURROW L M, GARTNER Z J. DoubletFinder: Doublet Detection in Single-Cell RNA Sequencing Data Using Artificial Nearest Neighbors. Cell Syst, 2019, 8(4): 329-37 e4.
  20. YANG S, CORBETT S E, KOGA Y, et al. Decontamination of ambient RNA in single-cell RNA-seq with DecontX. Genome Biol, 2020, 21(1): 57.
  21. BUTLER A, HOFFMAN P, SMIBERT P, et al. Integrating single-cell transcriptomic data across different conditions, technologies, and species . Nat Biotechnol, 2018, 36(5): 411-20.
  22. HAFEMEISTER C, SATIJA R. Normalization and variance stabilization of single-cell RNA-seq data using regularized negative binomial regression . Genome Biol, 2019, 20(1): 296.
  23. TANG W, BERTAUX F, THOMAS P, et al. bayNorm: Bayesian gene expression recovery, imputation and normalization for single-cell RNA-sequencing data . Bioinformatics, 2020, 36(4): 1174-81.
  24. BACHER R, CHU L F, LENG N, et al. SCnorm: robust normalization of single-cell RNA-seq data . Nat Methods, 2017, 14(6): 584-6.
  25. HAGHVERDI L, LUN A T L, MORGAN M D, et al. Batch effects in single-cell RNA-sequencing data are corrected by matching mutual nearest neighbors. Nat Biotechnol, 2018, 36(5): 421-7.
  26. KORSUNSKY I, MILLARD N, FAN J, et al. Fast, sensitive and accurate integration of single-cell data with Harmony. Nat Methods, 2019, 16(12): 1289-96.
  27. BARKAS N, PETUKHOV V, NIKOLAEVA D, et al. Joint analysis of heterogeneous single-cell RNA-seq dataset collections . Nat Methods, 2019, 16(8): 695-8.
  28. BRENNECKE P, ANDERS S, KIM J K, et al. Accounting for technical noise in single-cell RNA-seq experiments . Nature Methods, 2013, 10(11): 1093-5.
  29. PEARSON K. On lines and planes of closest fit to systems of points in space. Philos Mag, 1901, 2(7-12): 559-72.
  30. VAN DER MAATEN L, HINTON G. Visualizing Data using t-SNE. J Mach Learn Res, 2008, 9: 2579-605.
  31. LELAND MCINNES J H, JAMES MELVILLE. UMAP: Uniform Manifold Approximation and Projection for Dimension Reduction . ArXiv e-prints, 2018.
  32. COLLINS D R, URBACH J M, RACENET Z J, et al. Functional impairment of HIV-specific CD8 T cells precedes aborted spontaneous control of viremia. Immunity, 2021, 54(10).
  33. ADAMO S, MICHLER J, ZURBUCHEN Y, et al. Signature of long-lived memory CD8 T cells in acute SARS-CoV-2 infection. Nature, 2022, 602(7895): 148-55.
  34. SZABO P A, DOGRA P, GRAY J I, et al. Longitudinal profiling of respiratory and systemic immune responses reveals myeloid cell-driven lung inflammation in severe COVID-19. Immunity, 2021, 54(4).
  35. WANG S, ZHANG Q, HUI H, et al. An atlas of immune cell exhaustion in HIV-infected individuals revealed by single-cell transcriptomics . Emerg Microbes Infect, 2020, 9(1): 2333-47.
  36. ANGIN M, VOLANT S, PASSAES C, et al. Metabolic plasticity of HIV-specific CD8 T cells is associated with enhanced antiviral potential and natural control of HIV-1 infection. Nat Metab, 2019, 1(7): 704-16.
  37. WEN W, SU W, TANG H, et al. Immune cell profiling of COVID-19 patients in the recovery stage by single-cell sequencing. Cell Discov, 2020, 6: 31.
  38. HAO X X, SHEN Y C, CHEN N, et al. Osteoprogenitor-GMP crosstalk underpins solid tumor-induced systemic immunosuppression and persists after tumor removal. Cell Stem Cell, 2023, 30(5): 648-+.
  39. LIBERZON A, SUBRAMANIAN A, PINCHBACK R, et al. Molecular signatures database (MSigDB) 3.0 . Bioinformatics, 2011, 27(12): 1739-40.
  40. CARBON S, DIETZE H, LEWIS S E, et al. Expansion of the Gene Ontology knowledgebase and resources. Nucleic Acids Res, 2017, 45(D1): D331-D8.
  41. KANEHISA M, FURUMICHI M, TANABE M, et al. KEGG: new perspectives on genomes, pathways, diseases and drugs. Nucleic Acids Res, 2017, 45(D1): D353-D61.
  42. FABREGAT A, JUPE S, MATTHEWS L, et al. The Reactome Pathway Knowledgebase . Nucleic Acids Res, 2018, 46(D1): D649-D55.
  43. AIBAR S, GONZÁLEZ-BLAS C B, MOERMAN T, et al. SCENIC: single-cell regulatory network inference and clustering. Nature Methods, 2017, 14(11): 1083-+.
  44. GRIFFITHS J A, SCIALDONE A, MARIONI J C. Using single-cell genomics to understand developmental processes and cell fate decisions. Molecular Systems Biology, 2018, 14(4).
  45. TRAPNELL C, CACCHIARELLI D, GRIMSBY J, et al. The dynamics and regulators of cell fate decisions are revealed by pseudotemporal ordering of single cells. Nature Biotechnology, 2014, 32(4): 381-U251.
  46. VENTO-TORMO R, EFREMOVA M, BOTTING R A, et al. Single-cell reconstruction of the early maternal-fetal interface in humans. Nature, 2018, 563(7731): 347-+.
  47. JIN S Q, GUERRERO-JUAREZ C F, ZHANG L H, et al. Inference and analysis of cell-cell communication using CellChat. Nature Communications, 2021, 12(1).
  48. BROWAEYS R, SAELENS W, SAEYS Y. NicheNet: modeling intercellular communication by linking ligands to target genes. Nature Methods, 2020, 17(2): 159-+.
  49. HUANG D, MA N, LI X, et al. Advances in single-cell RNA sequencing and its applications in cancer research. J Hematol Oncol, 2023, 16(1): 98.
  50. DURANTE M A, RODRIGUEZ D A, KURTENBACH S, et al. Single-cell analysis reveals new evolutionary complexity in uveal melanoma. Nat Commun, 2020, 11(1): 496.
  51. ZHENG Y, CHEN Z, HAN Y, et al. Immune suppressive landscape in the human esophageal squamous cell carcinoma microenvironment. Nat Commun, 2020, 11(1): 6268.
  52. NI J, JIANG M, CHEN Y, et al. Cadherin 11-mediated juxtacrine interaction of gastric cancer cells and fibroblasts promotes metastasis via YAP/tenascin-C signaling. Sci Bull, 2022, 67(10): 1026-30.
  53. KHAN O, GILES J R, MCDONALD S, et al. TOX transcriptionally and epigenetically programs CD8(+) T cell exhaustion. Nature, 2019, 571(7764): 211-8.
  54. AOKI T, CHONG L C, TAKATA K, et al. Single-Cell Transcriptome Analysis Reveals Disease-Defining T-cell Subsets in the Tumor Microenvironment of Classic Hodgkin Lymphoma . Cancer Discov, 2020, 10(3): 406-21.
  55. PU S, QIN B, HE H, et al. Identification of early myeloid progenitors as immunosuppressive cells . European Journal of Immunology, 2016, 46: 714-.
  56. VELTEN L, HAAS S F, RAFFEL S, et al. Human haematopoietic stem cell lineage commitment is a continuous process. Nat Cell Biol, 2017, 19(4): 271-+.
  57. PARK J E, BOTTING R A, DOMINGUEZ CONDE C, et al. A cell atlas of human thymic development defines T cell repertoire formation. Science, 2020, 367(6480).
  58. DARMANIS S, SLOAN S A, ZHANG Y, et al. A survey of human brain transcriptome diversity at the single cell level. Proc Natl Acad Sci U S A, 2015, 112(23): 7285-90.
  59. OLAH M, MENON V, HABIB N, et al. Single cell RNA sequencing of human microglia uncovers a subset associated with Alzheimer's disease. Nat Commun, 2020, 11(1): 6129.
  60. Method of the year 2013 . Nat Methods, 2014, 11(1): 1.
  61. VOOSEN P, ESCOBAR H, ENSERINK M. Breakdowns of the year. Science, 2018, 362(6421): 1352-3.
For Research Use Only. Not for use in diagnostic procedures.
Related Services
PDF Download
* Email Address:

CD Genomics needs the contact information you provide to us in order to contact you about our products and services and other content that may be of interest to you. By clicking below, you consent to the storage and processing of the personal information submitted above by CD Genomcis to provide the content you have requested.

×
Quote Request
! For research purposes only, not intended for personal diagnosis, clinical testing, or health assessment.
Contact CD Genomics
Terms & Conditions | Privacy Policy | Feedback   Copyright © CD Genomics. All rights reserved.
Top