CellChat

Beta

New application is live now

CellChat

Cell-Cell communication

Notebooks

Premium

SPOTlight: seeded NMF regression to deconvolute spatial transcriptomics spots with single-cell transcriptomes
lock icon

BioTuring

Spatially resolved gene expression profiles are key to understand tissue organization and function. However, spatial transcriptomics (ST) profiling techniques lack single-cell resolution and require a combination with single-cell RNA sequencing (scRNA-seq) information to deconvolute the spatially indexed datasets. Leveraging the strengths of both data types, we developed SPOTlight, a computational tool that enables the integration of ST with scRNA-seq data to infer the location of cell types and states within a complex tissue. SPOTlight is centered around a seeded non-negative matrix factorization (NMF) regression, initialized using cell-type marker genes and non-negative least squares (NNLS) to subsequently deconvolute ST capture locations (spots). Simulating varying reference quantities and qualities, we confirmed high prediction accuracy also with shallowly sequenced or small-sized scRNA-seq reference datasets. SPOTlight deconvolution of the mouse brain correctly mapped subtle neuronal cell states of the cortical layers and the defined architecture of the hippocampus. In human pancreatic cancer, we successfully segmented patient sections and further fine-mapped normal and neoplastic cell states. Trained on an external single-cell pancreatic tumor references, we further charted the localization of clinical-relevant and tumor-specific immune cell states, an illustrative example of its flexible application spectrum and future potential in digital pathology.
Required GPU
SPOTlight
CS-CORE: Cell-type-specific co-expression inference from single cell RNA-sequencing data
lock icon

BioTuring

The recent development of single-cell RNA-sequencing (scRNA-seq) technology has enabled us to infer cell-type-specific co-expression networks, enhancing our understanding of cell-type-specific biological functions. However, existing methods proposed for this task still face challenges due to unique characteristics in scRNA-seq data, such as high sequencing depth variations across cells and measurement errors. CS-CORE (Su, C., Xu, Z., Shan, X. et al., 2023), an R package for cell-type-specific co-expression inference, explicitly models sequencing depth variations and measurement errors in scRNA-seq data. In this notebook, we will illustrate an example workflow of CS-CORE using a dataset of Peripheral Blood Mononuclear Cells (PBMC) from COVID patients and healthy controls (Wilk et al., 2020). The notebook content is inspired by CS-CORE's vignette and modified to demonstrate how the tool works on BioTuring's platform.
Only CPU
CS-CORE
expiMap: Biologically informed deep learning to query gene programs in single-cell atlases
lock icon

BioTuring

The development of large-scale single-cell atlases has allowed describing cell states in a more detailed manner. Meanwhile, current deep leanring methods enable rapid analysis of newly generated query datasets by mapping them into reference atlases. expiMap (‘explainable programmable mapper’) Lotfollahi, Mohammad, et al. is one of the methods proposed for single-cell reference mapping. Furthermore, it incorporates prior knowledge from gene sets databases or users to analyze query data in the context of known gene programs (GPs).
Required GPU
expiMap
Slingshot: cell lineage and pseudotime inference for single-cell transcriptomics
lock icon

BioTuring

Single-cell RNA sequencing (scRNA-seq) data have allowed us to investigate cellular heterogeneity and the kinetics of a biological process. Some studies need to understand how cells change state, and corresponding genes during the process, but it is challenging to track the cell development in scRNA-seq protocols. Therefore, a variety of statistical and computational methods have been proposed for lineage inference (or pseudotemporal ordering) to reconstruct the states of cells according to the developmental process from the measured snapshot data. Specifically, lineage refers to an ordered transition of cellular states, where individual cells represent points along. pseudotime is a one-dimensional variable representing each cell’s transcriptional progression toward the terminal state. Slingshot which is one of the methods suggested for lineage reconstruction and pseudotime inference from single-cell gene expression data. In this notebook, we will illustrate an example workflow for cell lineage and pseudotime inference using Slingshot. The notebook is inspired by Slingshot's vignette and modified to demonstrate how the tool works on BioTuring's platform.
Only CPU
slingshot

Trends

Bioturing Massive-scale Analysis Solution for CellChat: Running analysis for massive-scale data from Seurat dataset

BioTuring

This tool provides a user-friendly and automated way to analyze large-scale single-cell RNA-seq datasets stored in RDS (Seurat) format. It allows users to run various analysis tools on their data in one command, streamlining the analysis workflow and(More)
Only CPU
CellChat
scGPT: Towards Building a Foundational Model for Single-Cell Multi-omics Using Generative AI

BioTuring

