function aggregate_scores(obj) {
return d3.mean(obj.map(val => {
if (val.score === undefined || isNaN(val.score)) return 0;
return Math.min(1, Math.max(0, val.score))
}));
}
function transpose_list_of_objects(list) {
return Object.fromEntries(Object.keys(list[0]).map(key => [key, list.map(d => d[key])]))
}
function label_time(time) {
if (time < 1e-5) return "0s";
if (time < 1) return "<1s";
if (time < 60) return `${Math.floor(time)}s`;
if (time < 3600) return `${Math.floor(time / 60)}m`;
if (time < 3600 * 24) return `${Math.floor(time / 3600)}h`;
if (time < 3600 * 24 * 7) return `${Math.floor(time / 3600 / 24)}d`;
return ">7d"; // Assuming missing values are encoded as NaN
}
function label_memory(x_mb, include_mb = true) {
if (!include_mb && x_mb < 1e3) return "<1G";
if (x_mb < 1) return "<1M";
if (x_mb < 1e3) return `${Math.round(x_mb)}M`;
if (x_mb < 1e6) return `${Math.round(x_mb / 1e3)}G`;
if (x_mb < 1e9) return `${Math.round(x_mb / 1e6)}T`;
return ">1P";
}
function mean_na_rm(x) {
return d3.mean(x.filter(d => !isNaN(d)));
}
Spatial Simulators
Assessing the quality of spatial transcriptomics simulators.
10 datasets · 8 methods · 3 control methods · 46 metrics
Info
Repository
Issues
build_main
MIT
Task info Method info Metric info Dataset info Results
Computational methods for spatially resolved transcriptomics (SRT) are frequently developed and assessed through data simulation. The effectiveness of these evaluations relies on the simulation methods’ ability to accurately reflect experimental data. However, a systematic evaluation framework for spatial simulators is lacking. Here, we present SpatialSimBench, a comprehensive evaluation framework that assesses 13 simulation methods using 10 distinct STR datasets.
The research goal of this benchmark is to systematically evaluate and compare the performance of various simulation methods for spatial transcriptomics (ST) data. It aims to address the lack of a comprehensive evaluation framework for spatial simulators and explore the feasibility of leveraging existing single-cell simulators for ST data. The experimental setup involves collecting public spatial transcriptomics datasets and corresponding scRNA-seq datasets. The spatial and scRNA-seq datasets can originate from different study but should consist of similar cell types from similar tissues.
Summary
Display settings
Filter datasets
Filter methods
Filter metrics
Results
Results table of the scores per method, dataset and metric (after scaling). Use the filters to make a custom subselection of methods and datasets. The “Overall mean” dataset is the mean value across all datasets.
Dataset info
Show
Hindlimbmuscle
Data source · 14-03-2025 · 19.16 MiB
Spatial RNA sequencing of regenerating mouse hindlimb muscle (McKellar_2020?).
The spatial transcriptomics datasets regenerates mouse muscle tissue generated with the 10x Genomics Visium platform.
Brain
Data source · 14-03-2025 · 42.61 MiB
10X Visium spatial RNA-seq from adult mouse brain sections paired to single-nucleus RNA-seq (Kleshchevnikov_2022?).
This datasets were generated matched single nucleus (sn, this submission) and Visium spatial RNA-seq (10X Genomics) profiles of adjacent mouse brain sections that contain multiple regions from the telencephalon and diencephalon.
Cortex
Data source · 14-03-2025 · 19.33 MiB
Scripts and source data for image processing, barcode calling, and cell type annotations in a seqFISH+ experiment (Eng_2019?).
The dataset includes processed image data, cell type annotations with Louvain clusters, gene IDs for transcript locations, and mRNA point locations, with additional data available on Zenodo.
Prostate
Data source · 14-03-2025 · 19.69 MiB
Spatially resolved gene expression of human protate tissue slices treated with steroid hormones for 8 hours (McCray_2021?).
Spatially resolved gene expression was prepard by dissociated hman prostate tissue to single cells, and collected & prepped for RNA-seq using the Visium Spatial Gene Expression kit.
Breast
Data source · 14-03-2025 · 22.65 MiB
A spatially resolved atlas of human breast cancers (Wu_2021?).
This study presents a spatially resolved transcriptomics analysis of human breast cancers.
pancreatic ductal adenocarcinomas
Data source · 14-03-2025 · 17.55 MiB
Integrating microarray-based spatial transcriptomics and single-cell RNA-seq reveals tissue architecture in pancreatic ductal adenocarcinomas (McKellar_2020?).
We developed a multimodal intersection analysis method combining scRNA-seq with spatial transcriptomics to map and characterize the spatial organization and interactions of distinct cell subpopulations in complex tissues, such as primary pancreatic tumors..
Olfactorybulb
Data source · 14-03-2025 · 2.23 MiB
Single-cell and spatial transcriptomic of mouse olfactory bulb (St_hl_2016?).
Single-cell and spatial transcriptomic of mouse olfactory bulb
Fibrosarcoma
Data source · 14-03-2025 · 27.16 MiB
Multi-resolution deconvolution of spatial transcriptomics data reveals continuous patterns of Tumor A1 of Tissue 1 (Lopez_2022?).
Spatial transcriptomics of Tumor A1 of Tissue 1.
Gastrulation
Data source · 14-03-2025 · 14.96 MiB
single-cell and spatial transcriptomic molecular map of mouse gastrulation (Lohoff_2021?).
Single-Cell omics Data across Mouse Gastrulation and Highly multiplexed spatially resolved gene expression profiling of Early Organogenesis.
Osteosarcoma
Data source · 14-03-2025 · 20.11 MiB
Spatial profiling of human osteosarcoma cells (Xia_2019?).
Spatial transcriptome profiling by MERFISH reveals subcellular RNA compartmentalization and cell cycle-dependent gene expression.
Method info
Show
scDesign2
Documentation · Repository · Source Code · Container · build_main
A transparent simulator that generates high-fidelity single-cell gene expression count data with gene correlations captured (Sun_2021?)
scDesign2 is a transparent simulator that achieves all three goals (preserving genes, capturing gene correlations, and generating any number of cells with varying sequencing depths) and generates high-fidelity synthetic data for multiple single-cell gene expression count-based technologies.
scDesign3 (NB)
Documentation · Repository · Source Code · Container · build_main
A probabilistic model that unifies the generation and inference for single-cell and spatial omics data (Song_2023?)
scDesign3 offers a probabilistic model that unifies the generation and inference for single-cell and spatial omics data. The model’s interpretable parameters and likelihood enable scDesign3 to generate customized in silico data and unsupervisedly assess the goodness-of-fit of inferred cell latent structures (for example, clusters, trajectories and spatial locations).
scDesign3 (Poisson)
Documentation · Repository · Source Code · Container · build_main
A probabilistic model that unifies the generation and inference for single-cell and spatial omics data (Song_2023?)
scDesign3 offers a probabilistic model that unifies the generation and inference for single-cell and spatial omics data. The model’s interpretable parameters and likelihood enable scDesign3 to generate customized in silico data and unsupervisedly assess the goodness-of-fit of inferred cell latent structures (for example, clusters, trajectories and spatial locations).
SPARsim
Documentation · Repository · Source Code · Container · build_main
SPARSim single cell is a count data simulator for scRNA-seq data (Baruzzo_2019?)
SPARSim is a scRNA-seq count data simulator based on a Gamma-Multivariate Hypergeometric model. It allows to generate count data that resembles real data in terms of count intensity, variability and sparsity.
Splatter
Documentation · Repository · Source Code · Container · build_main
A single cell RNA-seq data simulator based on a gamma-Poisson distribution (Zappia_2017?)
The Splat model is a gamma-Poisson distribution used to generate a gene by cell matrix of counts. Mean expression levels for each gene are simulated from a gamma distribution and the Biological Coefficient of Variation is used to enforce a mean-variance trend before counts are simulated from a Poisson distribution.
SRTsim
Documentation · Repository · Source Code · Container · build_main
An SRT-specific simulator for scalable, reproducible, and realistic SRT simulations (Zhu_2023?)
A key benefit of srtsim is its ability to maintain location-wise and gene-wise SRT count properties and preserve spatial expression patterns, enabling evaluation of SRT method performance using synthetic data.
symsim
Documentation · Repository · Source Code · Container · build_main
Simulating multiple faceted variability in single cell RNA sequencing (Zhang_2019?)
SymSim is a simulator for modeling single-cell RNA-Seq data, accounting for three primary sources of variation: intrinsic transcription noise, extrinsic variation from different cell states, and technical variation from measurement noise and bias.
zinbwave
Documentation · Repository · Source Code · Container · build_main
A general and flexible method for signal extraction from single-cell RNA-seq data (Risso_2018?)
ZINB-WaVE is a general and flexible zero-inflated negative binomial model, which leads to low-dimensional representations of the data that account for zero inflation (dropouts), over-dispersion, and the count nature of the data.
Control method info
Show
positive
Documentation · Repository · Source Code · Container · build_main
A positive control method
A positive control method.
negative_shuffle
Documentation · Repository · Source Code · Container · build_main
A negative control method which shuffles the input data
This control method shuffles the input data as a negative control.
negative_normal
Documentation · Repository · Source Code · Container · build_main
A negative control which generates normal distributed data
This control method generates normal distributed data as a negative control. The mean and the sd are defined by the mean and sd of the input data.
Metric info
Show
clustering_ari
Adjusted rand index (ARI) measures the similarity between two clusters in real and simulated datasets (Vinh_2009?).
Adjusted Rand Index used in spatial clustering to measure the similarity between two data clusterings, adjusted for chance.
clustering_nmi
Normalized mutual information (NMI) measures of the mutual dependence between the real and simulated spatial clusters (Vinh_2009?).
Normalized Mutual Information used in spatial clustering to measure the agreement between two different clusterings, scaled to [0, 1].
svg_recall
Recall measures the proportion of real SVG correctly identified in the simulated dataset (1?).
Recall used in identifying spatial variable genes, measuring the true positive rate.
svg_precision
Precision measures the proportion of correctly identified items in simulated datasets (1?).
Precision used in identifying spatial variable genes, measuring the accuracy of positive predictions.
ctdeconvolute_rmse
Root Mean Square deviation is calculated between the true and predicted proportion of per cell type (Hodson_2022?).
Root Mean Squared Error used in cell type deconvolution to measure the difference between observed and predicted values.
ctdeconcolute_jsd
Jensen-Shannon divergence (JSD) is calculated between the true and predicted proportion per cell type in all spots (Drost_2018?).
Jensen-Shannon Divergence used in cell type deconvolution to measure the similarity between two probability distributions.
crosscor_mantel
Mantel statistic is the test statistic for the Mantel test, which is a correlation coefficient calculated between bivariate Moran’s I of real dataset and that of in simulation dataset (Legendre_2015?).
Mantel statistic used in spatial cross-correlation to test the correlation between two distance matrices.
crosscor_cosine
Cosine similarity measures similarity between bivariate Moran’s I of real dataset and that of in simulation dataset (Leydesdorff_2005?).
Cosine similarity used in spatial cross-correlation to measure the cosine of the angle between two non-zero vectors.
Fraction of zeros per gene
KS statistic of the fraction of zeros per gene (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the fraction of zeros per gene in the real datasets versus the fraction of zeros per gene in the simulated datasets.
Fraction of zeros per cell
KS statistic of the fraction of zeros per spot (cell) (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the fraction of zeros per spot (cell) in the real datasets versus the fraction of zeros per spot (cell) in the simulated datasets.
Library size
KS statistic of the library size (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the total sum of UMI counts across all genes in the real datasets versus the total sum of UMI counts across all genes in the simmulated datasets.
Effective library size
KS statistic of the effective library size (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the effective library size of the real datasets versus the effective library size of the simulated datasets.
TMM
KS statistic of the weight trimmed mean of M-values normalization factor (TMM) (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the weight trimmed mean of M-values normalization factor for the real datasets versus the weight trimmed mean of M-values normalization factor for the simulated datasets.
Scaled variance cell
KS statistic of the spot- (or cell-) level scaled variance of the expression matrix (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the spot-level z-score standardization of the variance of expression matrix in terms of log2(CPM) in the real datasets versus the simulated datasets.
Scaled mean cells
KS statistic of the spot- (or cell-) level scaled mean of the expression matrix (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the z-score standardization of the mean of expression matrix in terms of log2(CPM) in the real datasets versus the simulated datasets.
Library size vs fraction zero
KS statistic of the relationship between library size and the proportion of zeros per spot (cell) (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the relationship between library size and the proportion of zeros per spot (cell) in the real datasets versus the simulated datasets.
Sample Pearson correlation
KS statistic of the sample Pearson correlation (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the sample Pearson correlation of the real datasets versus the sample Pearson correlation of the simulated datasets.
Scaled variance genes
KS statistic of the gene-level scaled variance of the expression matrix (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the gene-level z-score standardization of the variance of expression matrix in terms of log2(CPM) in the real datasets versus the simulated datasets.
Scaled mean genes
KS statistic of the gene-level scaled mean of the expression matrix (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the gene-level z-score standardization of the mean of expression matrix in terms of log2(CPM) in the real datasets versus the simulated datasets.
Gene Pearson correlation
KS statistic of the gene Pearson correlation (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the gene Pearson correlation of the real datasets versus the gene Pearson correlation of the simulated datasets.
Mean vs variance
KS statistic of the relationship between mean expression and variance expression (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the relationship between mean expression and variance expression in the real datasets versus the simulated datasets.
Mean vs fraction zero
KS statistic of the relationship between mean expression and the proportion of zero per gene (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the relationship between mean expression and the proportion of zero per gene in the real datasets versus the simulated datasets.
Fraction of zeros per gene
KS statistic of the fraction of zeros per gene (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the fraction of zeros per gene in the real datasets versus the fraction of zeros per gene in the simulated datasets.
Fraction of zeros per cell
KS statistic of the fraction of zeros per spot (cell) (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the fraction of zeros per spot (cell) in the real datasets versus the fraction of zeros per spot (cell) in the simulated datasets.
Library size
KS statistic of the library size (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the total sum of UMI counts across all genes in the real datasets versus the total sum of UMI counts across all genes in the simmulated datasets.
Effective library size
KS statistic of the effective library size (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the effective library size of the real datasets versus the effective library size of the simulated datasets.
TMM
KS statistic of the weight trimmed mean of M-values normalization factor (TMM) (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the weight trimmed mean of M-values normalization factor for the real datasets versus the weight trimmed mean of M-values normalization factor for the simulated datasets.
Scaled variance cell
KS statistic of the spot- (or cell-) level scaled variance of the expression matrix (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the spot-level z-score standardization of the variance of expression matrix in terms of log2(CPM) in the real datasets versus the simulated datasets.
Scaled mean cells
KS statistic of the spot- (or cell-) level scaled mean of the expression matrix (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the z-score standardization of the mean of expression matrix in terms of log2(CPM) in the real datasets versus the simulated datasets.
Library size vs fraction zero
KS statistic of the relationship between library size and the proportion of zeros per spot (cell) (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the relationship between library size and the proportion of zeros per spot (cell) in the real datasets versus the simulated datasets.
Sample Pearson correlation
KS statistic of the sample Pearson correlation (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the sample Pearson correlation of the real datasets versus the sample Pearson correlation of the simulated datasets.
Scaled variance genes
KS statistic of the gene-level scaled variance of the expression matrix (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the gene-level z-score standardization of the variance of expression matrix in terms of log2(CPM) in the real datasets versus the simulated datasets.
Scaled mean genes
KS statistic of the gene-level scaled mean of the expression matrix (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the gene-level z-score standardization of the mean of expression matrix in terms of log2(CPM) in the real datasets versus the simulated datasets.
Gene Pearson correlation
KS statistic of the gene Pearson correlation (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the gene Pearson correlation of the real datasets versus the gene Pearson correlation of the simulated datasets.
Mean vs variance
KS statistic of the relationship between mean expression and variance expression (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the relationship between mean expression and variance expression in the real datasets versus the simulated datasets.
Mean vs fraction zero
KS statistic of the relationship between mean expression and the proportion of zero per gene (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the relationship between mean expression and the proportion of zero per gene in the real datasets versus the simulated datasets.
L statistics
KS statistic of the L statistics (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the L statistics in the real datasets versus the L statistics in the simulated datasets.
Celltype interaction
KS statistic of the celltype interaction (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the Celltype interaction in the real datasets versus the Celltype interaction in the simulated datasets.
Library size
KS statistic of the library size (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the nn correlation in the real datasets versus the nn correlation in the simmulated datasets.
Effective library size
KS statistic of the effective library size (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the morans I of the real datasets versus the morans I of the simulated datasets.
Transition matrix
KS Statistic of the transition matrix (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the transition matrix of the real dataset versus the simulated dataset. The transition matrix elucidates the interrelationships among spatial clusters in each space. Each element in the matrix signifies the transition probability from one spatial cluster to another, thereby mapping the dynamic interplay of spatial clusters.
Centralized score
Ks Statistic of the centralized score matrix (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the centralized score matrix of the real dataset versus the simulated dataset. The centralized score matrix is a vector of the group degree centrality (inter-cluster connectivity), average clustering coefficient (propensity for a spot within a spatial cluster to be connected to spots in another cluster), and the group closeness centrality (relative proximity or accessibility of one cluster to all spots in another).
Neighborhood enrichment
Ks Statistic of the neighborhood enrichment (Chac_n_2018?).
The Kolmogorov-Smirnov statistic comparing the neighborhood enrichment matrices of the real dataset versus the simulated dataset. The neighborhood enrichment matrix quantifies the enrichment observed between each pair of spatial clusters. It serves to systematically assess the interaction between different clusters within a spatial context, providing insights into the relative connectivity between various spatial clusters.
Frobenius norm of transition matrix
Frobenius norm of the transition matrix (Chac_n_2018?).
The Frobenius norm of the difference between two matrices is calculated to assess the closeness of the spatial pattern of cell types between the simulated and real data.
Frobenius norm of centralized score
Frobenius norm of the centralized score matrix (Chac_n_2018?).
The Frobenius norm of the difference between two matrices is calculated to assess the closeness of the spatial pattern of cell types between the simulated and real data.
Frobenius norm of neighborhood enrichment
Frobenius norm of the neighborhood enrichment (Chac_n_2018?).
The Frobenius norm of the difference between two matrices is calculated to assess the closeness of the spatial pattern of cell types between the simulated and real data.
Quality control results
Show
Category | Name | Value | Condition | Severity |
---|---|---|---|---|
Scaling | Worst score scdesign2 ks_statistic_enrichment_scalef | -129.8837000 | worst_score >= -1 | ✗✗✗ |
Scaling | Worst score scdesign3_poisson ks_statistic_enrichment_scalef | -59.2387000 | worst_score >= -1 | ✗✗✗ |
Scaling | Worst score scdesign3_poisson ks_statistic_morans_I | -54.6940000 | worst_score >= -1 | ✗✗✗ |
Scaling | Worst score scdesign3_poisson ks_statistic_nn_correlation | -20.3592000 | worst_score >= -1 | ✗✗✗ |
Scaling | Worst score scdesign2 ks_statistic_central_score_scalef | -12.7374000 | worst_score >= -1 | ✗✗✗ |
Scaling | Worst score scdesign2 ks_statistic_transition_scalef | -12.4357000 | worst_score >= -1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_efflib_size_cells_tstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_efflib_size_cells_zstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_frac_zero_cells_tstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_frac_zero_cells_zstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_frac_zero_genes_tstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_frac_zero_genes_zstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_lib_fraczero_cells_tstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_lib_fraczero_cells_zstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_lib_size_cells_tstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_lib_size_cells_zstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_mean_fraczero_genes_tstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_mean_fraczero_genes_zstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_mean_var_genes_tstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_mean_var_genes_zstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_pearson_cells_tstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_pearson_cells_zstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_pearson_genes_tstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_pearson_genes_zstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_scaled_mean_cells_tstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_scaled_mean_cells_zstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_scaled_mean_genes_tstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_scaled_mean_genes_zstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_scaled_var_cells_tstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_scaled_var_cells_zstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_scaled_var_genes_tstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_scaled_var_genes_zstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_tmm_cells_tstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_tmm_cells_zstat' %missing | 1.0000000 | pct_missing <= .1 | ✗✗✗ |
Raw results | Method 'scdesign3_nb' %missing | 0.7521739 | pct_missing <= .1 | ✗✗✗ |
Raw results | Dataset 'gastrulation' %missing | 0.7430830 | pct_missing <= .1 | ✗✗✗ |
Raw results | Dataset 'brain' %missing | 0.7371542 | pct_missing <= .1 | ✗✗✗ |
Raw results | Dataset 'pdac' %missing | 0.7233202 | pct_missing <= .1 | ✗✗✗ |
Raw results | Dataset 'prostate' %missing | 0.7173913 | pct_missing <= .1 | ✗✗✗ |
Raw results | Dataset 'hindlimbmuscle' %missing | 0.7015810 | pct_missing <= .1 | ✗✗✗ |
Raw results | Method 'scdesign3_poisson' %missing | 0.6978261 | pct_missing <= .1 | ✗✗✗ |
Raw results | Method 'scdesign2' %missing | 0.6913043 | pct_missing <= .1 | ✗✗✗ |
Raw results | Method 'negative_shuffle' %missing | 0.6891304 | pct_missing <= .1 | ✗✗✗ |
Raw results | Method 'splatter' %missing | 0.6739130 | pct_missing <= .1 | ✗✗✗ |
Raw results | Method 'symsim' %missing | 0.6739130 | pct_missing <= .1 | ✗✗✗ |
Raw results | Method 'sparsim' %missing | 0.6717391 | pct_missing <= .1 | ✗✗✗ |
Raw results | Dataset 'breast' %missing | 0.6699605 | pct_missing <= .1 | ✗✗✗ |
Raw results | Method 'srtsim' %missing | 0.6695652 | pct_missing <= .1 | ✗✗✗ |
Raw results | Method 'zinbwave' %missing | 0.6695652 | pct_missing <= .1 | ✗✗✗ |
Raw results | Method 'negative_normal' %missing | 0.6652174 | pct_missing <= .1 | ✗✗✗ |
Raw results | Method 'positive' %missing | 0.6478261 | pct_missing <= .1 | ✗✗✗ |
Raw results | Dataset 'cortex' %missing | 0.6462451 | pct_missing <= .1 | ✗✗✗ |
Raw results | Dataset 'fibrosarcoma' %missing | 0.6343874 | pct_missing <= .1 | ✗✗✗ |
Raw results | Dataset 'olfactorybulb' %missing | 0.6284585 | pct_missing <= .1 | ✗✗✗ |
Raw results | Dataset 'osteosarcoma' %missing | 0.6185771 | pct_missing <= .1 | ✗✗✗ |
Scaling | Best score sparsim ks_statistic_enrichment_scalef | 11.5541000 | best_score <= 2 | ✗✗✗ |
Scaling | Best score symsim ks_statistic_enrichment_scalef | 11.4882000 | best_score <= 2 | ✗✗✗ |
Scaling | Best score splatter ks_statistic_enrichment_scalef | 11.4715000 | best_score <= 2 | ✗✗✗ |
Scaling | Worst score scdesign3_poisson ks_statistic_central_score_scalef | -4.4044000 | worst_score >= -1 | ✗✗✗ |
Scaling | Worst score scdesign3_poisson ks_statistic_transition_scalef | -4.0175000 | worst_score >= -1 | ✗✗✗ |
Raw results | Metric 'crosscor_cosine' %missing | 0.4000000 | pct_missing <= .1 | ✗✗✗ |
Scaling | Worst score scdesign2 ks_statistic_enrichment | -4.0000000 | worst_score >= -1 | ✗✗✗ |
Scaling | Worst score scdesign3_poisson ks_statistic_enrichment | -4.0000000 | worst_score >= -1 | ✗✗✗ |
Raw results | Metric 'svg_precision' %missing | 0.3818182 | pct_missing <= .1 | ✗✗✗ |
Scaling | Worst score sparsim ks_statistic_morans_I | -3.7508000 | worst_score >= -1 | ✗✗✗ |
Scaling | Best score sparsim ks_statistic_central_score | 7.0000000 | best_score <= 2 | ✗✗✗ |
Scaling | Best score splatter ks_statistic_central_score | 7.0000000 | best_score <= 2 | ✗✗✗ |
Scaling | Best score symsim ks_statistic_central_score | 7.0000000 | best_score <= 2 | ✗✗✗ |
Scaling | Worst score sparsim ks_statistic_transition_scalef | -3.4773000 | worst_score >= -1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_L_stats' %missing | 0.3090909 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_celltype_interaction' %missing | 0.3090909 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_morans_I' %missing | 0.3090909 | pct_missing <= .1 | ✗✗✗ |
Raw results | Metric 'ks_statistic_nn_correlation' %missing | 0.3090909 | pct_missing <= .1 | ✗✗✗ |
Dataset info | Pct 'task_id' missing | 1.0000000 | percent_missing(dataset_info, field) | ✗✗ |
Method info | Pct 'paper_reference' missing | 0.7272727 | percent_missing(method_info, field) | ✗✗ |
Metric info | Pct 'paper_reference' missing | 1.0000000 | percent_missing(metric_info, field) | ✗✗ |
Scaling | Worst score zinbwave ks_statistic_L_stats | -2.7543000 | worst_score >= -1 | ✗✗ |
Scaling | Worst score symsim ks_statistic_L_stats | -2.6781000 | worst_score >= -1 | ✗✗ |
Scaling | Worst score scdesign2 ks_statistic_central_score | -2.5000000 | worst_score >= -1 | ✗✗ |
Scaling | Worst score splatter ks_statistic_L_stats | -2.4967000 | worst_score >= -1 | ✗✗ |
Scaling | Best score zinbwave ks_statistic_enrichment_scalef | 4.8473000 | best_score <= 2 | ✗✗ |
Scaling | Worst score sparsim ks_statistic_L_stats | -2.4098000 | worst_score >= -1 | ✗✗ |
Scaling | Worst score sparsim ks_statistic_nn_correlation | -2.3172000 | worst_score >= -1 | ✗✗ |
Raw results | Metric 'svg_recall' %missing | 0.2181818 | pct_missing <= .1 | ✗✗ |
Scaling | Best score sparsim ks_statistic_enrichment | 4.0000000 | best_score <= 2 | ✗ |
Scaling | Best score splatter ks_statistic_enrichment | 4.0000000 | best_score <= 2 | ✗ |
Scaling | Best score splatter ks_statistic_transition_matrix | 4.0000000 | best_score <= 2 | ✗ |
Scaling | Best score symsim ks_statistic_transition_matrix | 4.0000000 | best_score <= 2 | ✗ |
Scaling | Best score splatter ks_statistic_transition_scalef | 3.8803000 | best_score <= 2 | ✗ |
Scaling | Best score symsim ks_statistic_transition_scalef | 3.8803000 | best_score <= 2 | ✗ |
Scaling | Worst score symsim ks_statistic_morans_I | -1.7977000 | worst_score >= -1 | ✗ |
Scaling | Best score zinbwave ks_statistic_transition_scalef | 3.3624000 | best_score <= 2 | ✗ |
Scaling | Best score sparsim ks_statistic_transition_matrix | 3.3333000 | best_score <= 2 | ✗ |
Scaling | Best score scdesign3_nb ks_statistic_transition_scalef | 3.3003000 | best_score <= 2 | ✗ |
Scaling | Best score scdesign3_nb ks_statistic_enrichment | 3.0000000 | best_score <= 2 | ✗ |
Scaling | Best score scdesign3_poisson ks_statistic_enrichment | 3.0000000 | best_score <= 2 | ✗ |
Scaling | Best score srtsim ks_statistic_enrichment | 3.0000000 | best_score <= 2 | ✗ |
Scaling | Best score symsim ks_statistic_enrichment | 3.0000000 | best_score <= 2 | ✗ |
Scaling | Best score zinbwave ks_statistic_enrichment | 3.0000000 | best_score <= 2 | ✗ |
Scaling | Best score zinbwave ks_statistic_transition_matrix | 3.0000000 | best_score <= 2 | ✗ |
Scaling | Worst score sparsim ks_statistic_central_score_scalef | -1.4920000 | worst_score >= -1 | ✗ |
Scaling | Best score srtsim ks_statistic_transition_scalef | 2.9102000 | best_score <= 2 | ✗ |
Scaling | Best score scdesign3_nb ks_statistic_enrichment_scalef | 2.8293000 | best_score <= 2 | ✗ |
Scaling | Best score scdesign3_poisson ks_statistic_transition_scalef | 2.8141000 | best_score <= 2 | ✗ |
Scaling | Worst score symsim svg_precision | -1.4000000 | worst_score >= -1 | ✗ |
Raw results | Metric 'ks_statistic_central_score' %missing | 0.1363636 | pct_missing <= .1 | ✗ |
Raw results | Metric 'ks_statistic_central_score_scalef' %missing | 0.1363636 | pct_missing <= .1 | ✗ |
Raw results | Metric 'ks_statistic_enrichment' %missing | 0.1363636 | pct_missing <= .1 | ✗ |
Raw results | Metric 'ks_statistic_enrichment_scalef' %missing | 0.1363636 | pct_missing <= .1 | ✗ |
Raw results | Metric 'ks_statistic_transition_matrix' %missing | 0.1363636 | pct_missing <= .1 | ✗ |
Raw results | Metric 'ks_statistic_transition_scalef' %missing | 0.1363636 | pct_missing <= .1 | ✗ |
Scaling | Best score scdesign2 ks_statistic_transition_scalef | 2.5279000 | best_score <= 2 | ✗ |
Scaling | Best score scdesign2 ks_statistic_enrichment_scalef | 2.5015000 | best_score <= 2 | ✗ |
Scaling | Worst score srtsim ks_statistic_transition_scalef | -1.2426000 | worst_score >= -1 | ✗ |
Scaling | Best score scdesign3_poisson ks_statistic_enrichment_scalef | 2.4207000 | best_score <= 2 | ✗ |
Scaling | Best score srtsim ks_statistic_enrichment_scalef | 2.4083000 | best_score <= 2 | ✗ |
Scaling | Best score sparsim ks_statistic_transition_scalef | 2.3964000 | best_score <= 2 | ✗ |
Scaling | Worst score srtsim ks_statistic_morans_I | -1.1172000 | worst_score >= -1 | ✗ |
Scaling | Worst score sparsim svg_precision | -1.0787000 | worst_score >= -1 | ✗ |
Scaling | Best score splatter ks_statistic_central_score_scalef | 2.1239000 | best_score <= 2 | ✗ |
Scaling | Best score symsim ks_statistic_central_score_scalef | 2.1239000 | best_score <= 2 | ✗ |
Scaling | Best score sparsim ks_statistic_central_score_scalef | 2.0261000 | best_score <= 2 | ✗ |