# HG changeset patch # User iuc # Date 1699454840 0 # Node ID 95777145cb92e676bb7f9d4b39bcd6cfc492e606 # Parent aa0c474463c21274f1221c76a49c1f79a5953a7c planemo upload for repository https://github.com/galaxyproject/tools-iuc/tree/master/tools/scanpy/ commit aba2a85f5da6e1094f382d1f0d94c4b8f2544a7d diff -r aa0c474463c2 -r 95777145cb92 macros.xml --- a/macros.xml Wed Sep 22 21:13:39 2021 +0000 +++ b/macros.xml Wed Nov 08 14:47:20 2023 +0000 @@ -1,12 +1,16 @@ - 1.7.1 - 19.01 + 1.9.6 + 22.05 scanpy - loompy - leidenalg + loompy + leidenalg + louvain + pandas + matplotlib + seaborn @@ -15,9 +19,15 @@ scanpy + + + + + 10.1186/s13059-017-1382-0 + 10.1093/gigascience/giaa102 @@ -56,7 +66,7 @@ @@ -66,12 +76,12 @@ - + advanced_common['show_log'] @@ -875,7 +885,7 @@ - + @@ -979,7 +989,7 @@ @CMD_param_legend_fontsize@ legend_fontweight='$method.plot.legend_fontweight', @CMD_param_size@ - #if str($method.plot.color_map) != 'None' + #if str($method.plot.color_map) != '' color_map='$method.plot.color_map', #end if #if str($method.plot.palette) != '' diff -r aa0c474463c2 -r 95777145cb92 plot.xml --- a/plot.xml Wed Sep 22 21:13:39 2021 +0000 +++ b/plot.xml Wed Nov 08 14:47:20 2023 +0000 @@ -1,9 +1,9 @@ - + with scanpy - macros.xml + @@ -21,11 +21,32 @@ #if $method.method == 'pl.scatter' +#if $method.type.type == 'xy': +x_field='$method.type.x' +y_field='$method.type.y' + +#if $method.type.log: +if x_field in adata.obs or x_field in adata.var: + if x_field in adata.obs: + adata.obs[f"log_{x_field}"] = np.log10(adata.obs[x_field]) + elif x_field in adata.var: + adata.var[f"log_{x_field}"] = np.log10(adata.var[x_field]) + x_field=f"log_{x_field}" + +if y_field in adata.obs or y_field in adata.var: + if y_field in adata.obs: + adata.obs[f"log_{y_field}"] = np.log10(adata.obs[y_field]) + elif y_field in adata.var: + adata.var[f"log_{y_field}"] = np.log10(adata.var[y_field]) + y_field=f"log_{y_field}" +#end if +#end if + sc.pl.scatter( @CMD_param_plot_inputs@ - #if $method.type.type == 'xy' - x='$method.type.x', - y='$method.type.y', + #if $method.type.type == 'xy': + x=x_field, + y=y_field, #if str($method.type.color) != '' color='$method.type.color', #end if @@ -265,6 +286,29 @@ @CMD_pl_attribute_section@ @CMD_params_matplotlib_pyplot_scatter@) +#else if $method.method == 'pl.embedding_density' +sc.pl.embedding_density( + @CMD_param_plot_inputs@ + basis='$method.basis', + #if str($method.key) != '' + key='$method.key', + #end if + #if str($method.groupby) != '' + groupby='$method.groupby', + #end if + #if str($method.group) != '' + #set $group = ([x.strip() for x in str($method.group).split(',')]) + group=$group, + #end if + #if str($method.color_map) != '' + color_map='$method.color_map', + #end if + bg_dotsize=$method.bg_dotsize, + fg_dotsize=$method.fg_dotsize, + ncols=$method.ncols, + wspace=$method.wspace, + hspace=$method.hspace) + #else if $method.method == 'pl.dpt_groups_pseudotime' sc.pl.dpt_groups_pseudotime( @CMD_param_plot_inputs@ @@ -305,7 +349,7 @@ #set $annotations=([x.strip() for x in str($method.annotations).split(',')]) annotations=$annotations, #end if - #if str($method.color_map) != '' + #if str($method.color_map) != 'None' color_map='$method.color_map', #end if n_avg=$method.n_avg, @@ -358,6 +402,9 @@ sc.pl.rank_genes_groups_dotplot( @CMD_param_plot_inputs@ @CMD_pl_rank_genes_groups_ext@ + #if str($method.gene_symbols) != '' + gene_symbols='$method.gene_symbols', + #end if @CMD_params_plots@ @CMD_pl_dotplot@) @@ -366,6 +413,9 @@ @CMD_param_plot_inputs@ @CMD_pl_rank_genes_groups_ext@ @CMD_params_plots@ + #if str($method.gene_symbols) != '' + gene_symbols='$method.gene_symbols', + #end if @CMD_pl_heatmap@) #else if $method.method == 'pl.rank_genes_groups_matrixplot' @@ -373,6 +423,9 @@ @CMD_param_plot_inputs@ @CMD_pl_rank_genes_groups_ext@ @CMD_params_plots@ + #if str($method.gene_symbols) != '' + gene_symbols='$method.gene_symbols', + #end if @CMD_pl_matrixplot@) #else if $method.method == 'pl.rank_genes_groups_stacked_violin' @@ -380,6 +433,9 @@ @CMD_param_plot_inputs@ @CMD_pl_rank_genes_groups_ext@ @CMD_params_plots@ + #if str($method.gene_symbols) != '' + gene_symbols='$method.gene_symbols', + #end if @CMD_pl_stacked_violin@) #end if @@ -397,7 +453,6 @@ - @@ -409,15 +464,14 @@ + - @@ -436,6 +490,7 @@ + @@ -666,6 +721,27 @@ + + + + + + + + + + + + + + + + + + + + @@ -730,7 +806,7 @@ - + @@ -745,45 +821,49 @@ + + + + - + format == 'png' and method['method'] != 'pl.rank_genes_groups_violin' - + format == 'png' and method['method'] == 'pl.rank_genes_groups_violin' - - format == 'pdf' and method['method'] != pl.rank_genes_groups_violin + + format == 'pdf' and method['method'] != 'pl.rank_genes_groups_violin' - + format == 'pdf' and method['method'] == 'pl.rank_genes_groups_violin' - + format == 'svg' and method['method'] != pl.rank_genes_groups_violin - + format == 'svg' and method['method'] == 'pl.rank_genes_groups_violin' @@ -792,8 +872,8 @@ - - + + @@ -837,8 +917,8 @@ - - + + @@ -870,8 +950,8 @@ - - + + @@ -885,8 +965,8 @@ - - + + @@ -933,8 +1013,8 @@ - - + + @@ -983,8 +1063,8 @@ - - + + @@ -1042,8 +1122,8 @@ - - + + @@ -1080,8 +1160,8 @@ - - + + @@ -1137,8 +1217,8 @@ - - + + @@ -1197,8 +1277,8 @@ - - + + @@ -1232,8 +1312,8 @@ - - + + @@ -1276,8 +1356,8 @@ - - + + @@ -1316,8 +1396,8 @@ - - + + @@ -1348,8 +1428,8 @@ - - + + @@ -1375,8 +1455,8 @@ - - + + @@ -1397,8 +1477,8 @@ - - + + @@ -1453,13 +1533,13 @@ - + - - + + @@ -1477,8 +1557,8 @@ - - + + @@ -1498,8 +1578,8 @@ - - + + @@ -1541,8 +1621,8 @@ - - + + @@ -1596,8 +1676,8 @@ - - + + @@ -1656,8 +1736,8 @@ - - + + @@ -1707,8 +1787,8 @@ - - + + @@ -1763,22 +1843,48 @@ - + + + + + + + +
+ +
+ + + + + + + + +
+ + - - - - +
+ +
+ + + + + + -
!--> - - + + + @@ -1800,15 +1906,14 @@ - - - + @@ -1823,19 +1928,40 @@ -
!--> - - + + + + + + + + + + + + + + + + + + + + +
+ - - + --> + + + @@ -1855,8 +1981,8 @@ - @@ -1899,13 +2025,13 @@
- --> - - + + + @@ -1933,12 +2059,13 @@ - - + + + @@ -1969,12 +2096,13 @@ - - + + + @@ -2004,12 +2132,13 @@ - - + + + @@ -2057,6 +2186,53 @@ + + + + + + + + + + + + + + + + + +
+ + + + + + + + +
+
+
+ +
+ + + + + + + + + + + + + + + +
`__ +`__ Generic: Heatmap of the expression values of set of genes (`pl.heatmap`) ======================================================================== @@ -2078,7 +2254,7 @@ specified in `num_categories`. More details on the `scanpy documentation -`__ +`__ Generic: Makes a dot plot of the expression values (`pl.dotplot`) ================================================================= @@ -2095,7 +2271,7 @@ expressing the gene can be visualized for each cluster. More details on the `scanpy documentation -`__ +`__ Generic: Violin plot (`pl.violin`) ================================== @@ -2103,7 +2279,7 @@ Wraps `seaborn.violinplot` for `anndata.AnnData`. More details on the `scanpy documentation -`__ +`__ Generic: Stacked violin plots (`pl.stacked_violin`) =================================================== @@ -2112,7 +2288,7 @@ stacked on top of each other. Useful to visualize gene expression per cluster. More details on the `scanpy documentation -`__ +`__ Generic: Heatmap of the mean expression values per cluster (`pl.matrixplot`) ============================================================================ @@ -2123,7 +2299,7 @@ category. More details on the `scanpy documentation -`__ +`__ Generic: Hierarchically-clustered heatmap (`pl.clustermap`) =========================================================== @@ -2141,7 +2317,7 @@ Column indices, use: clustergrid.dendrogram_col.reordered_ind More details on the `scanpy documentation -`__ +`__ Preprocessing: Plot the fraction of counts assigned to each gene over all cells (`pl.highest_expr_genes`) ========================================================================================================= @@ -2153,7 +2329,7 @@ This plot is similar to the `scater` package function `plotHighestExprs(type= "highest-expression")` More details on the `scanpy documentation -`__ +`__ Preprocessing: Plot dispersions versus means for genes (`pl.highly_variable_genes`) =================================================================================== @@ -2161,25 +2337,25 @@ It produces Supp. Fig. 5c of Zheng et al. (2017) and MeanVarPlot() of Seurat. More details on the `scanpy documentation -`__ +`__ PCA: Scatter plot in PCA coordinates (`pl.pca`) =============================================== More details on the `scanpy documentation -`__ +`__ PCA: Rank genes according to contributions to PCs (`pl.pca_loadings`) ===================================================================== More details on the `scanpy documentation -`__ +`__ PCA: Plot the variance ratio (`pl.pca_variance_ratio`) ====================================================== More details on the `scanpy documentation -`__ +`__ PCA: Plot PCA results (`pl.pca_overview`) ========================================= @@ -2188,37 +2364,37 @@ if you want to change the default settings. More details on the `scanpy documentation -`__ +`__ Embedding: Scatter plot in tSNE basis (`pl.tsne`) ================================================= More details on the `scanpy documentation -`__ +`__ Embeddings: Scatter plot in UMAP basis (`pl.umap`) ================================================== More details on the `scanpy documentation -`__ +`__ Embeddings: Scatter plot in Diffusion Map basis (`pl.diffmap`) ============================================================== More details on the `scanpy documentation -`__ +`__ Branching trajectories and pseudotime, clustering: Plot groups and pseudotime (`pl.dpt_groups_pseudotime`) =========================================================================================================== More details on the `scanpy documentation -`__ +`__ Branching trajectories and pseudotime, clustering: Heatmap of pseudotime series (`pl.dpt_timeseries`) ===================================================================================================== More details on the `scanpy documentation -`__ +`__ Branching trajectories and pseudotime, clustering: Plot the abstracted graph through thresholding low-connectivity edges (`pl.paga`) @@ -2231,56 +2407,56 @@ `maxiter` parameter by 1 if the layout is flipped. More details on the `scanpy documentation -`__ +`__ Branching trajectories and pseudotime, clustering: Scatter and PAGA graph side-by-side (`pl.paga_compare`) ========================================================================================================== More details on the `scanpy documentation -`__ +`__ Branching trajectories and pseudotime, clustering: Gene expression and annotation changes along paths (`pl.paga_path`) ====================================================================================================================== More details on the `scanpy documentation -`__ +`__ Marker genes: Plot ranking of genes using dotplot plot (`pl.rank_genes_groups`) =============================================================================== More details on the `scanpy documentation -`__ +`__ Marker genes: Plot ranking of genes as violin plot (`pl.rank_genes_groups_violin`) ================================================================================== More details on the `scanpy documentation -`__ +`__ Marker genes: Plot ranking of genes as dotplot plot (`pl.rank_genes_groups_dotplot`) ==================================================================================== More details on the `scanpy documentation -`__ +`__ Marker genes: Plot ranking of genes as heatmap plot (`pl.rank_genes_groups_heatmap`) ==================================================================================== More details on the `scanpy documentation -`__ +`__ Marker genes: Plot ranking of genes as matrixplot plot (`pl.rank_genes_groups_matrixplot`) ========================================================================================== More details on the `scanpy documentation -`__ +`__ Marker genes: Plot ranking of genes as stacked violin plot (`pl.rank_genes_groups_stacked_violin`) ================================================================================================== More details on the `scanpy documentation -`__ +`__ ]]>
diff -r aa0c474463c2 -r 95777145cb92 test-data/blobs.h5ad Binary file test-data/blobs.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/krumsiek11.h5ad Binary file test-data/krumsiek11.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pbmc68k_reduced.h5ad Binary file test-data/pbmc68k_reduced.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pl.clustermap.krumsiek11.png Binary file test-data/pl.clustermap.krumsiek11.png has changed diff -r aa0c474463c2 -r 95777145cb92 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 aa0c474463c2 -r 95777145cb92 test-data/pl.dotplot.krumsiek11.png Binary file test-data/pl.dotplot.krumsiek11.png has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pl.dpt_groups_pseudotime.dpt.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.png Binary file test-data/pl.dpt_groups_pseudotime.dpt.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.png has changed diff -r aa0c474463c2 -r 95777145cb92 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 aa0c474463c2 -r 95777145cb92 test-data/pl.draw_graph.png Binary file test-data/pl.draw_graph.png has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pl.embedding_density.pbmc68k_reduced.png Binary file test-data/pl.embedding_density.pbmc68k_reduced.png has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pl.heatmap.krumsiek11.png Binary file test-data/pl.heatmap.krumsiek11.png has changed diff -r aa0c474463c2 -r 95777145cb92 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 aa0c474463c2 -r 95777145cb92 test-data/pl.highly_variable_genes.seurat.blobs.png Binary file test-data/pl.highly_variable_genes.seurat.blobs.png has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pl.matrixplot.krumsiek11.png Binary file test-data/pl.matrixplot.krumsiek11.png has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pl.paga.paul15_gauss_braycurtis.png Binary file test-data/pl.paga.paul15_gauss_braycurtis.png has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pl.paga_compare.paul15_gauss_braycurtis.png Binary file test-data/pl.paga_compare.paul15_gauss_braycurtis.png has changed diff -r aa0c474463c2 -r 95777145cb92 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 aa0c474463c2 -r 95777145cb92 test-data/pl.pca_loadings.pp.pca.krumsiek11.png Binary file test-data/pl.pca_loadings.pp.pca.krumsiek11.png has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pl.pca_overview.pp.pca.krumsiek11.png Binary file test-data/pl.pca_overview.pp.pca.krumsiek11.png has changed diff -r aa0c474463c2 -r 95777145cb92 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 aa0c474463c2 -r 95777145cb92 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 aa0c474463c2 -r 95777145cb92 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 aa0c474463c2 -r 95777145cb92 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 aa0c474463c2 -r 95777145cb92 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 aa0c474463c2 -r 95777145cb92 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 aa0c474463c2 -r 95777145cb92 test-data/pl.rank_genes_groups_violin.Ery.png Binary file test-data/pl.rank_genes_groups_violin.Ery.png has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pl.rank_genes_groups_violin.Mk.png Binary file test-data/pl.rank_genes_groups_violin.Mk.png has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pl.rank_genes_groups_violin.Mo.png Binary file test-data/pl.rank_genes_groups_violin.Mo.png has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pl.rank_genes_groups_violin.Neu.png Binary file test-data/pl.rank_genes_groups_violin.Neu.png has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pl.rank_genes_groups_violin.progenitor.png Binary file test-data/pl.rank_genes_groups_violin.progenitor.png has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pl.scatter.krumsiek11.png Binary file test-data/pl.scatter.krumsiek11.png has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pl.scatter.pbmc68k_reduced.png Binary file test-data/pl.scatter.pbmc68k_reduced.png has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pl.scatter.umap.pbmc68k_reduced.png Binary file test-data/pl.scatter.umap.pbmc68k_reduced.png has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pl.stacked_violin.krumsiek11.png Binary file test-data/pl.stacked_violin.krumsiek11.png has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pl.tsne.krumsiek11.png Binary file test-data/pl.tsne.krumsiek11.png has changed diff -r aa0c474463c2 -r 95777145cb92 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 aa0c474463c2 -r 95777145cb92 test-data/pl.violin.pbmc68k_reduced_custom.png Binary file test-data/pl.violin.pbmc68k_reduced_custom.png has changed diff -r aa0c474463c2 -r 95777145cb92 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 aa0c474463c2 -r 95777145cb92 test-data/pp.combat.blobs.h5ad Binary file test-data/pp.combat.blobs.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pp.downsample_counts.random-randint.h5ad Binary file test-data/pp.downsample_counts.random-randint.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pp.filter_cells.krumsiek11-max_genes.h5ad Binary file test-data/pp.filter_cells.krumsiek11-max_genes.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pp.filter_cells.krumsiek11-min_counts.h5ad Binary file test-data/pp.filter_cells.krumsiek11-min_counts.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pp.filter_genes.krumsiek11-min_counts.h5ad Binary file test-data/pp.filter_genes.krumsiek11-min_counts.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 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 aa0c474463c2 -r 95777145cb92 test-data/pp.highly_variable_genes.seurat.blobs.h5ad Binary file test-data/pp.highly_variable_genes.seurat.blobs.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pp.log1p.krumsiek11.h5ad Binary file test-data/pp.log1p.krumsiek11.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pp.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad Binary file test-data/pp.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pp.neighbors_umap_euclidean.recipe_weinreb17.paul15_subsample.h5ad Binary file test-data/pp.neighbors_umap_euclidean.recipe_weinreb17.paul15_subsample.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pp.normalize_total.krumsiek11.h5ad Binary file test-data/pp.normalize_total.krumsiek11.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pp.pca.krumsiek11.h5ad Binary file test-data/pp.pca.krumsiek11.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pp.pca.krumsiek11_chunk.h5ad Binary file test-data/pp.pca.krumsiek11_chunk.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pp.recipe_seurat.recipe_zheng17.h5ad Binary file test-data/pp.recipe_seurat.recipe_zheng17.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pp.recipe_weinreb17.paul15_subsample.h5ad Binary file test-data/pp.recipe_weinreb17.paul15_subsample.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pp.recipe_weinreb17.paul15_subsample.updated.h5ad Binary file test-data/pp.recipe_weinreb17.paul15_subsample.updated.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pp.recipe_zheng17.random-randint.h5ad Binary file test-data/pp.recipe_zheng17.random-randint.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pp.regress_out.krumsiek11.h5ad Binary file test-data/pp.regress_out.krumsiek11.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pp.scale.krumsiek11.h5ad Binary file test-data/pp.scale.krumsiek11.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pp.scale_max_value.krumsiek11.h5ad Binary file test-data/pp.scale_max_value.krumsiek11.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pp.sqrt.krumsiek11.h5ad Binary file test-data/pp.sqrt.krumsiek11.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pp.subsample.krumsiek11_fraction.h5ad Binary file test-data/pp.subsample.krumsiek11_fraction.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/pp.subsample.krumsiek11_n_obs.h5ad Binary file test-data/pp.subsample.krumsiek11_n_obs.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/sparce_csr_matrix.h5ad Binary file test-data/sparce_csr_matrix.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/tl.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad Binary file test-data/tl.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/tl.dpt.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad Binary file test-data/tl.dpt.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/tl.draw_graph.pp.neighbors_umap_euclidean.recipe_weinreb17.paul15_subsample.h5ad Binary file test-data/tl.draw_graph.pp.neighbors_umap_euclidean.recipe_weinreb17.paul15_subsample.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 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 aa0c474463c2 -r 95777145cb92 test-data/tl.embedding_density.umap.pbmc68k_reduced.h5ad Binary file test-data/tl.embedding_density.umap.pbmc68k_reduced.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 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 aa0c474463c2 -r 95777145cb92 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 aa0c474463c2 -r 95777145cb92 test-data/tl.paga.neighbors.paul15_gauss_braycurtis.h5ad Binary file test-data/tl.paga.neighbors.paul15_gauss_braycurtis.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 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 aa0c474463c2 -r 95777145cb92 test-data/tl.pca.krumsiek11.h5ad Binary file test-data/tl.pca.krumsiek11.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/tl.rank_genes_groups.krumsiek11.h5ad Binary file test-data/tl.rank_genes_groups.krumsiek11.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/tl.rank_genes_groups.liblinear.krumsiek11.h5ad Binary file test-data/tl.rank_genes_groups.liblinear.krumsiek11.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 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 aa0c474463c2 -r 95777145cb92 test-data/tl.score_genes.krumsiek11.h5ad Binary file test-data/tl.score_genes.krumsiek11.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/tl.score_genes_cell_cycle.krumsiek11.h5ad Binary file test-data/tl.score_genes_cell_cycle.krumsiek11.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/tl.tsne.krumsiek11.h5ad Binary file test-data/tl.tsne.krumsiek11.h5ad has changed diff -r aa0c474463c2 -r 95777145cb92 test-data/tl.umap.neighbors_umap_euclidean.recipe_weinreb17.paul15_subsample.h5ad Binary file test-data/tl.umap.neighbors_umap_euclidean.recipe_weinreb17.paul15_subsample.h5ad has changed