E-spatial

Beta

New application is live now

E-spatial

Single-cell spatial explorer

Notebooks

Premium

NicheNet: modeling intercellular communication by linking ligands to target genes
lock icon

BioTuring

Computational methods that model how the gene expression of a cell is influenced by interacting cells are lacking. We present NicheNet, a method that predicts ligand–target links between interacting cells by combining their expression data with prior knowledge of signaling and gene regulatory networks. We applied NicheNet to the tumor and immune cell microenvironment data and demonstrated that NicheNet can infer active ligands and their gene regulatory effects on interacting cells.
Only CPU
nichenetr
Identifying tumor cells at the single-cell level using machine learning - inferCNV
lock icon

BioTuring

Tumors are complex tissues of cancerous cells surrounded by a heterogeneous cellular microenvironment with which they interact. Single-cell sequencing enables molecular characterization of single cells within the tumor. However, cell annotation—the assignment of cell type or cell state to each sequenced cell—is a challenge, especially identifying tumor cells within single-cell or spatial sequencing experiments. Here, we propose ikarus, a machine learning pipeline aimed at distinguishing tumor cells from normal cells at the single-cell level. We test ikarus on multiple single-cell datasets, showing that it achieves high sensitivity and specificity in multiple experimental contexts. **InferCNV** is a Bayesian method, which agglomerates the expression signal of genomically adjointed genes to ascertain whether there is a gain or loss of a certain larger genomic segment. We have used **inferCNV** to call copy number variations in all samples used in the manuscript.
Only CPU
inferCNV
scKINETICS: Inference of regulatory velocity with single-cell transcriptomics data
lock icon

BioTuring

In the realm of transcriptional dynamics, understanding the intricate interplay of regulatory proteins is crucial for deciphering processes ranging from normal development to disease progression. However, traditional RNA velocity methods often overlook the underlying regulatory drivers of gene expression changes over time. This gap in knowledge hinders our ability to unravel the mechanistic intricacies of these dynamic processes. scKINETICs (Key regulatory Interaction NETwork for Inferring Cell Speed) (Burdziak et al, 2023) offers a dynamic model for gene expression changes that simultaneously learns per-cell transcriptional velocities and a governing gene regulatory network. By employing an expectation-maximization approach, scKINETICS quantifies the impact of each regulatory element on its target genes, incorporating insights from epigenetic data, gene-gene coexpression patterns and constraints dictated by the phenotypic manifold.
Required GPU
scKINETICS
CellPhoneDB: inferring cell–cell communication from combined expression of multi-subunit ligand–receptor complexes
lock icon

BioTuring

Cell–cell communication mediated by ligand–receptor complexes is critical to coordinating diverse biological processes, such as development, differentiation and inflammation. To investigate how the context-dependent crosstalk of different cell types enables physiological processes to proceed, we developed CellPhoneDB, a novel repository of ligands, receptors and their interactions. In contrast to other repositories, our database takes into account the subunit architecture of both ligands and receptors, representing heteromeric complexes accurately. We integrated our resource with a statistical framework that predicts enriched cellular interactions between two cell types from single-cell transcriptomics data. Here, we outline the structure and content of our repository, provide procedures for inferring cell–cell communication networks from single-cell RNA sequencing data and present a practical step-by-step guide to help implement the protocol. CellPhoneDB v.2.0 is an updated version of our resource that incorporates additional functionalities to enable users to introduce new interacting molecules and reduces the time and resources needed to interrogate large datasets. CellPhoneDB v.2.0 is publicly available, both as code and as a user-friendly web interface; it can be used by both experts and researchers with little experience in computational genomics. In our protocol, we demonstrate how to evaluate meaningful biological interactions with CellPhoneDB v.2.0 using published datasets. This protocol typically takes ~2 h to complete, from installation to statistical analysis and visualization, for a dataset of ~10 GB, 10,000 cells and 19 cell types, and using five threads.
Only CPU
CellPhoneDB

Trends

Multimodal single-cell chromatin analysis with Signac

