# HG changeset patch # User iuc # Date 1699454789 0 # Node ID edec35114f72669947ab6b0011f84d3fed9099cc # Parent aaa5da8e73a98ed45e0fb915660a42fac836847f planemo upload for repository https://github.com/galaxyproject/tools-iuc/tree/master/tools/scanpy/ commit aba2a85f5da6e1094f382d1f0d94c4b8f2544a7d diff -r aaa5da8e73a9 -r edec35114f72 cluster_reduce_dimension.xml --- a/cluster_reduce_dimension.xml Wed Sep 22 21:09:55 2021 +0000 +++ b/cluster_reduce_dimension.xml Wed Nov 08 14:46:29 2023 +0000 @@ -1,6 +1,5 @@ with scanpy - macros.xml @@ -20,7 +19,7 @@ - + @@ -61,8 +60,8 @@ use_highly_variable=$method.use_highly_variable ]]> + - louvain Force-directed graph drawing, using 'tl.draw_graph' + @@ -288,15 +301,26 @@ - + + + + + + + + + + + + - - + + @@ -326,8 +350,8 @@ - - + + @@ -352,8 +376,8 @@ - - + + @@ -384,8 +408,8 @@ - @@ -397,21 +421,24 @@ - - - - - - - - - - +
+ +
+ + + + + + + + + + +
- --> - - + + @@ -441,8 +468,8 @@ - - + + @@ -458,8 +485,8 @@ - - + + @@ -486,8 +513,8 @@ - - + + @@ -524,8 +551,8 @@ - - + + @@ -544,8 +571,8 @@ - - + + @@ -566,8 +593,8 @@ - - + + @@ -590,6 +617,26 @@ + + + + + + + + +
+ +
+ + + + + + + + +
`_ +`_ Cluster cells into subgroups (`tl.leiden`) ========================================== @@ -612,7 +659,7 @@ The Louvain algorithm has been proposed for single-cell analysis by Levine et al, 2015. More details on the `tl.leiden scanpy documentation -`_ +`_ Computes PCA (principal component analysis) coordinates, loadings and variance decomposition, using `pp.pca` ============================================================================================================ @@ -620,7 +667,7 @@ @CMD_pca_outputs@ More details on the `pp.pca scanpy documentation -`__ +`__ Computes PCA (principal component analysis) coordinates, loadings and variance decomposition, using `tl.pca` ============================================================================================================ @@ -628,7 +675,7 @@ @CMD_pca_outputs@ More details on the `tl.pca scanpy documentation -`__ +`__ Diffusion Maps, using `tl.diffmap` ================================== @@ -645,24 +692,24 @@ `method=='umap'`. Differences between these options shouldn't usually be dramatic. -The diffusion map representation of data are added to the return AnnData in the multi-dimensional -observations annotation (obsm). It is the right eigen basis of the transition matrix with eigenvectors +The diffusion map representation of data are added to the return AnnData in the multi-dimensional +observations annotation (obsm). It is the right eigen basis of the transition matrix with eigenvectors as colum. It can be accessed using the inspect tool for AnnData More details on the `tl.diffmap scanpy documentation -`__ +`__ t-distributed stochastic neighborhood embedding (tSNE), using `tl.tsne` ======================================================================= t-distributed stochastic neighborhood embedding (tSNE) (Maaten et al, 2008) has been proposed for visualizating single-cell data by (Amir et al, 2013). Here, by default, -we use the implementation of *scikit-learn* (Pedregosa et al, 2011). +we use the implementation of *scikit-learn* (Pedregosa et al, 2011). It returns `X_tsne`, tSNE coordinates of data. More details on the `tl.tsne scanpy documentation -`__ +`__ Embed the neighborhood graph using UMAP, using `tl.umap` ======================================================== @@ -678,30 +725,30 @@ (McInnes et al, 2018). For a few comparisons of UMAP with tSNE, see this `preprint `__. -The UMAP coordinates of data are added to the return AnnData in the multi-dimensional +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 More details on the `tl.umap scanpy documentation -`__ +`__ Force-directed graph drawing, using `tl.draw_graph` =================================================== -Force-directed graph drawing describes a class of long-established algorithms for visualizing graphs. -It has been suggested for visualizing single-cell data by Islam et al, 11. -Many other layouts as implemented in igraph are available. Similar approaches have been used by +Force-directed graph drawing describes a class of long-established algorithms for visualizing graphs. +It has been suggested for visualizing single-cell data by Islam et al, 11. +Many other layouts as implemented in igraph are available. Similar approaches have been used by Zunder et al, 2015 or Weinreb et al, 2016. -This is an alternative to tSNE that often preserves the topology of the data better. +This is an alternative to tSNE that often preserves the topology of the data better. This requires to run `pp.neighbors`, first. The default layout (ForceAtlas2) uses the package fa2. -The coordinates of graph layout are added to the return AnnData in the multi-dimensional +The coordinates of graph layout are added to the return AnnData in the multi-dimensional observations annotation (obsm). This data is accessible using the inspect tool for AnnData. More details on the `tl.draw_graph scanpy documentation -`__ +`__ Infer progression of cells through geodesic distance along the graph (`tl.dpt`) =============================================================================== @@ -714,7 +761,7 @@ `n_branchings>1`. We recommend, however, to only use `tl.dpt` for computing pseudotime (`n_branchings=0`) and to detect branchings via `paga`. For pseudotime, you need -to annotate your data with a root cell. +to annotate your data with a root cell. This requires to run `pp.neighbors`, first. In order to reproduce the original implementation of DPT, use `method=='gauss'` in @@ -730,7 +777,7 @@ The tool is similar to the R package `destiny` of Angerer et al (2016). More details on the `tl.dpt scanpy documentation -`_ +`_ Generate cellular maps of differentiation manifolds with complex topologies (`tl.paga`) @@ -761,7 +808,7 @@ These datasets are stored in the unstructured annotation (uns) and can be accessed using the inspect tool for AnnData objects More details on the `tl.paga scanpy documentation -`_ +`_ ]]>
diff -r aaa5da8e73a9 -r edec35114f72 macros.xml --- a/macros.xml Wed Sep 22 21:09:55 2021 +0000 +++ b/macros.xml Wed Nov 08 14:46:29 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 aaa5da8e73a9 -r edec35114f72 test-data/blobs.h5ad Binary file test-data/blobs.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/krumsiek11.h5ad Binary file test-data/krumsiek11.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pbmc68k_reduced.h5ad Binary file test-data/pbmc68k_reduced.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pl.clustermap.krumsiek11.png Binary file test-data/pl.clustermap.krumsiek11.png has changed diff -r aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 test-data/pl.dotplot.krumsiek11.png Binary file test-data/pl.dotplot.krumsiek11.png has changed diff -r aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 test-data/pl.draw_graph.png Binary file test-data/pl.draw_graph.png has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pl.embedding_density.pbmc68k_reduced.png Binary file test-data/pl.embedding_density.pbmc68k_reduced.png has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pl.heatmap.krumsiek11.png Binary file test-data/pl.heatmap.krumsiek11.png has changed diff -r aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 test-data/pl.highly_variable_genes.seurat.blobs.png Binary file test-data/pl.highly_variable_genes.seurat.blobs.png has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pl.matrixplot.krumsiek11.png Binary file test-data/pl.matrixplot.krumsiek11.png has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pl.paga.paul15_gauss_braycurtis.png Binary file test-data/pl.paga.paul15_gauss_braycurtis.png has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pl.paga_compare.paul15_gauss_braycurtis.png Binary file test-data/pl.paga_compare.paul15_gauss_braycurtis.png has changed diff -r aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 test-data/pl.pca_loadings.pp.pca.krumsiek11.png Binary file test-data/pl.pca_loadings.pp.pca.krumsiek11.png has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pl.pca_overview.pp.pca.krumsiek11.png Binary file test-data/pl.pca_overview.pp.pca.krumsiek11.png has changed diff -r aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 test-data/pl.rank_genes_groups_violin.Ery.png Binary file test-data/pl.rank_genes_groups_violin.Ery.png has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pl.rank_genes_groups_violin.Mk.png Binary file test-data/pl.rank_genes_groups_violin.Mk.png has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pl.rank_genes_groups_violin.Mo.png Binary file test-data/pl.rank_genes_groups_violin.Mo.png has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pl.rank_genes_groups_violin.Neu.png Binary file test-data/pl.rank_genes_groups_violin.Neu.png has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pl.rank_genes_groups_violin.progenitor.png Binary file test-data/pl.rank_genes_groups_violin.progenitor.png has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pl.scatter.krumsiek11.png Binary file test-data/pl.scatter.krumsiek11.png has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pl.scatter.pbmc68k_reduced.png Binary file test-data/pl.scatter.pbmc68k_reduced.png has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pl.scatter.umap.pbmc68k_reduced.png Binary file test-data/pl.scatter.umap.pbmc68k_reduced.png has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pl.stacked_violin.krumsiek11.png Binary file test-data/pl.stacked_violin.krumsiek11.png has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pl.tsne.krumsiek11.png Binary file test-data/pl.tsne.krumsiek11.png has changed diff -r aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 test-data/pl.violin.pbmc68k_reduced_custom.png Binary file test-data/pl.violin.pbmc68k_reduced_custom.png has changed diff -r aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 test-data/pp.combat.blobs.h5ad Binary file test-data/pp.combat.blobs.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pp.downsample_counts.random-randint.h5ad Binary file test-data/pp.downsample_counts.random-randint.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pp.filter_cells.krumsiek11-max_genes.h5ad Binary file test-data/pp.filter_cells.krumsiek11-max_genes.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pp.filter_cells.krumsiek11-min_counts.h5ad Binary file test-data/pp.filter_cells.krumsiek11-min_counts.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pp.filter_genes.krumsiek11-min_counts.h5ad Binary file test-data/pp.filter_genes.krumsiek11-min_counts.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 test-data/pp.highly_variable_genes.seurat.blobs.h5ad Binary file test-data/pp.highly_variable_genes.seurat.blobs.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pp.log1p.krumsiek11.h5ad Binary file test-data/pp.log1p.krumsiek11.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 test-data/pp.normalize_total.krumsiek11.h5ad Binary file test-data/pp.normalize_total.krumsiek11.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pp.pca.krumsiek11.h5ad Binary file test-data/pp.pca.krumsiek11.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pp.pca.krumsiek11_chunk.h5ad Binary file test-data/pp.pca.krumsiek11_chunk.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pp.recipe_seurat.recipe_zheng17.h5ad Binary file test-data/pp.recipe_seurat.recipe_zheng17.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pp.recipe_weinreb17.paul15_subsample.h5ad Binary file test-data/pp.recipe_weinreb17.paul15_subsample.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pp.recipe_weinreb17.paul15_subsample.updated.h5ad Binary file test-data/pp.recipe_weinreb17.paul15_subsample.updated.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pp.recipe_zheng17.random-randint.h5ad Binary file test-data/pp.recipe_zheng17.random-randint.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pp.regress_out.krumsiek11.h5ad Binary file test-data/pp.regress_out.krumsiek11.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pp.scale.krumsiek11.h5ad Binary file test-data/pp.scale.krumsiek11.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pp.scale_max_value.krumsiek11.h5ad Binary file test-data/pp.scale_max_value.krumsiek11.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pp.sqrt.krumsiek11.h5ad Binary file test-data/pp.sqrt.krumsiek11.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pp.subsample.krumsiek11_fraction.h5ad Binary file test-data/pp.subsample.krumsiek11_fraction.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/pp.subsample.krumsiek11_n_obs.h5ad Binary file test-data/pp.subsample.krumsiek11_n_obs.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/sparce_csr_matrix.h5ad Binary file test-data/sparce_csr_matrix.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 test-data/tl.embedding_density.umap.pbmc68k_reduced.h5ad Binary file test-data/tl.embedding_density.umap.pbmc68k_reduced.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 test-data/tl.paga.neighbors.paul15_gauss_braycurtis.h5ad Binary file test-data/tl.paga.neighbors.paul15_gauss_braycurtis.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 test-data/tl.pca.krumsiek11.h5ad Binary file test-data/tl.pca.krumsiek11.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/tl.rank_genes_groups.krumsiek11.h5ad Binary file test-data/tl.rank_genes_groups.krumsiek11.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/tl.rank_genes_groups.liblinear.krumsiek11.h5ad Binary file test-data/tl.rank_genes_groups.liblinear.krumsiek11.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 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 aaa5da8e73a9 -r edec35114f72 test-data/tl.score_genes.krumsiek11.h5ad Binary file test-data/tl.score_genes.krumsiek11.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/tl.score_genes_cell_cycle.krumsiek11.h5ad Binary file test-data/tl.score_genes_cell_cycle.krumsiek11.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 test-data/tl.tsne.krumsiek11.h5ad Binary file test-data/tl.tsne.krumsiek11.h5ad has changed diff -r aaa5da8e73a9 -r edec35114f72 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