# HG changeset patch # User iuc # Date 1726317946 0 # Node ID 178242b8229736b73ffda050438d0af1c0e06e62 # Parent f9353ee6a0d4895b30599523d6290bf4ce168fdf planemo upload for repository https://github.com/galaxyproject/tools-iuc/tree/master/tools/scanpy/ commit 91121b1e72696f17478dae383badaa71e9f96dbb diff -r f9353ee6a0d4 -r 178242b82297 README.md --- a/README.md Tue Aug 20 09:50:17 2024 +0000 +++ b/README.md Sat Sep 14 12:45:46 2024 +0000 @@ -25,6 +25,7 @@ `pp.highly_variable_genes` | Extract highly variable genes `pp.subsample` | Subsample to a fraction of the number of observations `pp.downsample_counts` | Downsample counts so that each cell has no more than target_counts + `pp.scrublet` | Predict doublets 3. Normalize (`normalize.xml`) @@ -34,14 +35,18 @@ `pp.recipe_zheng17` | Normalization and filtering as of [Zheng17] `pp.recipe_weinreb17` | Normalization and filtering as of [Weinreb17] `pp.recipe_seurat` | Normalization and filtering as of Seurat [Satija15] + `external.pp.magic` | Denoising using Markov Affinity-based Graph Imputation of Cells (MAGIC) API 4. Remove confounders (`remove_confounder.xml`) Methods | Description --- | --- `pp.regress_out` | Regress out unwanted sources of variation - `pp.mnn_correct` | Correct batch effects by matching mutual nearest neighbors + `pp.combat` | ComBat function for batch effect correction + `external.pp.bbknn` | Batch effect removal with Batch balanced KNN (BBKNN) + `external.pp.harmony_integrate` | Integrate multiple single-cell experiments with Harmony + `external.pp.scanorama_integrate` | Integrate multiple single-cell experiments with Scanorama 5. Clustering, embedding and trajectory inference (`cluster_reduce_dimension.xml`) @@ -49,14 +54,14 @@ --- | --- `tl.louvain` | Cluster cells into subgroups `tl.leiden` | Cluster cells into subgroups - `tl.pca` | Principal component analysis - `pp.pca` | Principal component analysis (appears to be the same func...) + `pp.pca` | Principal component analysis `tl.diffmap` | Diffusion Maps `tl.tsne` | t-SNE `tl.umap` | Embed the neighborhood graph using UMAP `tl.draw_graph` | Force-directed graph drawing `tl.dpt` | Infer progression of cells through geodesic distance along the graph `tl.paga` | Mapping out the coarse-grained connectivity structures of complex manifolds + `tl.embedding_density` | Calculate the density of cells in an embedding (per condition) 6. Plot (`plot.xml`) @@ -66,18 +71,20 @@ --- | --- `pl.scatter` | Scatter plot along observations or variables axes `pl.heatmap` | Heatmap of the expression values of set of genes + `pl.tracksplot` | Tracks plot of the expression values per cell `pl.dotplot` | Makes a dot plot of the expression values `pl.violin` | Violin plot `pl.stacked_violin` | Stacked violin plots `pl.matrixplot` | Heatmap of the mean expression values per cluster `pl.clustermap` | Hierarchically-clustered heatmap - + 2. Preprocessing Methods | Description --- | --- `pl.highest_expr_genes` | Plot the fraction of counts assigned to each gene over all cells `pl.highly_variable_genes` | Plot dispersions versus means for genes + `pl.scrublet_score_distribution` | Histogram of doublet scores 3. PCA @@ -96,12 +103,13 @@ `pl.umap` | Scatter plot in UMAP basis `pl.diffmap` | Scatter plot in Diffusion Map basis `pl.draw_graph` | Scatter plot in graph-drawing basis + `pl.embedding_density` | Density of cells in an embedding (per condition) 5. Branching trajectories and pseudotime, clustering Methods | Description --- | --- - `pl.dpt_groups_pseudotime` | Plot groups and pseudotime + `pl.dpt_timeseries` | Heatmap of pseudotime series `pl.paga` | Plot the abstracted graph through thresholding low-connectivity edges `pl.paga_compare` | Scatter and PAGA graph side-by-side @@ -113,3 +121,8 @@ --- | --- `pl.rank_genes_groups` | Plot ranking of genes using dotplot plot `pl.rank_genes_groups_violin` | Plot ranking of genes for all tested comparisons + `pl.rank_genes_groups_stacked_violin` | Plot ranking of genes as stacked violin plot + `pl.rank_genes_groups_heatmap` | Plot ranking of genes as heatmap plot + `pl.rank_genes_groups_dotplot` | Plot ranking of genes as dotplot plot + `pl.rank_genes_groups_matrixplot` | Plot ranking of genes as matrixplot plot + `pl.rank_genes_groups_tracksplot` | Plot ranking of genes as tracksplot plot diff -r f9353ee6a0d4 -r 178242b82297 cluster_reduce_dimension.xml --- a/cluster_reduce_dimension.xml Tue Aug 20 09:50:17 2024 +0000 +++ b/cluster_reduce_dimension.xml Sat Sep 14 12:45:46 2024 +0000 @@ -1,37 +1,44 @@ - - with scanpy + + and infer trajectories macros.xml - - + + + + + + + + + + + + - - + - + - + - - + + - - + ]]> + + umap-learn + leidenalg + louvain + scikit-learn + ]]> + +@CMD_ANNDATA_WRITE_OUTPUTS@ + ]]> + @@ -202,113 +234,123 @@ - - + - - - + + + - + - - + + - + + - - + + - + + + + + + + - - - - + + + - - - - - - + + + + + + + + + - + - + - + + - - + + - - - - + + + + + - - - + + + - - + + + - - + + - - + + + - + - + - + @@ -318,22 +360,16 @@ + + - - + - - - - - - -
- +
@@ -347,21 +383,23 @@ - + + + + + +
+ + - - + - - - -
- +
@@ -369,29 +407,26 @@ - + - + + + + + +
+ + - - + - - - - - - - - -
- +
@@ -400,28 +435,31 @@ - - - + + + + + + +
+ + - - + - -
- +
@@ -431,73 +469,48 @@ - - + + + + + + +
+ + - - + - - - - - - - - - - +
- -
- - - - - - - - - - - - -
- - - - - - - -
- +
- + + + + + +
+ + - - + - - - - -
- +
@@ -507,28 +520,25 @@ - - + + + + + +
+ + - - + - - - - - - - -
- +
@@ -544,22 +554,22 @@ - + - + +
+ + - - -
- +
@@ -568,42 +578,24 @@ - -
- - - - - - - - - -
- -
- + - - - - + + -
+ + - - + - -
- +
@@ -614,18 +606,48 @@ - + + + + + +
+ + + + + + + + +
+ +
+ + + + + + + + + + + + + +
+ + - - + -
- +
@@ -634,10 +656,16 @@ - + + + + + +
`_ + Cluster cells into subgroups (`tl.leiden`) ========================================== @@ -660,21 +689,13 @@ More details on the `tl.leiden scanpy documentation `_ + Computes PCA (principal component analysis) coordinates, loadings and variance decomposition, using `pp.pca` ============================================================================================================ -@CMD_pca_outputs@ - More details on the `pp.pca scanpy documentation `__ -Computes PCA (principal component analysis) coordinates, loadings and variance decomposition, using `tl.pca` -============================================================================================================ - -@CMD_pca_outputs@ - -More details on the `tl.pca scanpy documentation -`__ Diffusion Maps, using `tl.diffmap` ================================== @@ -698,6 +719,7 @@ More details on the `tl.diffmap scanpy documentation `__ + t-distributed stochastic neighborhood embedding (tSNE), using `tl.tsne` ======================================================================= @@ -710,6 +732,7 @@ More details on the `tl.tsne scanpy documentation `__ + Embed the neighborhood graph using UMAP, using `tl.umap` ======================================================== @@ -721,8 +744,8 @@ nearest-neighbor distances in the embedding such that these best match the distribution of distances in the high-dimensional space. We use the implementation of `umap-learn `__ -(McInnes et al, 2018). For a few comparisons of UMAP with tSNE, see this `preprint -`__. +(McInnes et al, 2018). For a few comparisons of UMAP with tSNE, see this `paper +`__. The UMAP coordinates of data are added to the return AnnData in the multi-dimensional observations annotation (obsm). This data is accessible using the inspect tool for AnnData @@ -730,6 +753,7 @@ More details on the `tl.umap scanpy documentation `__ + Force-directed graph drawing, using `tl.draw_graph` =================================================== @@ -749,6 +773,7 @@ More details on the `tl.draw_graph scanpy documentation `__ + Infer progression of cells through geodesic distance along the graph (`tl.dpt`) =============================================================================== @@ -808,6 +833,18 @@ More details on the `tl.paga scanpy documentation `_ - ]]> + + +Calculates the density of cells in an embedding (per condition). (`tl.embedding_density`) +========================================================================================= + +Gaussian kernel density estimation is used to calculate the density of cells in an embedded space. This can be performed per category over a categorical cell annotation. + +Note that density values are scaled to be between 0 and 1. Thus, the density value at each cell is only comparable to densities in the same category. + +More details on the `tl.embedding_density scanpy documentation +`_ + ]]> +
diff -r f9353ee6a0d4 -r 178242b82297 macros.xml --- a/macros.xml Tue Aug 20 09:50:17 2024 +0000 +++ b/macros.xml Sat Sep 14 12:45:46 2024 +0000 @@ -1,17 +1,15 @@ - 1.9.6 - 4 - 21.09 + 1.10.2 + 0 + 21.09 scanpy - loompy - leidenalg - louvain - pandas - matplotlib - seaborn - magic-impute + anndata + numpy + pandas + scipy + statsmodels @@ -22,7 +20,7 @@ - + @@ -31,28 +29,13 @@ 10.1093/gigascience/giaa102 - - - - '$hidden_output' && -python '$script_file' >> '$hidden_output' && -ls . >> '$hidden_output' && -touch 'anndata_info.txt' && -cat 'anndata_info.txt' @CMD_prettify_stdout@ - ]]> - - - + + + - + @@ -62,58 +45,55 @@ - + - -
- +
- - + + + + advanced_common['show_log'] + + + + + - - - - + + + - + - + + - @@ -393,141 +373,6 @@ - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - 0: - #set $var_group_positions=[] - #set $var_group_labels=[] - #for $i, $s in enumerate($method.var_group_positions) - #silent $var_group_positions.append((int($s.start), int($s.end))) - #silent $var_group_labels.append(str($s.label)) - #end for - var_group_positions=$var_group_positions, - var_group_labels=$var_group_labels, - #end if - #if str($method.var_group_rotation) != '' - var_group_rotation=$method.var_group_rotation, - #end if - #if $method.figsize.test == 'yes' - figsize=($method.figsize.width, $method.figsize.height), - #end if - #if $method.layer - layer='$method.layer', - #end if - ]]> @@ -679,500 +524,298 @@ - + - - - - - - - - - - -
- - - - - - -
+ + - - - - - - - - - - - - - - - - - - - - - - - - - - - - + + + - + + + + + + + + + + + + + + + + + + + '$hidden_output' && +python '$script_file' >> '$hidden_output' && +ls . >> '$hidden_output' && +touch 'anndata_info.txt' && +cat 'anndata_info.txt' @CMD_PRETTIFY_STDOUT@ + ]]> + + + + + + + + + + + + - -
- - - - - - - - - - - - - -
-
- - - - - - - - - - + density_norm='$method.violin_plot.density_norm', + ]]> + + + + + + + + + + + - - - - - - - - - - - - 0 - #set $components=[] - #for $i, $s in enumerate($method.plot.components) - #silent $components.append(str($s.axis1) + ',' + str($s.axis2)) - #end for - components=$components, -#end if - ]]> - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - + + + + - - - - - - - - - - - - - - - - - - - - - + + + + - - - - - - - - - - - - - - - - - - - - - + + + + + + + - - - - + + + + - + + + + - - - - - - - - - - - -
- - - - - - - - - - - - - -
-
- - - - - - - - - - - - - - - - - - - + + + - - + + - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - + + + + + - + + + + + + + + + + + + + + + + - - + + + + + + + + + - - - - + + + + + + + + - - + + - - - - - - - + + + + + + + + - 0: + #set $var_group_positions=[] + #set $var_group_labels=[] + #for $i, $s in enumerate($method.var_group_positions) + #silent $var_group_positions.append((int($s.start), int($s.end))) + #silent $var_group_labels.append(str($s.label)) + #end for + var_group_positions=$var_group_positions, + var_group_labels=$var_group_labels, #end if - #if str($method.dot_max) != '' - dot_max=$method.dot_max, + #if str($method.var_group_rotation) != '': + var_group_rotation=$method.var_group_rotation, #end if - #if str($method.dot_min) != '' - dot_min=$method.dot_min, - #end if - @CMD_params_matplotlib_pyplot_scatter@ + @CMD_PARAMS_FIGSIZE@ + @CMD_PARAM_LAYER@ ]]> - - - - + + + + + + + + + + + + - + +
+ + + + + +
+
+ + + + +
- - + + @@ -1194,106 +837,627 @@ - +
- - - - - - - - - + +
- - - +
+ + + +
- + + + + + + + + + + + + + + + + + + + + + + + + + + + +
+ + + + + + + + + + + + + + +
+
+ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + 0: + #set $components=[] + #for $i, $s in enumerate($method.plot.components) + #silent $components.append(str($s.axis1) + ',' + str($s.axis2)) + #end for + components=$components, +#end if + ]]> + + + + + + + + + + + + + + + + + + + + - + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + +
+ + + + + + + + + + + + + + + + +
+
+ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + +
- +
- - - - - - + + + + + +
- + + + + + + + + + + + + + + + + + +
diff -r f9353ee6a0d4 -r 178242b82297 test-data/cosg.rank_genes_groups.newton-cg.pbmc68k_highly_reduced_1.h5ad Binary file test-data/cosg.rank_genes_groups.newton-cg.pbmc68k_highly_reduced_1.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/external.pp.bbknn.krumsiek11.h5ad Binary file test-data/external.pp.bbknn.krumsiek11.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/external.pp.magic.all_genes.krumsiek11.h5ad Binary file test-data/external.pp.magic.all_genes.krumsiek11.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/external.pp.magic.pca_only.krumsiek11.h5ad Binary file test-data/external.pp.magic.pca_only.krumsiek11.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pbmc68k_reduced.h5ad Binary file test-data/pbmc68k_reduced.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.clustermap.krumsiek11.png Binary file test-data/pl.clustermap.krumsiek11.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.png Binary file test-data/pl.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.dotplot.krumsiek11.png Binary file test-data/pl.dotplot.krumsiek11.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.dpt_timeseries.dpt.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.png Binary file test-data/pl.dpt_timeseries.dpt.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.draw_graph.png Binary file test-data/pl.draw_graph.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.embedding_density.pbmc68k_reduced.png Binary file test-data/pl.embedding_density.pbmc68k_reduced.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.heatmap.krumsiek11.png Binary file test-data/pl.heatmap.krumsiek11.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.highest_expr_genes.filter_genes_dispersion.krumsiek11-seurat.png Binary file test-data/pl.highest_expr_genes.filter_genes_dispersion.krumsiek11-seurat.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.highly_variable_genes.seurat.blobs.png Binary file test-data/pl.highly_variable_genes.seurat.blobs.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.matrixplot.krumsiek11.png Binary file test-data/pl.matrixplot.krumsiek11.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.paga.paul15_gauss_braycurtis.png Binary file test-data/pl.paga.paul15_gauss_braycurtis.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.paga_compare.paul15_gauss_braycurtis.png Binary file test-data/pl.paga_compare.paul15_gauss_braycurtis.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.pca.pbmc68k_reduced.CD3D_CD79A_components_2d.pdf Binary file test-data/pl.pca.pbmc68k_reduced.CD3D_CD79A_components_2d.pdf has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.pca_loadings.pp.pca.krumsiek11.png Binary file test-data/pl.pca_loadings.pp.pca.krumsiek11.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.pca_overview.pp.pca.krumsiek11.png Binary file test-data/pl.pca_overview.pp.pca.krumsiek11.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.pca_variance_ratio.pp.pca.krumsiek11.png Binary file test-data/pl.pca_variance_ratio.pp.pca.krumsiek11.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.rank_genes_groups.newton-cg.pbmc68k_highly_reduced_marker_1.png Binary file test-data/pl.rank_genes_groups.newton-cg.pbmc68k_highly_reduced_marker_1.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.rank_genes_groups.newton-cg.pbmc68k_highly_reduced_marker_filtered_1.png Binary file test-data/pl.rank_genes_groups.newton-cg.pbmc68k_highly_reduced_marker_filtered_1.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.rank_genes_groups.rank_genes_groups.krumsiek11.png Binary file test-data/pl.rank_genes_groups.rank_genes_groups.krumsiek11.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.rank_genes_groups_dotplot.rank_genes_groups.krumsiek11.png Binary file test-data/pl.rank_genes_groups_dotplot.rank_genes_groups.krumsiek11.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.rank_genes_groups_heatmap.rank_genes_groups.krumsiek11.png Binary file test-data/pl.rank_genes_groups_heatmap.rank_genes_groups.krumsiek11.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.rank_genes_groups_matrixplot.rank_genes_groups.krumsiek11.png Binary file test-data/pl.rank_genes_groups_matrixplot.rank_genes_groups.krumsiek11.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.rank_genes_groups_stacked_violin.rank_genes_groups.krumsiek11.png Binary file test-data/pl.rank_genes_groups_stacked_violin.rank_genes_groups.krumsiek11.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.rank_genes_groups_tracksplot.newton-cg.pbmc68k_highly_reduced_marker_filtered_1.png Binary file test-data/pl.rank_genes_groups_tracksplot.newton-cg.pbmc68k_highly_reduced_marker_filtered_1.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.rank_genes_groups_violin.Ery.png Binary file test-data/pl.rank_genes_groups_violin.Ery.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.rank_genes_groups_violin.Mk.png Binary file test-data/pl.rank_genes_groups_violin.Mk.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.rank_genes_groups_violin.Mo.png Binary file test-data/pl.rank_genes_groups_violin.Mo.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.rank_genes_groups_violin.Neu.png Binary file test-data/pl.rank_genes_groups_violin.Neu.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.rank_genes_groups_violin.progenitor.png Binary file test-data/pl.rank_genes_groups_violin.progenitor.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.scatter.krumsiek11.png Binary file test-data/pl.scatter.krumsiek11.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.scatter.pbmc68k_reduced.png Binary file test-data/pl.scatter.pbmc68k_reduced.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.scatter.umap.pbmc68k_reduced.png Binary file test-data/pl.scatter.umap.pbmc68k_reduced.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.scrublet_score_distribution.png Binary file test-data/pl.scrublet_score_distribution.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.stacked_violin.krumsiek11.png Binary file test-data/pl.stacked_violin.krumsiek11.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.stacked_violin_pp.filter_genes_dispersion.krumsiek11-seurat.png Binary file test-data/pl.stacked_violin_pp.filter_genes_dispersion.krumsiek11-seurat.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.tsne.krumsiek11.png Binary file test-data/pl.tsne.krumsiek11.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.umap.neighbors_umap_euclidean.recipe_weinreb17.paul15_subsample.png Binary file test-data/pl.umap.neighbors_umap_euclidean.recipe_weinreb17.paul15_subsample.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pl.violin.pbmc68k_reduced_custom.png Binary file test-data/pl.violin.pbmc68k_reduced_custom.png has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pp.calculate_qc_metrics.sparce_csr_matrix.h5ad Binary file test-data/pp.calculate_qc_metrics.sparce_csr_matrix.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pp.downsample_counts.random-randint.h5ad Binary file test-data/pp.downsample_counts.random-randint.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pp.filter_cells.krumsiek11-max_genes.h5ad Binary file test-data/pp.filter_cells.krumsiek11-max_genes.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pp.filter_cells.krumsiek11-min_counts.h5ad Binary file test-data/pp.filter_cells.krumsiek11-min_counts.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pp.filter_genes.krumsiek11-min_counts.h5ad Binary file test-data/pp.filter_genes.krumsiek11-min_counts.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pp.filter_rank_genes_groups.h5ad Binary file test-data/pp.filter_rank_genes_groups.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pp.highly_variable_genes.krumsiek11-cell_ranger.h5ad Binary file test-data/pp.highly_variable_genes.krumsiek11-cell_ranger.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pp.log1p.krumsiek11.h5ad Binary file test-data/pp.log1p.krumsiek11.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pp.normalize_total.krumsiek11.h5ad Binary file test-data/pp.normalize_total.krumsiek11.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pp.pca.krumsiek11.batch.h5ad Binary file test-data/pp.pca.krumsiek11.batch.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pp.pca.krumsiek11_chunk.h5ad Binary file test-data/pp.pca.krumsiek11_chunk.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pp.recipe_seurat.recipe_zheng17.h5ad Binary file test-data/pp.recipe_seurat.recipe_zheng17.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pp.recipe_weinreb17.paul15_subsample.updated.h5ad Binary file test-data/pp.recipe_weinreb17.paul15_subsample.updated.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pp.recipe_zheng17.random-randint.h5ad Binary file test-data/pp.recipe_zheng17.random-randint.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pp.scale.krumsiek11.h5ad Binary file test-data/pp.scale.krumsiek11.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pp.scale_max_value.krumsiek11.h5ad Binary file test-data/pp.scale_max_value.krumsiek11.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pp.scrublet.krumsiek11.h5ad Binary file test-data/pp.scrublet.krumsiek11.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pp.sqrt.krumsiek11.h5ad Binary file test-data/pp.sqrt.krumsiek11.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pp.subsample.krumsiek11_fraction.h5ad Binary file test-data/pp.subsample.krumsiek11_fraction.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/pp.subsample.krumsiek11_n_obs.h5ad Binary file test-data/pp.subsample.krumsiek11_n_obs.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/random-randint.h5ad Binary file test-data/random-randint.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/sparce_csr_matrix.h5ad Binary file test-data/sparce_csr_matrix.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/tl.embedding_density.umap.neighbors_umap_euclidean.recipe_weinreb17.paul15_subsample.h5ad Binary file test-data/tl.embedding_density.umap.neighbors_umap_euclidean.recipe_weinreb17.paul15_subsample.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/tl.embedding_density.umap.pbmc68k_reduced.h5ad Binary file test-data/tl.embedding_density.umap.pbmc68k_reduced.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/tl.leiden.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad Binary file test-data/tl.leiden.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/tl.louvain.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad Binary file test-data/tl.louvain.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/tl.paga.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad Binary file test-data/tl.paga.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/tl.rank_genes_groups.liblinear.krumsiek11.h5ad Binary file test-data/tl.rank_genes_groups.liblinear.krumsiek11.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/tl.rank_genes_groups.newton-cg.pbmc68k_reduced.h5ad Binary file test-data/tl.rank_genes_groups.newton-cg.pbmc68k_reduced.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/tl.score_genes.krumsiek11.h5ad Binary file test-data/tl.score_genes.krumsiek11.h5ad has changed diff -r f9353ee6a0d4 -r 178242b82297 test-data/tl.score_genes_cell_cycle.krumsiek11.h5ad Binary file test-data/tl.score_genes_cell_cycle.krumsiek11.h5ad has changed