BioTuring

The recent development of experimental methods for measuring chromatin state at single-cell resolution has created a need for computational tools capable of analyzing these datasets. Here we developed Signac, a framework for the analysis of single-cell chromatin data, as an extension of the Seurat R toolkit for single-cell multimodal analysis. **Signac** enables an end-to-end analysis of single-cell chromatin data, including peak calling, quantification, quality control, dimension reduction, clustering, integration with single-cell gene expression datasets, DNA motif analysis, and interactive visualization. Furthermore, Signac facilitates the analysis of multimodal single-cell chromatin data, including datasets that co-assay DNA accessibility with gene expression, protein abundance, and mitochondrial genotype. We demonstrate scaling of the Signac framework to datasets containing over 700,000 cells.
Only CPU
Required PFP
signac
BayesPrism: Cell type and gene expression deconvolution for bulk RNA-seq data

BioTuring

Reconstructing cell type compositions and their gene expression from bulk RNA sequencing (RNA-seq) datasets is an ongoing challenge in cancer research. BayesPrism (Chu, T., Wang, Z., Pe’er, D. et al., 2022) is a Bayesian method used to predict cellular composition and gene expression in individual cell types from bulk RNA-seq datasets, with scRNA-seq as references. This notebook illustrates an example workflow for bulk RNA-seq deconvolution using BayesPrism. The notebook content is inspired by BayesPrism's vignette and modified to demonstrate how the tool works on BioTuring's platform.
Bioalpha-Biocolab: Enabling Large-Scale Data Uploads for BBrowserX single-cell analysis platform

BioTuring

Single-cell data analysis is revolutionizing biological research, but often these dataset sizes can be massive and pose challenges for submission process. Bioalpha-Biocolab addresses this issue by implementing advanced algorithms and leveraging efficient computational resources to overcome these challenges.
Required GPU
AlphaSC
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 research using libraries that interact with Scanpy in Python and Seurat in R. seurat.to.adata function can retain information about reductions (such as PCA, t-SNE, UMAP and Seurat Clusters) and spatial information.
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 to work with ***Geneformer*** models. These notebooks include the instruction to: 1. Prepare input datasets 2. Finetune Geneformer model to perform specific task 3. Using finetuning models for cell classification and gene classification application
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 cofactors that accurately represent known heteromeric molecular complexes. We then develop **CellChat**, a tool that is able to quantitatively infer and analyze intercellular communication networks from single-cell RNA-sequencing (scRNA-seq) data. CellChat predicts major signaling inputs and outputs for cells and how those cells and signals coordinate for functions using network analysis and pattern recognition approaches. Through manifold learning and quantitative contrasts, CellChat classifies signaling pathways and delineates conserved and context-specific pathways across different datasets. Applying **CellChat** to mouse and human skin datasets shows its ability to extract complex signaling patterns.
Required GPU
CellChat
scPRINT: Large Cell Model for scRNAseq data

BioTuring