Generative pre-trained models have demonstrated exceptional success in various fields, including natural language processing and computer vision. In line with this progress, scGPT has been developed as a foundational model tailored specifically for t(More)
Required GPU
scgpt
Seurat
CopyKAT: Delineating copy number and clonal substructure in human tumors from single-cell transcriptomes

BioTuring

Classification of tumor and normal cells in the tumor microenvironment from scRNA-seq data is an ongoing challenge in human cancer study. Copy number karyotyping of aneuploid tumors (***copyKAT***) (Gao, Ruli, et al., 2021) is a method proposed f(More)
Geneformer: a deep learning model for exploring gene networks

BioTuring

Geneformer is a foundation transformer model pretrained on a large-scale corpus of ~30 million single cell transcriptomes to enable context-aware predictions in settings with limited data in network biology. Here, we will demonstrate a basic workflow(More)
Inference and analysis of cell-cell communication using CellChat

BioTuring

Understanding global communications among cells requires accurate representation of cell-cell signaling links and effective systems-level analyses of those links. We construct a database of interactions among ligands, receptors and their cofactor(More)
Required GPU
CellChat
BioTuring Data Converter: Seurat <=> Scanpy for single-cell data transcriptomic and spatial transcriptomics

BioTuring

This notebook illustrates how to convert data from a Seurat object into a Scanpy annotation data and a Scanpy annotation data into a Seurat object using the BioStudio data transformation library (currently under development). It facilitates continued(More)
Monorail-pipeline and Recount3

BioTuring

Monorail can be used to process local and/or private data, allowing results to be directly compared to any study in recount3. Taken together, Monorail-pipeline tools help biologists maximize the utility of publicly available RNA-seq data, especially (More)
Only CPU
recount3
Deep learning and alignment of spatially resolved single-cell transcriptomes with Tangram

BioTuring

Charting an organs’ biological atlas requires us to spatially resolve the entire single-cell transcriptome, and to relate such cellular features to the anatomical scale. Single-cell and single-nucleus RNA-seq (sc/snRNA-seq) can profile cells compre(More)
Required GPU
Tangram
Scanpy is a scalable toolkit for analyzing single-cell gene expression data built jointly with anndata.

BioTuring

SCANPY integrates the analysis possibilities of established R-based frameworks and provides them in a scalable and modular form. Specifically, SCANPY provides preprocessing comparable to SEURAT and CELL RANGER, visualization through TSNE, graph-d(More)
Only CPU
Scanpy
WGCNA: an R package for Weighted Gene Correlation Network Analysis

BioTuring

WGCNA: an R package for Weighted Gene Correlation Network Analysis Correlation networks are increasingly being used in bioinformatics applications. For example, weighted gene co-expression network analysis is a systems biology method for describing (More)
Only CPU
WGCNA
FunPat: Function-based Pattern analysis on RNA-seq time series data

BioTuring

Dynamic expression data, nowadays obtained using high-throughput RNA sequencing (RNA-seq), are essential to monitor transient gene expression changes and to study the dynamics of their transcriptional activity in the cell or response to stimuli. FunP(More)
Only CPU
FunPat
Monocle3 - An analysis toolkit for single-cell RNA-seq

BioTuring

Build single-cell trajectories with the software that introduced **pseudotime**. Find out about cell fate decisions and the genes regulated as they're made. Group and classify your cells based on gene expression. Identify new cell types and states a(More)
COMMOT: Screening cell-cell communication in spatial transcriptomics via collective optimal transport

BioTuring

In this notebook, we present COMMOT (COMMunication analysis by Optimal Transport) to infer cell-cell communication (CCC) in spatial transcriptomic, a package that infers CCC by simultaneously considering numerous ligand–receptor pairs for either sp(More)
Only CPU
COMMOT
MuSiC: Multi-subject Single-cell Deconvolution

BioTuring

Knowledge of cell type composition in disease relevant tissues is an important step towards the identification of cellular targets of disease. MuSiC is a method that utilizes cell-type specific gene expression from single-cell RNA sequencing (RNA-seq(More)
Only CPU
MuSiC
DWLS: Gene Expression Deconvolution Using Dampened Weighted Least Squares

BioTuring

Dampened weighted least squares (DWLS) is an estimation method for gene expression deconvolution, in which the cell-type composition of a bulk RNA-seq data set is computationally inferred. This method corrects common biases towards cell types that ar(More)
Only CPU
DWLS
Notebooks
Only CPU
CellChat
Required GPU
scgpt
Seurat
Required GPU
CellChat
Only CPU
recount3
Required GPU
Tangram
Only CPU
Scanpy
Only CPU
WGCNA
Only CPU
FunPat
Only CPU
COMMOT
Only CPU
MuSiC
Only CPU
DWLS
...