Mercurial > repos > iuc > scanpy_filter
changeset 12:d600e0947468 draft
planemo upload for repository https://github.com/galaxyproject/tools-iuc/tree/master/tools/scanpy/ commit c21958f44b81d740191999fb6015d5ae69538ee0
line wrap: on
line diff
--- a/filter.xml Wed Sep 22 21:04:52 2021 +0000 +++ b/filter.xml Wed Jul 31 18:06:35 2024 +0000 @@ -1,9 +1,9 @@ -<tool id="scanpy_filter" name="Filter" version="@galaxy_version@" profile="@profile@"> +<tool id="scanpy_filter" name="Filter" version="@TOOL_VERSION@+galaxy@VERSION_SUFFIX@" profile="@profile@"> <description>with scanpy</description> - <expand macro="bio_tools"/> <macros> <import>macros.xml</import> </macros> + <expand macro="bio_tools"/> <expand macro="requirements"/> <expand macro="version_command"/> <command detect_errors="exit_code"><![CDATA[ @@ -45,14 +45,13 @@ #else if $method.method == 'tl.filter_rank_genes_groups' sc.tl.filter_rank_genes_groups( adata, - #if str($method.key) != '' + #if $method.key key='$method.key', #end if - #if str($method.groupby) != '' + #if $method.groupby groupby='$method.groupby', #end if use_raw=$method.use_raw, - log=$method.log, key_added='$method.key_added', min_in_group_fraction=$method.min_in_group_fraction, max_out_group_fraction=$method.max_out_group_fraction, @@ -63,17 +62,11 @@ adata=adata, flavor='$method.flavor.flavor', #if $method.flavor.flavor == 'seurat' - #if str($method.flavor.min_mean) != '' - min_mean=$method.flavor.min_mean, - #end if - #if str($method.flavor.max_mean) != '' - max_mean=$method.flavor.max_mean, - #end if - #if str($method.flavor.min_disp) != '' - min_disp=$method.flavor.min_disp, - #end if + min_mean=$method.flavor.min_mean, + max_mean=$method.flavor.max_mean, + min_disp=$method.flavor.min_disp, #if str($method.flavor.max_disp) != '' - max_disp=$method.flavor.max_disp, + max_disp=$method.flavor.max_disp, #end if #else if $method.flavor.flavor == 'cell_ranger' n_top_genes=$method.flavor.n_top_genes, @@ -105,6 +98,41 @@ random_state=$method.random_state, replace=$method.replace, copy=False) + +#else if $method.method == "filter_marker" + +#if $method.layer_selection.use_raw == 'False': + adata.X = adata.layers['$method.layer_selection.layer'] +#end if + +def check_marker(adata, group, gene, thresh_mean, thresh_frac, groupby): + filtered_data = adata[adata.obs[groupby] == group, adata.var_names == gene] + mean_expression = np.mean(filtered_data.X) + frac_cell_mean_expression = len(filtered_data.X[filtered_data.X > mean_expression]) / filtered_data.n_obs + if ( mean_expression > thresh_mean and frac_cell_mean_expression >= thresh_frac ): + return(True) + return(False) + +header='infer' + +#if $method.header == 'not_included': + header=None +#end if + +marker_list={key: list(value.values()) for key, value in pd.read_csv('$method.markerfile', sep='\t', index_col=0, header=header).to_dict(orient='index').items()} + +for key, value in marker_list.items(): + marker_list[key] = [x for x in value if check_marker(adata, key, x, $method.thresh_mean, $method.thresh_frac, '$method.groupby')] + +# Find the maximum length of lists +max_len = max(len(lst) for lst in marker_list.values()) + +# Fill smaller lists with empty values +for key, value in marker_list.items(): + marker_list[key] = value + [''] * (max_len - len(value)) + +df = pd.DataFrame(marker_list).T +df.to_csv('marker.tsv', sep='\t', index=True) #end if @CMD_anndata_write_outputs@ @@ -120,6 +148,7 @@ <option value="pp.highly_variable_genes">Annotate (and filter) highly variable genes, using 'pp.highly_variable_genes'</option> <option value="pp.subsample">Subsample to a fraction of the number of observations, using 'pp.subsample'</option> <option value="pp.downsample_counts">Downsample counts from count matrix, using 'pp.downsample_counts'</option> + <option value="filter_marker">Filter markers from count matrix and marker list</option> </param> <when value="pp.filter_cells"> <conditional name="filter"> @@ -173,7 +202,6 @@ <expand macro="sanitize_query" /> </param> <expand macro="param_use_raw"/> - <expand macro="param_log"/> <param argument="key_added" type="text" value="rank_genes_groups_filtered" label="Key that will contain new values"> <expand macro="sanitize_query" /> </param> @@ -221,15 +249,40 @@ <param argument="random_state" type="integer" value="0" label="Random seed to change subsampling"/> <param argument="replace" type="boolean" truevalue="True" falsevalue="False" checked="false" label="Sample the counts with replacement?"/> </when> + <when value="filter_marker"> + <param argument="markerfile" type="data" format="tabular" label="List of markers" help="This should be a tsv where row = group (e.g. celltypes) and columns = markers."></param> + <param name="header" type="select" label="Header in the list of markers?"> + <option value="included">Header incldued</option> + <option value="not_included">Header not included</option> + </param> + <param argument="thresh_mean" type="float" min="0.0" value="1.0" label="Minimal average count of all cells of a group (e.g., celltype) for a particular marker" help="Increasing the threshold will result in a smaller marker set."/> + <param argument="thresh_frac" type="float" min="0.0" max="1.0" value="0.1" label="Minimal fractions of cells that has a higher count than the average count of all cells of the group for the marker" help="Increasing this threshold might remove marker outliers."/> + <conditional name="layer_selection"> + <param name="use_raw" type="select" label="Use .X of adata to perform the filtering" help=""> + <option value="True">Yes</option> + <option value="False">No</option> + </param> + <when value="False"> + <param argument="layer" type="text" value="" label="Key from adata.layers whose value will be used to filter" help="If layers specified then use adata.layers[layer]."/> + </when> + <when value="True"/> + </conditional> + <param argument="groupby" type="text" value="" label="The key of the observation grouping to consider (e.g., celltype)" help=""> + <expand macro="sanitize_query" /> + </param> + </when> </conditional> <expand macro="inputs_common_advanced"/> </inputs> <outputs> <expand macro="anndata_outputs"/> + <data name="marker_out" format="tabular" from_work_dir="marker.tsv" label="${tool.name} on ${on_string}: Markers"> + <filter>method['method'] == 'filter_marker'</filter> + </data> </outputs> <tests> - <test> - <!-- test 0 --> + <test expect_num_outputs="2"> + <!-- test 1 --> <param name="adata" value="krumsiek11.h5ad" /> <conditional name="method"> <param name="method" value="pp.filter_cells"/> @@ -252,8 +305,8 @@ </output> <output name="anndata_out" file="pp.filter_cells.krumsiek11-min_counts.h5ad" ftype="h5ad" compare="sim_size"/> </test> - <test> - <!-- test 1 --> + <test expect_num_outputs="2"> + <!-- test 2 --> <param name="adata" value="krumsiek11.h5ad" /> <conditional name="method"> <param name="method" value="pp.filter_cells"/> @@ -274,8 +327,8 @@ </output> <output name="anndata_out" file="pp.filter_cells.krumsiek11-max_genes.h5ad" ftype="h5ad" compare="sim_size"/> </test> - <test> - <!-- test 2 --> + <test expect_num_outputs="2"> + <!-- test 3 --> <param name="adata" value="krumsiek11.h5ad" /> <conditional name="method"> <param name="method" value="pp.filter_genes"/> @@ -295,36 +348,41 @@ </output> <output name="anndata_out" file="pp.filter_genes.krumsiek11-min_counts.h5ad" ftype="h5ad" compare="sim_size"/> </test> - <!-- <test> --> - <!-- <!-\- test 3 -\-> --> - <!-- <!-\- Input dataset appears to be missing rank_genes_groups key... -\-> --> - <!-- <param name="adata" value="tl.rank_genes_groups.krumsiek11.h5ad" /> --> - <!-- <conditional name="method"> --> - <!-- <param name="method" value="tl.filter_rank_genes_groups"/> --> - <!-- <param name="key" value="rank_genes_groups"/> --> - <!-- <param name="use_raw" value="False"/> --> - <!-- <param name="log" value="False"/> --> - <!-- <param name="key_added" value="rank_genes_groups_filtered"/> --> - <!-- <param name="min_in_group_fraction" value="0.25"/> --> - <!-- <param name="max_out_group_fraction" value="0.5"/> --> - <!-- <param name="min_fold_change" value="3"/> --> - <!-- </conditional> --> - <!-- <output name="hidden_output"> --> - <!-- <assert_contents> --> - <!-- <has_text_matching expression="tl.filter_rank_genes_groups"/> --> - <!-- <has_text_matching expression="key='rank_genes_groups'"/> --> - <!-- <has_text_matching expression="use_raw=False"/> --> - <!-- <has_text_matching expression="log=False"/> --> - <!-- <has_text_matching expression="key_added='rank_genes_groups_filtered'"/> --> - <!-- <has_text_matching expression="min_in_group_fraction=0.25"/> --> - <!-- <has_text_matching expression="max_out_group_fraction=0.5"/> --> - <!-- <has_text_matching expression="min_fold_change=3"/> --> - <!-- </assert_contents> --> - <!-- </output> --> - <!-- <output name="anndata_out" file="pp.filter_rank_genes_groups.h5ad" ftype="h5ad" compare="sim_size"/> --> - <!-- </test> --> - <test> - <!-- test 4 --> + + <!-- test 4 --> + <!-- Fails to write to anndata after tl.filter_rank_genes_groups + Issue has been reported here: https://github.com/scverse/anndata/issues/726 + The current fix is: del adata.uns['rank_genes_groups_filtered'] --> + <!--<test expect_num_outputs="2"> + <param name="adata" value="tl.rank_genes_groups.krumsiek11.h5ad" /> + <conditional name="method"> + <param name="method" value="tl.filter_rank_genes_groups"/> + <param name="key" value="rank_genes_groups"/> + <param name="use_raw" value="False"/> + <param name="key_added" value="rank_genes_groups_filtered"/> + <param name="min_in_group_fraction" value="0.25"/> + <param name="max_out_group_fraction" value="0.5"/> + <param name="min_fold_change" value="3"/> + </conditional> + <section name="advanced_common"> + <param name="show_log" value="true" /> + </section> + <output name="hidden_output"> + <assert_contents> + <has_text_matching expression="tl.filter_rank_genes_groups"/> + <has_text_matching expression="key='rank_genes_groups'"/> + <has_text_matching expression="use_raw=False"/> + <has_text_matching expression="log=False"/> + <has_text_matching expression="key_added='rank_genes_groups_filtered'"/> + <has_text_matching expression="min_in_group_fraction=0.25"/> + <has_text_matching expression="max_out_group_fraction=0.5"/> + <has_text_matching expression="min_fold_change=3"/> + </assert_contents> + </output> + <output name="anndata_out" file="pp.filter_rank_genes_groups.h5ad" ftype="h5ad" compare="sim_size"/> + </test>--> + <test expect_num_outputs="2"> + <!-- test 5 --> <param name="adata" value="blobs.h5ad"/> <conditional name="method"> <param name="method" value="pp.highly_variable_genes"/> @@ -353,8 +411,8 @@ </output> <output name="anndata_out" file="pp.highly_variable_genes.seurat.blobs.h5ad" ftype="h5ad" compare="sim_size" delta="100000" delta_frac="0.2"/> </test> - <test> - <!-- test 5 --> + <test expect_num_outputs="2"> + <!-- test 6 --> <param name="adata" value="krumsiek11.h5ad" /> <conditional name="method"> <param name="method" value="pp.highly_variable_genes"/> @@ -379,8 +437,8 @@ </output> <output name="anndata_out" file="pp.highly_variable_genes.krumsiek11-cell_ranger.h5ad" ftype="h5ad" compare="sim_size" delta="100000" delta_frac="0.9"/> </test> - <test> - <!-- test 6 --> + <test expect_num_outputs="2"> + <!-- test 7 --> <param name="adata" value="krumsiek11.h5ad" /> <conditional name="method"> <param name="method" value="pp.subsample"/> @@ -402,8 +460,8 @@ </output> <output name="anndata_out" file="pp.subsample.krumsiek11_fraction.h5ad" ftype="h5ad" compare="sim_size"/> </test> - <test> - <!-- test 7 --> + <test expect_num_outputs="2"> + <!-- test 8 --> <param name="adata" value="krumsiek11.h5ad" /> <conditional name="method"> <param name="method" value="pp.subsample"/> @@ -425,8 +483,8 @@ </output> <output name="anndata_out" file="pp.subsample.krumsiek11_n_obs.h5ad" ftype="h5ad" compare="sim_size"/> </test> - <test> - <!-- test 8 --> + <test expect_num_outputs="2"> + <!-- test 9 --> <param name="adata" value="random-randint.h5ad" /> <conditional name="method"> <param name="method" value="pp.downsample_counts"/> @@ -447,6 +505,32 @@ </output> <output name="anndata_out" file="pp.downsample_counts.random-randint.h5ad" ftype="h5ad" compare="sim_size" delta="10000000" delta_frac="0.5"/> </test> + <test expect_num_outputs="3"> + <!-- test 10 --> + <param name="adata" value="cosg.rank_genes_groups.newton-cg.pbmc68k_highly_reduced_1.h5ad" /> + <conditional name="method"> + <param name="method" value="filter_marker"/> + <param name="markerfile" value="tl.rank_genes_groups.newton-cg.pbmc68k_highly_reduced_marker_1.tsv"/> + <param name="thresh_mean" value="1.0"/> + <param name="thresh_frac" value="0.2"/> + <param name="layer_selection" value="True"/> + <param name="groupby" value="bulk_labels"/> + </conditional> + <section name="advanced_common"> + <param name="show_log" value="true" /> + </section> + <output name="hidden_output"> + <assert_contents> + <has_text_matching expression="adata, key, x, 1.0, 0.2, 'bulk_labels'"/> + </assert_contents> + </output> + <output name="anndata_out" file="cosg.rank_genes_groups.newton-cg.pbmc68k_highly_reduced_1.h5ad" ftype="h5ad"> + <assert_contents> + <has_h5_keys keys="obs, var, uns" /> + </assert_contents> + </output> + <output name="marker_out" file="tl.rank_genes_groups.newton-cg.pbmc68k_highly_reduced_marker_filtered_1.tsv" ftype="tabular" compare="sim_size"/> + </test> </tests> <help><![CDATA[ @@ -461,7 +545,7 @@ `max_counts`, `max_genes` per call. More details on the `scanpy documentation -<https://icb-scanpy.readthedocs-hosted.com/en/@version@/api/scanpy.pp.filter_cells.html>`__ +<https://scanpy.readthedocs.io/en/stable/api/scanpy.pp.filter_cells.html>`__ Filter genes based on number of cells or counts (`pp.filter_genes`) @@ -475,14 +559,14 @@ `max_counts`, `max_cells` per call. More details on the `scanpy documentation -<https://icb-scanpy.readthedocs-hosted.com/en/@version@/api/scanpy.pp.filter_genes.html>`__ +<https://scanpy.readthedocs.io/en/stable/api/scanpy.pp.filter_genes.html>`__ Filters out genes based on fold change and fraction of genes expressing the gene within and outside the groupby categories (`tl.filter_rank_genes_groups`) ========================================================================================================================================================== More details on the `scanpy documentation -<https://icb-scanpy.readthedocs-hosted.com/en/@version@/api/scanpy.tl.filter_rank_genes_groups.html>`__ +<https://scanpy.readthedocs.io/en/stable/api/scanpy.tl.filter_rank_genes_groups.html>`__ Annotate highly variable genes (`pp.highly_variable_genes`) @@ -497,7 +581,7 @@ ====================================================================== More details on the `scanpy documentation -<https://icb-scanpy.readthedocs-hosted.com/en/@version@/api/scanpy.pp.subsample.html>`__ +<https://scanpy.readthedocs.io/en/stable/api/scanpy.pp.subsample.html>`__ Downsample counts (`pp.downsample_counts`) ========================================== @@ -505,8 +589,18 @@ Downsample counts so that each cell has no more than `target_counts`. Cells with fewer counts than `target_counts` are unaffected by this. This has been implemented by M. D. Luecken. + +Filter marker genes (`filter_marker`) +====================================================================== + +This option is specific for celltype marker gene detection. You can generate a celltype marker gene file (tsv) with **COSG** provided at Galaxy. + +The marker gene file should have as rows celltypes and columns as marker genes. Each celltype can have varying number of marker genes. + +A marker gene is returned (retained in the list) if the mean expression of the marker gene is bigger than the threshold of mean expression (thresh_mean) and if the fraction of cells with the marker gene expression is equal or higher than the cell fraction threshold (thresh_frac). + More details on the `scanpy documentation -<https://icb-scanpy.readthedocs-hosted.com/en/@version@/api/scanpy.pp.downsample_counts.html>`__ +<https://scanpy.readthedocs.io/en/stable/api/scanpy.pp.downsample_counts.html>`__ ]]></help>
--- a/macros.xml Wed Sep 22 21:04:52 2021 +0000 +++ b/macros.xml Wed Jul 31 18:06:35 2024 +0000 @@ -1,12 +1,17 @@ <macros> - <token name="@version@">1.7.1</token> - <token name="@profile@">19.01</token> - <token name="@galaxy_version@"><![CDATA[@version@+galaxy0]]></token> + <token name="@TOOL_VERSION@">1.9.6</token> + <token name="@VERSION_SUFFIX@">4</token> + <token name="@profile@">21.09</token> <xml name="requirements"> <requirements> - <requirement type="package" version="@version@">scanpy</requirement> - <requirement type="package" version="2.0.17">loompy</requirement> - <requirement type="package" version="0.8.3">leidenalg</requirement> + <requirement type="package" version="@TOOL_VERSION@">scanpy</requirement> + <requirement type="package" version="3.0.6">loompy</requirement> + <requirement type="package" version="0.10.1">leidenalg</requirement> + <requirement type="package" version="0.8.1">louvain</requirement> + <requirement type="package" version="1.5.3">pandas</requirement> + <requirement type="package" version="3.7">matplotlib</requirement> + <requirement type="package" version="0.12.2">seaborn</requirement> + <requirement type="package" version="3.0.0">magic-impute</requirement> <yield /> </requirements> </xml> @@ -15,9 +20,15 @@ <xref type="bio.tools">scanpy</xref> </xrefs> </xml> + <xml name="creators"> + <creator> + <organization name="European Galaxy Team" url="https://galaxyproject.org/eu/" /> + </creator> + </xml> <xml name="citations"> <citations> <citation type="doi">10.1186/s13059-017-1382-0</citation> + <citation type="doi">10.1093/gigascience/giaa102</citation> </citations> </xml> <xml name="version_command"> @@ -56,7 +67,7 @@ <param name="adata" type="data" format="h5ad" label="Annotated data matrix"/> </xml> <token name="@CMD_read_inputs@"><![CDATA[ -adata = sc.read('anndata.h5ad') +adata = sc.read_h5ad('anndata.h5ad') ]]> </token> <xml name="inputs_common_advanced"> @@ -66,12 +77,12 @@ </xml> <xml name="anndata_outputs"> <data name="anndata_out" format="h5ad" from_work_dir="anndata.h5ad" label="${tool.name} (${method.method}) on ${on_string}: Annotated data matrix"/> - <data name="hidden_output" format="txt" label="Log file" > + <data name="hidden_output" format="txt" label="Log file" > <filter>advanced_common['show_log']</filter> </data> </xml> <token name="@CMD_anndata_write_outputs@"><![CDATA[ -adata.write('anndata.h5ad') +adata.write_h5ad('anndata.h5ad') with open('anndata_info.txt','w', encoding='utf-8') as ainfo: print(adata, file=ainfo) ]]> @@ -414,6 +425,7 @@ <param name="type" type="select" label="Variables to plot (columns of the heatmaps)" > <option value="all">All variables in 'adata.var_names'</option> <option value="custom">Subset of variables in 'adata.var_names'</option> + <option value="customfile">Subset of variables as a tabular file</option> </param> <when value="all"/> <when value="custom"> @@ -421,6 +433,9 @@ <expand macro="sanitize_query" /> </param> </when> + <when value="customfile"> + <param argument="var_names" type="data" format="tabular" label="List of variables to plot" help="This should be a tsv where row = group (e.g. celltypes) and columns = variables."></param> + </when> </conditional> </xml> <xml name="param_num_categories"> @@ -457,15 +472,17 @@ <expand macro="param_num_categories"/> </xml> <token name="@CMD_params_inputs@"><![CDATA[ - #if $method.var_names.type == 'all' - var_names=adata.var_names, -#else + #if $method.var_names.type == 'custom' #set $var_names = ([x.strip() for x in str($method.var_names.var_names).split(',')]) var_names=$var_names, -#end if -#if str($method.groupby) != '' + #else if $method.var_names.type == 'customfile' + var_names={key: [v for v in list(value.values()) if pd.notna(v)] for key, value in pd.read_csv('$var_names', sep='\t', index_col=0).to_dict(orient='index').items()}, + #else + var_names=adata.var_names, + #end if + #if $method.groupby groupby='$method.groupby', -#end if + #end if num_categories=$method.num_categories, ]]></token> <xml name="params_plots"> @@ -491,15 +508,15 @@ var_group_positions=$var_group_positions, var_group_labels=$var_group_labels, #end if -#if $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 + #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 ]]></token> <xml name="matplotlib_color"> <option value="AliceBlue">AliceBlue</option> @@ -652,9 +669,8 @@ <option value="YellowGreen">YellowGreen</option> </xml> <xml name="param_matplotlib_pyplot_edgecolors"> - <param argument="edgecolors" type="select" label="Edge color of the marker" help=""> + <param argument="edgecolors" type="select" optional="true" label="Edge color of the marker" help=""> <option value="face">The edge color will always be the same as the face color</option> - <option value="none">No patch boundary will be drawn</option> <expand macro="matplotlib_color"/> </param> </xml> @@ -692,17 +708,19 @@ </section> </xml> <token name="@CMD_params_matplotlib_pyplot_scatter@"><![CDATA[ - #if $method.matplotlib_pyplot_scatter.vmin + #if str($method.matplotlib_pyplot_scatter.vmin) != '' vmin=$method.matplotlib_pyplot_scatter.vmin, #end if - #if $method.matplotlib_pyplot_scatter.vmax + #if str($method.matplotlib_pyplot_scatter.vmax) != '' vmax=$method.matplotlib_pyplot_scatter.vmax, #end if - #if $method.matplotlib_pyplot_scatter.alpha + #if str($method.matplotlib_pyplot_scatter.alpha) != '' alpha=$method.matplotlib_pyplot_scatter.alpha, #end if - linewidths=$method.matplotlib_pyplot_scatter.linewidths, - edgecolors='$method.matplotlib_pyplot_scatter.edgecolors' + lw=$method.matplotlib_pyplot_scatter.linewidths, + #if $method.matplotlib_pyplot_scatter.edgecolors + ec='$method.matplotlib_pyplot_scatter.edgecolors' + #end if ]]></token> <xml name="conditional_stripplot"> <conditional name="stripplot"> @@ -742,13 +760,7 @@ </param> </xml> <token name="@CMD_params_violin_plots@"><![CDATA[ - stripplot=$method.violin_plot.stripplot.stripplot, -#if $method.violin_plot.stripplot.stripplot == "True" - jitter=$method.violin_plot.stripplot.jitter.jitter, - #if $method.violin_plot.stripplot.jitter.jitter == "True" - size=$method.violin_plot.stripplot.jitter.size, - #end if -#end if + @CMD_conditional_stripplot@ multi_panel=$method.violin_plot.multi_panel.multi_panel, #if $method.multi_panel.violin_plot.multi_panel == "True" and str($method.violin_plot.multi_panel.width) != '' and str($method.violin_plot.multi_panel.height) != '' figsize=($method.violin_plot.multi_panel.width, $method.violin_plot.multi_panel.height) @@ -766,7 +778,7 @@ <option value="h">horizontal</option> </param> <param argument="linewidth" type="float" value="0" label="Width of the gray lines that frame the plot elements" help=""/> - <param argument="color" type="select" label="Color for all of the elements" help=""> + <param argument="color" type="select" optional="true" label="Color for all of the elements" help=""> <expand macro="matplotlib_color"/> </param> <param argument="saturation" type="float" value="0.75" min="0" max="1" label="Proportion of the original saturation to draw colors at" help=""/> @@ -778,7 +790,9 @@ orient='$method.seaborn_violinplot.orient', #end if linewidth=$method.seaborn_violinplot.linewidth, + #if $method.seaborn_violinplot.color color='$method.seaborn_violinplot.color', + #end if saturation=$method.seaborn_violinplot.saturation ]]></token> <xml name="param_color"> @@ -787,7 +801,7 @@ </param> </xml> <token name="@CMD_param_color@"><![CDATA[ -#if str($method.color) != '' +#if $method.color #set $color = ([x.strip() for x in str($method.color).split(',')]) color=$color, #end if @@ -798,7 +812,7 @@ </param> </xml> <token name="@CMD_params_groups@"><![CDATA[ -#if str($method.groups) != '' +#if $method.groups #set $groups=([x.strip() for x in str($method.groups).split(',')]) groups=$groups, #end if @@ -868,14 +882,12 @@ </param> </xml> <xml name="param_palette"> - <param argument="palette" type="select" label="Colors to use for plotting categorical annotation groups" help=""> - <option value="default">Default</option> + <param argument="palette" type="select" optional="true" label="Colors to use for plotting categorical annotation groups" help=""> <expand macro="matplotlib_pyplot_colormap"/> </param> </xml> <xml name="param_color_map"> - <param argument="color_map" type="select" label="Color map to use for continous variables" help=""> - <option value="None">Default</option> + <param argument="color_map" type="select" optional="true" label="Color map to use for continous variables" help=""> <expand macro="matplotlib_pyplot_colormap"/> </param> </xml> @@ -931,7 +943,7 @@ </param> <when value="True"> <param argument="edges_width" type="float" min="0" value="0.1" label="Width of edges"/> - <param argument="edges_color" type="select" label="Color of edges"> + <param argument="edges_color" type="select" optional="true" label="Color of edges"> <expand macro="matplotlib_color"/> </param> </when> @@ -942,7 +954,9 @@ #if str($method.edges.edges) == 'True' edges=True, edges_width=$method.edges.edges_width, + #if $method.edges.edges_color edges_color='$method.edges.edges_color', + #end if #else edges=False, #end if @@ -952,7 +966,7 @@ <param argument="arrows" type="boolean" truevalue="True" falsevalue="False" checked="false" label="Show arrows?" help="It requires to run 'tl.rna_velocity' before."/> </xml> <xml name="param_cmap"> - <param argument="cmap" type="select" label="Colors to use for plotting categorical annotation groups" help=""> + <param argument="cmap" type="select" optional="true" label="Colors to use for plotting categorical annotation groups" help=""> <expand macro="matplotlib_pyplot_colormap"/> </param> </xml> @@ -979,10 +993,10 @@ @CMD_param_legend_fontsize@ legend_fontweight='$method.plot.legend_fontweight', @CMD_param_size@ - #if str($method.plot.color_map) != 'None' + #if $method.plot.color_map color_map='$method.plot.color_map', #end if - #if str($method.plot.palette) != '' + #if $method.plot.palette palette='$method.plot.palette', #end if frameon=$method.plot.frameon, @@ -1052,18 +1066,18 @@ </xml> <token name="@CMD_params_pl_paga@"><![CDATA[ threshold=$method.threshold, -#if str($method.groups) != '' +#if $method.groups #set $groups=([x.strip() for x in str($method.groups).split(',')]) groups=$groups, #end if -#if str($method.color) != '' +#if $method.color #set $color=([x.strip() for x in str($method.color).split(',')]) color=$color, #end if #if $method.pos pos=np.fromfile($method.pos, dtype=dt), #end if -#if str($method.labels) != '' +#if $method.labels #set $labels=([x.strip() for x in str($method.labels).split(',')]) labels=$labels, #end if @@ -1072,7 +1086,7 @@ init_pos=np.fromfile($method.init_pos, dtype=dt), #end if random_state=$method.random_state, -#if str($method.root) != '' +#if $method.root #set $root=([int(x.strip()) for x in str($method.root).split(',')]) root=$root, #end if @@ -1088,15 +1102,17 @@ node_size_scale=$method.node_size_scale, node_size_power=$method.node_size_power, edge_width_scale=$method.edge_width_scale, -#if $method.min_edge_width +#if str($method.min_edge_width) != '' min_edge_width=$method.min_edge_width, #end if -#if $method.max_edge_width +#if str($method.max_edge_width) != '' max_edge_width=$method.max_edge_width, #end if arrowsize=$method.arrowsize, normalize_to_color=$method.normalize_to_color, + #if $method.cmap cmap='$method.cmap', + #end if #if $method.title title='$method.title', #end if @@ -1112,10 +1128,10 @@ </param> </xml> <xml name="param_n_genes"> - <param argument="n_genes" type="integer" min="0" value="10" label="Number of genes to show" help=""/> + <param argument="n_genes" type="integer" min="0" value="10" label="Number of genes to show" help="It is only used if you are not specifying certain variable names"/> </xml> <xml name="pl_dotplot"> - <param argument="color_map" type="select" label="Color palette"> + <param argument="color_map" type="select" optional="true" label="Color palette"> <expand macro="matplotlib_pyplot_colormap"/> </param> <param argument="dot_max" type="float" value="" min="0" max="1" optional="true" label="Maximum dot size" help="If none, the maximum dot size is set to the maximum fraction value found (e.g. 0.6). If given, the value should be a number between 0 and 1. All fractions larger than dot_max are clipped to this value."/> @@ -1123,7 +1139,9 @@ <expand macro="section_matplotlib_pyplot_scatter"/> </xml> <token name="@CMD_pl_dotplot@"><![CDATA[ + #if $method.color_map color_map='$method.color_map', + #end if #if str($method.dot_max) != '' dot_max=$method.dot_max, #end if @@ -1174,17 +1192,19 @@ <token name="@CMD_pl_heatmap@"><![CDATA[ swap_axes=$method.swap_axes, show_gene_labels=$method.show_gene_labels, + #if $method.matplotlib_pyplot_imshow.cmap cmap='$method.matplotlib_pyplot_imshow.cmap', + #end if #if str($method.matplotlib_pyplot_imshow.interpolation) != 'None' interpolation='$method.matplotlib_pyplot_imshow.interpolation', #end if - #if $method.matplotlib_pyplot_imshow.alpha + #if str($method.matplotlib_pyplot_imshow.alpha) != '' alpha=$method.matplotlib_pyplot_imshow.alpha, #end if - #if $method.matplotlib_pyplot_imshow.vmin + #if str($method.matplotlib_pyplot_imshow.vmin) != '' vmin=$method.matplotlib_pyplot_imshow.vmin, #end if - #if $method.matplotlib_pyplot_imshow.vmax + #if str($method.matplotlib_pyplot_imshow.vmax) != '' vmax=$method.matplotlib_pyplot_imshow.vmax, #end if origin='$method.matplotlib_pyplot_imshow.origin' @@ -1197,10 +1217,8 @@ </xml> <token name="@CMD_pl_rank_genes_groups_ext@"><![CDATA[ @CMD_params_groups@ - #if str($method.n_genes) != '' n_genes=$method.n_genes, - #end if - #if str($method.key) != '' + #if $method.key key='$method.key', #end if ]]> @@ -1208,7 +1226,7 @@ <xml name="pl_matrixplot"> <expand macro="param_swap_axes"/> <section name="matplotlib_pyplot_pcolor" title="Parameters for matplotlib.pyplot.pcolor"> - <param argument="cmap" type="select" label="Color palette"> + <param argument="cmap" type="select" optional="true" label="Color palette"> <expand macro="seaborn_color_palette_options"/> </param> <param argument="vmin" type="float" value="" optional="true" label="Minimum value to anchor the colormap" help=""/> @@ -1220,15 +1238,19 @@ </xml> <token name="@CMD_pl_matrixplot@"><