scPRINT is a large transformer model built for the inference of gene networks (connections between genes explaining the cell's expression profile) from scRNAseq data. It uses novel encoding and decoding of the cell expression profile and new pre-training methodologies to learn a cell model. scPRINT can be used to perform the following analyses: - expression denoising: increase the resolution of your scRNAseq data - cell embedding: generate a low-dimensional representation of your dataset - label prediction: predict the cell type, disease, sequencer, sex, and ethnicity of your cells - gene network inference: generate a gene network from any cell or cell cluster in your scRNAseq dataset
Required GPU
scPrint
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-drawing and diffusion maps, clustering similar to PHENOGRAPH, identification of marker genes for clusters via differential expression tests and pseudotemporal ordering via diffusion pseudotime, which compares favorably with MONOCLE 2, and WISHBONE.
Only CPU
Scanpy
UMI-tools: tools for dealing with Unique Molecular Identifiers

BioTuring

Unique Molecular Identifiers (UMIs) are random oligonucleotide barcodes that are increasingly used in high-throughput sequencing experiments. Through a UMI, identical copies arising from distinct molecules can be distinguished from those arising through PCR-amplification of the same molecule. Existing methods often ignore or poorly address errors in UMI sequences. Here we introduce the UMI-tools, a network-based approach to account for these errors when identifying PCR duplicates. This open source improves quantification on accuracy both under simulated conditions and real iCLIP and single-cell RNA-seq datasets. UMI-tools contains tools for dealing with Unique Molecular Identifiers (UMIs)/Random Molecular Tags (RMTs) and single-cell RNA-Seq cell barcodes.
Only CPU
UMI-Tools
A workflow to analyze cell-cell communications on Visium data

BioTuring

Single-cell RNA data allows cell-cell communications (***CCC***) methods to infer CCC at either the individual cell or cell cluster/cell type level, but physical distances between cells are not preserved Almet, Axel A., et al., (2021). On the other hand, spatial data provides spatial distances between cells, but single-cell or gene resolution is potentially lost. Therefore, integrating two types of data in a proper manner can complement their strengths and limitations, from that improve CCC analysis. In this pipeline, we analyze CCC on Visium data with single-cell data as a reference. The pipeline includes 4 sub-notebooks as following 01-deconvolution: This step involves deconvolution and cell type annotation for Visium data, with cell type information obtained from a relevant single-cell dataset. The deconvolution method is SpatialDWLS which is integrated in Giotto package. 02-giotto: performs spatial based CCC and expression based CCC on Visium data using Giotto method. 03-nichenet: performs spatial based CCC and expression based CCC on Visium data using NicheNet method. 04-visualization: visualizes CCC results obtained from Giotto and NicheNet.
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 saving time. Note that this notebook is only for the demonstration of the tool. Users can run the tool directly through the command line. Currently, we support: - CellChat - Inference and analysis of cell-cell communication using CellChat
Only CPU
CellChat
CellDrift: Temporal perturbation effects for single cell data

BioTuring

Perturbation effects on gene programs are commonly investigated in single-cell experiments. Existing models measure perturbation responses independently across time series, disregarding the temporal consistency of specific gene programs. We introduce CellDrift, a generalized linear model based functional data analysis approach to investigate temporal gene patterns in response to perturbations. CellDrift is a python package for the evaluation of temporal perturbation effects using single-cell RNA-seq data. It includes functions below: 1. Disentangle common and cell type specific perturbation effects across time; 2. Identify patterns of genes that have similar temporal perturbation responses; 3. Prioritize genes with distinct temporal perturbation responses between perturbations or cell types; 4. Infer differential genes of perturbational states in the pseudo-time trajectories.
Only CPU
CellDrift
BioStudio: From CellRanger to BBrowserX

BioTuring

Support run fastq from CellRanger and upload to BBrowserX
Only CPU
SoupX: removing ambient RNA contamination from droplet-based single-cell RNA sequencing data

BioTuring

Droplet-based single-cell RNA sequence analyses assume that all acquired RNAs are endogenous to cells. However, there is a certain amount of cell-free mRNAs floating in the input solution (referred to as 'the soup'), created from cells in the input solution being lysed. These background mRNAs are then distributed into the droplets with cells and sequenced alongside them, resulting in background contamination that confounds the biological interpretation of single-cell transcriptomic data. SoupX (Young and Behjati, 2020) is one of the methods proposed for ambient mRNA removal. In this notebook, we will illustrate a workflow example that applies SoupX to correct the ambient RNA in a dataset of 10k PBMC cells. The output of SoupX is a modified counts matrix, which can be used for any downstream analysis tool.
Only CPU
SoupX
CS-CORE: Cell-type-specific co-expression inference from single cell RNA-sequencing data

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
Notebooks
Required PFP
Only CPU
signac
Required GPU
AlphaSC
Required GPU
CellChat
Required GPU
scPrint
Only CPU
Scanpy
Only CPU
UMI-Tools
Only CPU
CellChat
Only CPU
CellDrift
Only CPU
Only CPU
SoupX
Only CPU
CS-CORE