Previous changeset 3:de6d0b7c17af (2018-10-01) |
Commit message:
Uploaded new release 1.7.3 |
modified:
abims_sartools_deseq2.xml abims_sartools_deseq2_wrapper.py abims_sartools_edger.xml abims_sartools_edger_wrapper.py macros.xml make_html.py pre_sartools.py pre_sartools.xml repository_dependencies.xml template_script_DESeq2_CL.r test-data/test_output_target.html |
added:
README.rst |
removed:
README.md |
b |
diff -r de6d0b7c17af -r 05c9b1a7f44e README.md --- a/README.md Mon Oct 01 05:07:56 2018 -0400 +++ /dev/null Thu Jan 01 00:00:00 1970 +0000 |
[ |
@@ -1,52 +0,0 @@ --------------------------------------------------------------------------------------- -SARTools-Galaxy: a galaxy wrapper for SARTools (Statistical Analysis of RNA-Seq Tools) --------------------------------------------------------------------------------------- - -[![Build Status](https://travis-ci.org/PF2-pasteur-fr/SARTools-Galaxy.svg?branch=master)](https://travis-ci.org/PF2-pasteur-fr/SARTools-Galaxy) - -Description: ------------- - SARTools is a R package dedicated to the differential analysis of RNA-seq data. - - SARTools provides tools to generate descriptive and diagnostic graphs, to run the differential analysis with one of the well known DESeq2 or edgeR packages and to export the results into easily readable tab-delimited files. It also facilitates the generation of a HTML report which displays all the figures produced, explains the statistical methods and gives the results of the differential analysis. Note that SARTools does not intend to replace DESeq2 or edgeR: it simply provides an environment to go with them. For more details about the methodology behind DESeq2 or edgeR, the user should read their documentations and papers. - -Requirements: -------------- - These Galaxy tools need: - - R and the following R packages: SARTools, DESeq2, edgeR, genefilter, xtable and knitr. - - Rscript and optparse package - - SARTools can be downloaded on github (https://github.com/PF2-pasteur-fr/SARTools). More information about installation can be found at this url. - -Requirements using Conda: -------------------------- -[![install with bioconda](https://img.shields.io/badge/install%20with-bioconda-brightgreen.svg?style=flat)](http://bioconda.github.io/recipes/r-sartools/README.html) - -[Conda](http://conda.pydata.org/) is package manager that among many other things can be used to manage Python packages. - - -``` -#To install miniconda2 -#http://conda.pydata.org/miniconda.html -#To install the SARTools R library using conda: -conda install r-sartools -#To set an environment: -conda create -n r-sartools r-sartools` -#To activate the environment: -. activate r-sartools -``` - - -Test: ------ - -`planemo test` using conda: passed - - -References: ------------ - The SARTools package has been developped at PF2 - Institut Pasteur by M.-A. Dillies and H. Varet (hugo.varet@pasteur.fr). - Thanks to cite H. Varet, L. Brillet-Guéguen, J.-Y. Coppee and M.-A. Dillies, SARTools: A DESeq2- and EdgeR-Based R Pipeline for Comprehensive Differential Analysis of RNA-Seq Data, PLoS One, 2016, doi: http://dx.doi.org/10.1371/journal.pone.0157022 when using this tool for any analysis published. - - The Galaxy wrapper and scripts have been developped by Loraine Brillet-Guéguen, Institut Français de Bioinformatique - |
b |
diff -r de6d0b7c17af -r 05c9b1a7f44e README.rst --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/README.rst Thu Jan 07 11:12:01 2021 +0000 |
b |
@@ -0,0 +1,57 @@ +====================================================================================== +SARTools-Galaxy: a galaxy wrapper for SARTools (Statistical Analysis of RNA-Seq Tools) +====================================================================================== + +|Build Status| + +Description: +============ + + +SARTools is a R package dedicated to the differential analysis of RNA-seq data. + +SARTools provides tools to generate descriptive and diagnostic graphs, to run the differential analysis with one of the well known DESeq2 or edgeR packages and to export the results into easily readable tab-delimited files. It also facilitates the generation of a HTML report which displays all the figures produced, explains the statistical methods and gives the results of the differential analysis. Note that SARTools does not intend to replace DESeq2 or edgeR: it simply provides an environment to go with them. For more details about the methodology behind DESeq2 or edgeR, the user should read their documentations and papers. + +SARTools can be downloaded on github (https://github.com/PF2-pasteur-fr/SARTools). More information about installation can be found at this url. + + +Requirements using Conda: +========================= + +|install with bioconda| + +`Conda`_ is a package manager that among many other things can be used to manage Python packages. + +.. code-block:: bash + + #To install miniconda + #http://conda.pydata.org/miniconda.html + #To install the SARTools R library using conda: + conda install r-sartools + #To set an environment: + conda create -n r-sartools r-sartools` + #To activate the environment: + . activate r-sartools + +Test: +===== + +``planemo test`` using conda: passed + +References: +=========== + + +The SARTools package has been developped at PF2 - Institut Pasteur by M.-A. Dillies and H. Varet (hugo.varet@pasteur.fr). + +Thanks to cite H. Varet, L. Brillet-Guéguen, J.-Y. Coppee and M.-A. Dillies, SARTools: A DESeq2- and EdgeR-Based R Pipeline for Comprehensive Differential Analysis of RNA-Seq Data, PLoS One, 2016, doi: http://dx.doi.org/10.1371/journal.pone.0157022 when using this tool for any analysis published. + +The Galaxy wrapper and scripts have been developped by Loraine Brillet-Guéguen, Institut Français de Bioinformatique + +.. _Conda: http://conda.pydata.org/ + +.. |Build Status| image:: https://travis-ci.org/PF2-pasteur-fr/SARTools-Galaxy.svg?branch=master + :target: https://travis-ci.org/PF2-pasteur-fr/SARTools-Galaxy + +.. |install with bioconda| image:: https://img.shields.io/badge/install%20with-bioconda-brightgreen.svg?style=flat + :target: http://bioconda.github.io/recipes/r-sartools/README.html |
b |
diff -r de6d0b7c17af -r 05c9b1a7f44e abims_sartools_deseq2.xml --- a/abims_sartools_deseq2.xml Mon Oct 01 05:07:56 2018 -0400 +++ b/abims_sartools_deseq2.xml Thu Jan 07 11:12:01 2021 +0000 |
[ |
b'@@ -1,114 +1,96 @@\n-<tool id="sartools_deseq2" name="SARTools DESeq2" version="@WRAPPER_VERSION@.0">\n+<tool id="sartools_deseq2" name="SARTools DESeq2" version="@TOOL_VERSION@+galaxy0">\n \n- <!-- [REQUIRED] Tool description displayed after the tool name -->\n <description>Compare two or more biological conditions in a RNA-Seq framework with DESeq2</description>\n \n <macros>\n- \t<import>macros.xml</import>\n+ <import>macros.xml</import>\n </macros>\n \n <expand macro="requirements"/>\n <expand macro="stdio"/>\n \n- <!-- [REQUIRED] The command to execute -->\n- <command interpreter="python"><![CDATA[\n-\t\n-\tabims_sartools_deseq2_wrapper.py\n-\t## parameters\n-\t@COMMAND_BASIC_PARAMETERS@\n- \t#if str( $advanced_parameters.adv_param ) == "show":\n- @COMMAND_BATCH_PARAM@\n- --fitType $advanced_parameters.fitType\n- --cooksCutoff $advanced_parameters.cooksCutoff\n- --independentFiltering $advanced_parameters.independentFiltering\n-\t --alpha $advanced_parameters.alpha\n-\t --pAdjustMethod $advanced_parameters.pAdjustMethod\n-\t --typeTrans $advanced_parameters.typeTrans\n-\t --locfunc $advanced_parameters.locfunc\n-\t --colors $advanced_parameters.colors\n- --forceCairoGraph $advanced_parameters.forceCairoGraph\n- \t#end if\n-\t## ouputs\n-\t@COMMAND_OUTPUTS@\n+ <command><![CDATA[\n+ \n+python \'$__tool_directory__/abims_sartools_deseq2_wrapper.py\'\n+## parameters\n+@COMMAND_BASIC_PARAMETERS@\n+@COMMAND_BATCH_PARAM@\n+--fitType \'$advanced_parameters.fitType\'\n+--cooksCutoff \'$advanced_parameters.cooksCutoff\'\n+--independentFiltering \'$advanced_parameters.independentFiltering\'\n+--alpha \'$advanced_parameters.alpha\'\n+--pAdjustMethod \'$advanced_parameters.pAdjustMethod\'\n+--typeTrans \'$advanced_parameters.typeTrans\'\n+--locfunc \'$advanced_parameters.locfunc\'\n+--colors "\'$advanced_parameters.colors\'"\n+--forceCairoGraph \'$advanced_parameters.forceCairoGraph\'\n+## ouputs\n+@COMMAND_OUTPUTS@\n \n ]]></command>\n \n- <!-- [REQUIRED] Input files and tool parameters -->\n <inputs>\n \n <expand macro="basic_parameters" />\n- \n- <conditional name="advanced_parameters" >\n- <param name="adv_param" type="select" label="Advanced Parameters" help="" >\n- <option value="hide" selected="true">Hide</option>\n- <option value="show">Show</option>\n+\n+ <section name="advanced_parameters" title="Advanced Parameters" expanded="false">\n+ <expand macro="batch_param" />\n+ <param type="select" label="Mean-variance relationship" argument="--fitType" help="Type of model for the mean-dispersion relationship. Parametric by default." >\n+ <option value="parametric" selected="true">parametric</option>\n+ <option value="local">local</option>\n+ <option value="mean">mean</option>\n </param>\n- <when value="hide" />\n- <when value="show">\n-\t\t<expand macro="batch_param" />\n- <param type="select" label="Mean-variance relationship" argument="--fitType" help="Type of model for the mean-dispersion relationship. Parametric by default." >\n- \t\t<option value="parametric" selected="true">parametric</option>\n-\t\t\t<option value="local">local</option>\n-\t\t\t<option value="mean">mean</option>\n-\t\t</param>\n-\t\t<param type="boolean" checked="true" truevalue="TRUE" falsevalue="FALSE" label="Perform the outliers detection" argument="--cooksCutoff" help="Checked by default."/>\n-\t\t<param type="boolean" checked="true" truevalue="TRUE" falsevalue="FALSE" label="Perform independent filtering" argument="--independentFiltering" help="Checked by default."/>\n-\t\t<expand macro="alpha_param" />\n-\t\t<expand macro="padjustmethod_param" />\n- \t<param type="select" label="Transformation for PCA/clustering" argument="--typeTrans" help="Method of transformation of the counts for the clustering and the PCA: \'VST\' (default) for'..b');\n-\t* **typeTrans:** method of transformation of the counts for the clustering and the PCA (default is "VST" for Variance Stabilizing Transformation, or "rlog" for Regularized Log Transformation);\n-\t* **locfunc:** function used for the estimation of the size factors (default is "median", or "shorth" from the genefilter package);\n-\t* **colors:** colors used for the figures (one per biological condition), 8 are given by default.\n-\t* **forceCairoGraph:** TRUE or FALSE (default) to force the use of cairo with options(bitmapType="cairo").\n+ @HELP_BASIC_PARAMETERS@\n+ * **batch:** adjustment variable to use as a batch effect, must be a column of the target file (NULL if no batch effect needs to be taken into account);\n+ * **alpha:** significance threshold applied to the adjusted p-values to select the differentially expressed features (default is 0.05);\n+ * **fitType:** type of model for the mean-dispersion relationship ("parametric" by default, or "local");\n+ * **cooksCutoff:** TRUE (default) of FALSE to execute or not the detection of the outliers [4];\n+ * **independentFiltering:** TRUE (default) of FALSE to execute or not the independent filtering [5];\n+ * **pAdjustMethod:** p-value adjustment method for multiple testing [6, 7] ("BH" by default, "BY" or any value of p.adjust.methods);\n+ * **typeTrans:** method of transformation of the counts for the clustering and the PCA (default is "VST" for Variance Stabilizing Transformation, or "rlog" for Regularized Log Transformation);\n+ * **locfunc:** function used for the estimation of the size factors (default is "median", or "shorth" from the genefilter package);\n+ * **colors:** colors used for the figures (one per biological condition), 8 are given by default.\n+ * **forceCairoGraph:** TRUE or FALSE (default) to force the use of cairo with options(bitmapType="cairo").\n \n \n ------------\n@@ -154,7 +136,7 @@\n \n @HELP_OUTPUT_FILES@\n \n-\t\t\n+ \n ---------------------------------------------------\n \n [1] G.-K. Smyth. Limma: linear models for microarray data. In R. Gentleman, V. Carey, S. Dudoit, R. Irizarry, and W. Huber, editors, Bioinformatics and Computational Biology Solutions Using R and Bioconductor, pages 397\xe2\x80\x93420. Springer, New York, 2005.\n@@ -172,27 +154,27 @@\n [7] Y. Benjamini and D. Yekutieli. The control of the false discovery rate in multiple testing under dependency. Ann. Statist., 29(4):1165\xe2\x80\x931188, 2001.\n \n \n- ]]></help>\n+ ]]></help>\n \n- <citations>\n- <expand macro="common_citations" /> \n- <citation type="bibtex">@ARTICLE{Cook77,\n- author = {R.-D. Cook},\n- title = {Detection of Influential Observation in Linear Regression},\n- journal = {Technometrics},\n- year = {1977},\n- month = {February}\n- }</citation>\n- <citation type="bibtex">@ARTICLE{Bourgon10,\n- author = {R. Bourgon, R. Gentleman, and W. Huber},\n- title = {Independent filtering increases detection power for high-throughput experiments},\n- journal = {PNAS},\n- year = {2010},\n- volume = {107},\n- number = {21},\n- pages = {9546\xe2\x80\x939551},\n- note = {URL: http://www.pnas.org/content/107/21/9546.long}\n- }</citation>\n- </citations>\n+ <citations>\n+ <expand macro="common_citations" /> \n+ <citation type="bibtex">@ARTICLE{Cook77,\n+ author = {R.-D. Cook},\n+ title = {Detection of Influential Observation in Linear Regression},\n+ journal = {Technometrics},\n+ year = {1977},\n+ month = {February}\n+ }</citation>\n+ <citation type="bibtex">@ARTICLE{Bourgon10,\n+ author = {R. Bourgon, R. Gentleman, and W. Huber},\n+ title = {Independent filtering increases detection power for high-throughput experiments},\n+ journal = {PNAS},\n+ year = {2010},\n+ volume = {107},\n+ number = {21},\n+ pages = {9546\xe2\x80\x939551},\n+ note = {URL: http://www.pnas.org/content/107/21/9546.long}\n+ }</citation>\n+ </citations>\n \n </tool>\n' |
b |
diff -r de6d0b7c17af -r 05c9b1a7f44e abims_sartools_deseq2_wrapper.py --- a/abims_sartools_deseq2_wrapper.py Mon Oct 01 05:07:56 2018 -0400 +++ b/abims_sartools_deseq2_wrapper.py Thu Jan 07 11:12:01 2021 +0000 |
b |
@@ -67,7 +67,7 @@ report_html=args.report_html log=args.log #Print the parameters selected - print("Wrapper arguments: %s") %(args) + print("Wrapper arguments: %s" %(args)) #Get the working directory path working_directory = os.getcwd() @@ -104,7 +104,7 @@ if forceCairoGraph: cmd+="--forceCairoGraph %s " % (forceCairoGraph) cmd+="> %s 2>&1" % (log) - print("Rscript command: %s") % (cmd) + print("Rscript command: %s" % (cmd)) os.system(cmd) #Get output files |
b |
diff -r de6d0b7c17af -r 05c9b1a7f44e abims_sartools_edger.xml --- a/abims_sartools_edger.xml Mon Oct 01 05:07:56 2018 -0400 +++ b/abims_sartools_edger.xml Thu Jan 07 11:12:01 2021 +0000 |
[ |
b'@@ -1,84 +1,68 @@\n-<tool id="sartools_edger" name="SARTools edgeR" version="@WRAPPER_VERSION@.0">\n+<tool id="sartools_edger" name="SARTools edgeR" version="@TOOL_VERSION@+galaxy0">\n \n- <!-- [REQUIRED] Tool description displayed after the tool name -->\n <description>Compare two or more biological conditions in a RNA-Seq framework with edgeR</description>\n \n <macros>\n- \t<import>macros.xml</import>\n+ <import>macros.xml</import>\n </macros>\n \n <expand macro="requirements"/>\n <expand macro="stdio"/>\n \n \n- <!-- [REQUIRED] The command to execute -->\n- <command interpreter="python"><![CDATA[\n-\t\n-\tabims_sartools_edger_wrapper.py\n-\t## parameters\n-\t@COMMAND_BASIC_PARAMETERS@\n- \t#if str( $advanced_parameters.adv_param ) == "show":\n- @COMMAND_BATCH_PARAM@\n-\t --alpha $advanced_parameters.alpha\n-\t --pAdjustMethod $advanced_parameters.pAdjustMethod\n-\t --cpmCutoff $advanced_parameters.cpmCutoff\n-\t --geneSelection $advanced_parameters.geneSelection\n-\t --normalizationMethod $advanced_parameters.normalizationMethod\n-\t --colors $advanced_parameters.colors\n- --forceCairoGraph $advanced_parameters.forceCairoGraph\n- \t#end if\n-\t## ouputs\n-\t@COMMAND_OUTPUTS@\n+ <command><![CDATA[\n+ \n+python \'$__tool_directory__/abims_sartools_edger_wrapper.py\'\n+## parameters\n+@COMMAND_BASIC_PARAMETERS@\n+@COMMAND_BATCH_PARAM@\n+--alpha \'$advanced_parameters.alpha\'\n+--pAdjustMethod \'$advanced_parameters.pAdjustMethod\'\n+--cpmCutoff \'$advanced_parameters.cpmCutoff\'\n+--geneSelection \'$advanced_parameters.geneSelection\'\n+--normalizationMethod \'$advanced_parameters.normalizationMethod\'\n+--colors "\'$advanced_parameters.colors\'"\n+--forceCairoGraph \'$advanced_parameters.forceCairoGraph\'\n+## ouputs\n+@COMMAND_OUTPUTS@\n \n ]]></command>\n \n- <!-- [REQUIRED] Input files and tool parameters -->\n <inputs>\n \n <expand macro="basic_parameters" />\n \n- <conditional name="advanced_parameters" >\n- <param name="adv_param" type="select" label="Advanced Parameters" help="" >\n- <option value="hide" selected="true">Hide</option>\n- <option value="show">Show</option>\n+ <section name="advanced_parameters" title="Advanced Parameters" expanded="false" >\n+ <expand macro="batch_param" />\n+ <expand macro="alpha_param" />\n+ <expand macro="padjustmethod_param" />\n+ <param type="integer" value="1" min="0" label="Counts-per-million cut-off to filter low counts" argument="--cpmCutoff" help="Set to 0 to disable filtering. Default is 1." />\n+ <param name="geneSelection" type="select" label="Selection of the features in MDSPlot" argument="--gene.selection" help="Default is \'pairwise\'." >\n+ <option value="pairwise" selected="true">pairwise</option>\n+ <option value="common">common</option>\n </param>\n- <when value="hide" />\n- <when value="show">\n-\t\t<expand macro="batch_param" />\n-\t\t<expand macro="alpha_param" />\n-\t\t<expand macro="padjustmethod_param" />\n-\t\t<param type="integer" value="1" min="0" label="Counts-per-million cut-off to filter low counts" argument="--cpmCutoff" help="Set to 0 to disable filtering. Default is 1." />\n-\t\t<param name="geneSelection" type="select" label="Selection of the features in MDSPlot" argument="--gene.selection" help="Default is \'pairwise\'." >\n- \t<option value="pairwise" selected="true">pairwise</option>\n- \t<option value="common">common</option>\n-\t\t</param>\n-\t\t<param type="select" label="Normalization method in calcNormFactors" argument="--normalizationMethod" help="\'TMM\' (default), \'RLE\' (DESeq method) or \'upperquartile\'." >\n- \t<option value="TMM" selected="true">TMM</option>\n- \t<option value="RLE">RLE</option>\n- \t<option value="upperquartile">upperquartile</option>\n-\t\t</param>\n-\t\t<expand macro="colors'..b'="?" ftype="no_unzip.zip"/>\n-\t <param name="condRef" value="T0"/>\n-\t <param name="adv_param" value="show"/>\n-\t <param name="condition" value="true"/>\n+ <param name="condRef" value="T0"/>\n+ <param name="condition" value="true"/>\n <output name="tables_html" file="SARTools_edgeR_targetT048_tables.html" lines_diff="14">\n- \t<extra_files type="file" name="T4vsT0.complete.txt" value="SARTools_edgeR_T4vsT0.complete.txt"/>\n- \t<extra_files type="file" name="T8vsT0.complete.txt" value="SARTools_edgeR_T8vsT0.complete.txt"/>\n- \t<extra_files type="file" name="T8vsT4.complete.txt" value="SARTools_edgeR_T8vsT4.complete.txt"/>\n-\t </output>\n+ <extra_files type="file" name="T4vsT0.complete.txt" value="SARTools_edgeR_T4vsT0.complete.txt"/>\n+ <extra_files type="file" name="T8vsT0.complete.txt" value="SARTools_edgeR_T8vsT0.complete.txt"/>\n+ <extra_files type="file" name="T8vsT4.complete.txt" value="SARTools_edgeR_T8vsT4.complete.txt"/>\n+ </output>\n </test>\n---> </tests>\n+--> </tests>\n \n- <!-- [OPTIONAL] Help displayed in Galaxy -->\n <help><![CDATA[\n \n @HELP_AUTHORS@\n@@ -153,15 +133,15 @@\n Parameters\n ----------\n \n-\t@HELP_BASIC_PARAMETERS@\n-\t* **batch:** adjustment variable to use as a batch effect, must be a column of the target file (NULL if no batch effect needs to be taken into account);\n-\t* **alpha:** significance threshold applied to the adjusted p-values to select the differentially expressed features (default is 0.05);\n-\t* **pAdjustMethod:** p-value adjustment method for multiple testing [4, 5] ("BH" by default, "BY" or any value of p.adjust.methods);\n-\t* **cpmCutoff:** counts-per-million cut-off to filter low counts (default is 1, set to 0 to disable filtering);\n-\t* **gene.selection:** method of selection of the features for the MultiDimensional Scaling plot ("pairwise" by default or common);\n-\t* **normalizationMethod:** normalization method in calcNormFactors(): "TMM" (default), "RLE" (DESeq method) or "upperquartile";\n-\t* **colors:** colors used for the figures (one per biological condition), 8 are given by default.\n-\t* **forceCairoGraph:** TRUE or FALSE (default) to force the use of cairo with options(bitmapType="cairo").\n+ @HELP_BASIC_PARAMETERS@\n+ * **batch:** adjustment variable to use as a batch effect, must be a column of the target file (NULL if no batch effect needs to be taken into account);\n+ * **alpha:** significance threshold applied to the adjusted p-values to select the differentially expressed features (default is 0.05);\n+ * **pAdjustMethod:** p-value adjustment method for multiple testing [4, 5] ("BH" by default, "BY" or any value of p.adjust.methods);\n+ * **cpmCutoff:** counts-per-million cut-off to filter low counts (default is 1, set to 0 to disable filtering);\n+ * **gene.selection:** method of selection of the features for the MultiDimensional Scaling plot ("pairwise" by default or common);\n+ * **normalizationMethod:** normalization method in calcNormFactors(): "TMM" (default), "RLE" (DESeq method) or "upperquartile";\n+ * **colors:** colors used for the figures (one per biological condition), 8 are given by default.\n+ * **forceCairoGraph:** TRUE or FALSE (default) to force the use of cairo with options(bitmapType="cairo").\n \n \n ------------\n@@ -170,7 +150,7 @@\n \n @HELP_OUTPUT_FILES@\n \n-\t\t\n+ \n ---------------------------------------------------\n \n [1] G.-K. Smyth. Limma: linear models for microarray data. In R. Gentleman, V. Carey, S. Dudoit, R. Irizarry, and W. Huber, editors, Bioinformatics and Computational Biology Solutions Using R and Bioconductor, pages 397\xe2\x80\x93420. Springer, New York, 2005.\n@@ -184,7 +164,7 @@\n [5] Y. Benjamini and D. Yekutieli. The control of the false discovery rate in multiple testing under dependency. Ann. Statist., 29(4):1165\xe2\x80\x931188, 2001.\n \n \n- ]]></help>\n+ ]]></help>\n \n <citations>\n <expand macro="common_citations" /> \n' |
b |
diff -r de6d0b7c17af -r 05c9b1a7f44e abims_sartools_edger_wrapper.py --- a/abims_sartools_edger_wrapper.py Mon Oct 01 05:07:56 2018 -0400 +++ b/abims_sartools_edger_wrapper.py Thu Jan 07 11:12:01 2021 +0000 |
b |
@@ -63,7 +63,7 @@ report_html=args.report_html log=args.log #Print the parameters selected - print("Wrapper arguments: %s") %(args) + print("Wrapper arguments: %s" %(args)) #Get the working directory path working_directory = os.getcwd() @@ -96,7 +96,7 @@ if forceCairoGraph: cmd+="--forceCairoGraph %s " % (forceCairoGraph) cmd+="> %s 2>&1" % (log) - print("Rscript command: %s") % (cmd) + print("Rscript command: %s" % (cmd)) os.system(cmd) #Get output files |
b |
diff -r de6d0b7c17af -r 05c9b1a7f44e macros.xml --- a/macros.xml Mon Oct 01 05:07:56 2018 -0400 +++ b/macros.xml Thu Jan 07 11:12:01 2021 +0000 |
b |
b'@@ -1,11 +1,10 @@\n <macros>\n \n- <token name="@WRAPPER_VERSION@">1.6.3</token>\n+ <token name="@TOOL_VERSION@">1.7.3</token>\n \n <xml name="requirements">\n <requirements>\n- <requirement type="package" version="1.6.3">r-sartools</requirement>\n- <requirement type="package" version="1.6.0">r-optparse</requirement>\n+ <requirement type="package" version="@TOOL_VERSION@">r-sartools</requirement>\n </requirements>\n </xml>\n \n@@ -23,101 +22,106 @@\n </stdio>\n </xml>\n \n- <token name="@COMMAND_BASIC_PARAMETERS@">\n-\t--projectName $projectName\n-\t--author $author\n-\t--targetFile $targetFile\n-\t--rawDir $rawDir\n-\t--featuresToRemove $featuresToRemove\n-\t--varInt $varInt\n-\t--condRef $condRef\n- </token>\n+ <token name="@COMMAND_BASIC_PARAMETERS@">\n+--projectName \'$projectName\'\n+--author \'$author\'\n+--targetFile \'$targetFile\'\n+--rawDir \'$rawDir\'\n+--featuresToRemove \'$featuresToRemove\'\n+--varInt \'$varInt\'\n+--condRef \'$condRef\'\n+ </token>\n \n- <token name="@COMMAND_BATCH_PARAM@">\n- #if $advanced_parameters.batch_condition.condition:\n- --batch $advanced_parameters.batch_condition.batch\n- #else:\n+ <token name="@COMMAND_BATCH_PARAM@">\n+ #if $advanced_parameters.batch_condition.condition:\n+ --batch \'$advanced_parameters.batch_condition.batch\'\n+ #else:\n --batch NULL\n- #end if\n- </token>\n+ #end if\n+ </token>\n \n- <token name="@COMMAND_OUTPUTS@">\n-\t--figures_html $figures_html \n-\t--figures_html_files_path $figures_html.files_path\n-\t--tables_html $tables_html \n-\t--tables_html_files_path $tables_html.files_path\n-\t--rdata $rdata\n-\t--report_html $report_html\n- \t--log $log\n- </token>\n+ <token name="@COMMAND_OUTPUTS@">\n+--figures_html \'$figures_html\' \n+--figures_html_files_path \'$figures_html.files_path\'\n+--tables_html \'$tables_html\'\n+--tables_html_files_path \'$tables_html.files_path\'\n+--rdata \'$rdata\'\n+--report_html \'$report_html\'\n+--log \'$log\'\n+ </token>\n \n- <macro name="basic_parameters">\n+ <macro name="basic_parameters">\n <param type="text" value="Project" label="Name of the project used for the report" argument="--projectName" help="No space allowed." >\n-\t\t<validator type="regex" message="Field requires a value. No space allowed.">\\S+</validator>\n-\t</param>\n+ <validator type="regex" message="Field requires a value. No space allowed.">\\S+</validator>\n+ </param>\n <param type="text" value="Galaxy" label="Name of the report author" argument="--author" help="No space allowed." >\n-\t\t<validator type="regex" message="Field requires a value. No space allowed.">\\S+</validator>\n-\t</param>\n+ <validator type="regex" message="Field requires a value. No space allowed.">\\S+</validator>\n+ </param>\n <param type="data" format="txt" label="Design / target file" argument="--targetFile" help="See the help section below for details on the required format." /> \n <param type="data" format="no_unzip.zip,zip" label="Zip file containing raw counts files" argument="--rawDir" help="See the help section below for details on the required format." /> \n <param type="text" size="100" value="alignment_not_unique,ambiguous,no_feature,not_aligned,too_low_aQual" label="Names of the features to be removed" argument="--featuresToRemove" help="Separate the features with a comma, no space allowed. More than once can be specified. Specific HTSeq-count information and rRNA for example. Default are \'alignment_not_unique,ambiguous,no_feature,not_aligned,too_low_aQual\'." >\n-\t\t<validator type="regex" message="Field requires a value. No space allowed.">\\S+</validator>\n-\t</param>\n+ <validator type="regex" message="Field requires a value. No space allowed.">\\S+</validator>\n+ </param>\n <param type="text" value="group" label="Factor of interest" argument="--varInt" help="Biological condition in the target file. De'..b'ter.png:** hierachical clustering of the samples (based on VST or rlog data);\n+ * **countsBoxplot.png:** boxplots on raw and normalized counts;\n+ * **densplot.png:** estimation of the density of the counts for each sample;\n+ * **diagSizeFactorsHist.png:** diagnostic of the estimation of the size factors;\n+ * **diagSizeFactorsTC.png:** plot of the size factors vs the total number of reads;\n+ * **dispersionsPlot.png:** graph of the estimations of the dispersions and diagnostic of log-linearity of the dispersions;\n+ * **majSeq.png:** percentage of reads caught by the feature having the highest count in each sample;\n+ * **pairwiseScatter.png:** pairwise scatter plot between each pair of samples and SERE values;\n+ * **rawpHist.png:** histogram of the raw p-values for each comparison;\n+ * **volcanoPlot.png:** vulcano plot for each comparison (\xe2\x88\x92 log10 (adjusted P value) vs log ratio of the means).\n \n \n **R log file:**\n \n \n-\t| Give the R console outputs.\n+ | Give the R console outputs.\n \n \n **R objects (.RData file):**\n \n \n-\t| Give all the R objects created during the analysis is saved: it may be used to perform downstream analyses.\n- </token>\n+ | Give all the R objects created during the analysis is saved: it may be used to perform downstream analyses.\n+ </token>\n \n- <macro name="common_citations">\n- <citation type="doi">10.1371/journal.pone.0157022</citation>\n- <citation type="bibtex">@INBOOK{Smyth05,\n- author = {G.-K. Smyth},\n- editor = {R. Gentleman, V. Carey, S. Dudoit, R. Irizarry, and W. Huber},\n- chapter = {Limma: linear models for microarray data},\n- title = {Bioinformatics and Computational Biology Solutions Using R and Bioconductor},\n- publisher = {Springer},\n- year = {2005},\n- pages = {397\xe2\x80\x93420}\n- }</citation>\n- <citation type="doi">10.1093/bioinformatics/btu638</citation>\n- <citation type="bibtex">@ARTICLE{Benjamini95,\n- author = {Y. Benjamini and Y. Hochberg},\n- title = {Controlling the false discovery rate: a practical and powerful approach to multiple testing},\n- journal = {Journal of the Royal Statistical Society B},\n- year = {1995},\n- volume = {57},\n- pages = {289\xe2\x80\x93300}\n- }</citation>\n- <citation type="bibtex">@ARTICLE{Benjamini01,\n- author = {Y. Benjamini and D. Yekutieli},\n- title = {The control of the false discovery rate in multiple testing under dependency},\n- journal = {Ann. Statist.},\n- year = {2001},\n- volume = {29},\n- number = {4},\n- pages = {1165\xe2\x80\x931188}\n- }</citation>\n- </macro>\n+ <macro name="common_citations">\n+ <citation type="doi">10.1371/journal.pone.0157022</citation>\n+ <citation type="bibtex">@INBOOK{Smyth05,\n+ author = {G.-K. Smyth},\n+ editor = {R. Gentleman, V. Carey, S. Dudoit, R. Irizarry, and W. Huber},\n+ chapter = {Limma: linear models for microarray data},\n+ title = {Bioinformatics and Computational Biology Solutions Using R and Bioconductor},\n+ publisher = {Springer},\n+ year = {2005},\n+ pages = {397\xe2\x80\x93420}\n+ }</citation>\n+ <citation type="doi">10.1093/bioinformatics/btu638</citation>\n+ <citation type="bibtex">@ARTICLE{Benjamini95,\n+ author = {Y. Benjamini and Y. Hochberg},\n+ title = {Controlling the false discovery rate: a practical and powerful approach to multiple testing},\n+ journal = {Journal of the Royal Statistical Society B},\n+ year = {1995},\n+ volume = {57},\n+ pages = {289\xe2\x80\x93300}\n+ }</citation>\n+ <citation type="bibtex">@ARTICLE{Benjamini01,\n+ author = {Y. Benjamini and D. Yekutieli},\n+ title = {The control of the false discovery rate in multiple testing under dependency},\n+ journal = {Ann. Statist.},\n+ year = {2001},\n+ volume = {29},\n+ number = {4},\n+ pages = {1165\xe2\x80\x931188}\n+ }</citation>\n+ </macro>\n \n </macros>\n' |
b |
diff -r de6d0b7c17af -r 05c9b1a7f44e make_html.py --- a/make_html.py Mon Oct 01 05:07:56 2018 -0400 +++ b/make_html.py Thu Jan 07 11:12:01 2021 +0000 |
b |
@@ -68,6 +68,6 @@ html+=fin_html -htmlf = file(output_html,'w') +htmlf = open(output_html,'w') htmlf.write(html) htmlf.close() |
b |
diff -r de6d0b7c17af -r 05c9b1a7f44e pre_sartools.py --- a/pre_sartools.py Mon Oct 01 05:07:56 2018 -0400 +++ b/pre_sartools.py Thu Jan 07 11:12:01 2021 +0000 |
b |
@@ -51,8 +51,8 @@ filename_base = basename(filename) # For RSEM files we process files as HTSeq count output tmpdir = tempfile.mkdtemp() - with open(filename, 'rb') as csvfile: - with open(join(tmpdir, basename(filename)), 'wb') as out: + with open(filename, 'rt') as csvfile: + with open(join(tmpdir, basename(filename)), 'wt') as out: spamwriter = csv.writer(out, delimiter='\t') reader = csv.DictReader(csvfile, delimiter='\t', skipinitialspace=True) if len(reader.fieldnames) > 2: |
b |
diff -r de6d0b7c17af -r 05c9b1a7f44e pre_sartools.xml --- a/pre_sartools.xml Mon Oct 01 05:07:56 2018 -0400 +++ b/pre_sartools.xml Thu Jan 07 11:12:01 2021 +0000 |
[ |
@@ -1,10 +1,10 @@ -<tool id="presartools" name="Preprocess files for SARTools" version="0.1.0"> +<tool id="presartools" name="Preprocess files for SARTools" version="0.1.1"> <description>generate design/target file and archive for SARTools inputs</description> <stdio> <regex match="WARNING:galaxy.model:Datatype class not found" level="warning"/> </stdio> - <command interpreter="python"> - pre_sartools.py + <command><![CDATA[ + python '$__tool_directory__/pre_sartools.py' --outfile=$outfile --outarch=$outarch #if $batch_condition.condition: @@ -23,7 +23,7 @@ #end for #end if - </command> + ]]></command> <inputs> <conditional name="batch_condition"> <param name="condition" type="boolean" checked="false" truevalue="batch" falsevalue="NULL" label="Add a blocking factor" help="Adjustment variable to use as a batch effect (default no)."/> @@ -101,7 +101,7 @@ <param name="levels_1|rep_counts_0|label" value="group2_rep1"/> <param name="levels_1|rep_counts_1|count_data" value="group2_count2.txt"/> <param name="levels_1|rep_counts_1|label" value="group2_rep2"/> - <output name="outfile" file="test_output_target.html"/> + <output name="outfile" file="test_output_target.html" compare="re_match"/> </test> </tests> <help> @@ -115,4 +115,7 @@ * In input of SARTools, don't change the "factor of interest", by default is group but you need to change the "Reference biological condition" in order to correspond to one name of the groups. * If you add a blocking factor, you need to specify it in "Advanced Parameters" of SARTools </help> + <citations> + <citation type="doi">10.1371/journal.pone.0157022</citation> + </citations> </tool> |
b |
diff -r de6d0b7c17af -r 05c9b1a7f44e repository_dependencies.xml --- a/repository_dependencies.xml Mon Oct 01 05:07:56 2018 -0400 +++ b/repository_dependencies.xml Thu Jan 07 11:12:01 2021 +0000 |
b |
@@ -1,4 +1,4 @@ -<?xml version="1.0"?> +<?xml version="1.0" ?> <repositories description="SARTools requires the Galaxy applicable data format no_unzip.zip"> - <repository changeset_revision="7800ba9a4c1e" name="no_unzip_datatype" owner="lecorguille" toolshed="https://toolshed.g2.bx.psu.edu" /> -</repositories> + <repository name="no_unzip_datatype" owner="lecorguille" toolshed="https://toolshed.g2.bx.psu.edu" changeset_revision="7800ba9a4c1e"/> +</repositories> \ No newline at end of file |
b |
diff -r de6d0b7c17af -r 05c9b1a7f44e template_script_DESeq2_CL.r --- a/template_script_DESeq2_CL.r Mon Oct 01 05:07:56 2018 -0400 +++ b/template_script_DESeq2_CL.r Thu Jan 07 11:12:01 2021 +0000 |
b |
@@ -184,6 +184,7 @@ save.image(file=paste0(projectName, ".RData")) # generating HTML report +Sys.setenv(HOME = getwd()) writeReport.DESeq2(target=target, counts=counts, out.DESeq2=out.DESeq2, summaryResults=summaryResults, majSequences=majSequences, workDir=workDir, projectName=projectName, author=author, targetFile=targetFile, rawDir=rawDir, featuresToRemove=featuresToRemove, varInt=varInt, |
b |
diff -r de6d0b7c17af -r 05c9b1a7f44e test-data/test_output_target.html --- a/test-data/test_output_target.html Mon Oct 01 05:07:56 2018 -0400 +++ b/test-data/test_output_target.html Thu Jan 07 11:12:01 2021 +0000 |
[ |
@@ -1,5 +1,5 @@ label files group -group1_rep1 dataset_1.dat group1 -group1_rep2 dataset_2.dat group1 -group2_rep1 dataset_3.dat group2 -group2_rep2 dataset_4.dat group2 +group1_rep1 dataset_[a-fA-F0-9]{8}-[a-fA-F0-9]{4}-[a-fA-F0-9]{4}-[a-fA-F0-9]{4}-[a-fA-F0-9]{12}.dat group1 +group1_rep2 dataset_[a-fA-F0-9]{8}-[a-fA-F0-9]{4}-[a-fA-F0-9]{4}-[a-fA-F0-9]{4}-[a-fA-F0-9]{12}.dat group1 +group2_rep1 dataset_[a-fA-F0-9]{8}-[a-fA-F0-9]{4}-[a-fA-F0-9]{4}-[a-fA-F0-9]{4}-[a-fA-F0-9]{12}.dat group2 +group2_rep2 dataset_[a-fA-F0-9]{8}-[a-fA-F0-9]{4}-[a-fA-F0-9]{4}-[a-fA-F0-9]{4}-[a-fA-F0-9]{12}.dat group2 |