Repository 'r_goseq_1_22_0'
hg clone https://eddie.galaxyproject.org/repos/mvdbeek/r_goseq_1_22_0

Changeset 7:9ffae7bc23c2 (2016-03-07)
Previous changeset 6:0e9424413ab0 (2016-03-03) Next changeset 8:fb95db039592 (2016-03-07)
Commit message:
planemo upload for repository https://github.com/ARTbio/tools-artbio/tree/master/tools/goseq_1_22_0 commit f95b47ed1a09ce14d3b565e8ea56d8bf12c35814-dirty
modified:
goseq.r
goseq.xml
test-data/dge_list.tab
test-data/wal.tab
tool_dependencies.xml
b
diff -r 0e9424413ab0 -r 9ffae7bc23c2 goseq.r
--- a/goseq.r Thu Mar 03 09:56:51 2016 -0500
+++ b/goseq.r Mon Mar 07 13:57:32 2016 -0500
[
@@ -15,14 +15,12 @@
     make_option(c("-n","--nobias_tab"), type="character", default=FALSE, help="Path to output file with P-values estimated using wallenius distribution and no correction for gene length bias."),
     make_option(c("-l","--length_bias_plot"), type="character", default=FALSE, help="Path to length-bias plot."),
     make_option(c("-sw","--sample_vs_wallenius_plot"), type="character", default=FALSE, help="Path to plot comparing sampling with wallenius p-values."),
-    make_option(c("-padj", "--p_adj_column"), type="integer",help="Column that contains p. adjust values"),
-    make_option(c("-c", "--cutoff"), type="double",dest="p_adj_cutoff",
-                help="Genes with p.adjust below cutoff are considered not differentially expressed and serve as control genes"),
     make_option(c("-r", "--repcnt"), type="integer", default=100, help="Number of repeats for sampling"),
     make_option(c("-lf", "--length_file"), type="character", default="FALSE", help = "Path to tabular file mapping gene id to length"),
     make_option(c("-cat_file", "--category_file"), default="FALSE", type="character", help = "Path to tabular file with gene_id <-> category mapping."),
     make_option(c("-g", "--genome"), default=NULL, type="character", help = "Genome [used for looking up correct gene length]"),
     make_option(c("-i", "--gene_id"), default=NULL, type="character", help = "Gene ID format of genes in DGE file"),
+    make_option(c("-p", "--p_adj_method"), default="BH", type="character", help="Multiple hypothesis testing correction method to use"),
     make_option(c("-cat", "--use_genes_without_cat"), default=FALSE, type="logical",
                 help="A large number of gene may have no GO term annotated. If this option is set to FALSE, genes without category will be ignored in the calculation of p-values(default behaviour). If TRUE these genes will count towards the total number of genes outside the tested category (default behaviour prior to version 1.15.2)."),
     make_option(c("-plots", "--make_plots"), default=FALSE, type="logical", help="produce diagnostic plots?")
@@ -34,8 +32,6 @@
 # Vars:
 dge_file = args$dge_file
 category_file = args$category_file
-p_adj_column = args$p_adj_colum
-p_adj_cutoff = args$p_adj_cutoff
 length_file = args$length_file
 genome = args$genome
 gene_id = args$gene_id
@@ -45,20 +41,14 @@
 length_bias_plot = args$length_bias_plot
 sample_vs_wallenius_plot = args$sample_vs_wallenius_plot
 repcnt = args$repcnt
+p_adj_method = args$p_adj_method
 use_genes_without_cat = args$use_genes_without_cat
 make_plots = args$make_plots
 
 # format DE genes into named vector suitable for goseq
-first_line = read.delim(dge_file, header = FALSE, nrow=1)
-# check if header [character where numeric is expected]
-if (is.numeric(first_line[,p_adj_column])) {
-  dge_table = read.delim(dge_file, header = FALSE, sep="\t")
-  } else {
-  dge_table = read.delim(dge_file, header = TRUE, sep="\t")
-  }
-
-genes = as.integer(dge_table[,p_adj_column]<p_adj_cutoff)
-names(genes) = dge_table[,1] # Assuming first row contains gene names
+dge_table = read.delim(dge_file, header = FALSE, sep="\t")
+genes = as.numeric(as.logical(dge_table[,ncol(dge_table)])) # Last column contains TRUE/FALSE
+names(genes) = dge_table[,1] # Assuming first column contains gene names
 
 # gene lengths, assuming last column
 if (length_file != "FALSE" ) {
@@ -96,13 +86,27 @@
 }
 
 # wallenius approximation of p-values
-GO.wall=goseq(pwf, genome = genome, id = gene_id, use_genes_without_cat = use_genes_without_cat, gene2cat=go_map)
+if (wallenius_tab != "" && wallenius_tab!="None") {
+  GO.wall=goseq(pwf, genome = genome, id = gene_id, use_genes_without_cat = use_genes_without_cat, gene2cat=go_map)
+  GO.wall$p.adjust.over_represented = p.adjust(GO.wall$over_represented_pvalue, method=p_adj_method)
+  GO.wall$p.adjust.under_represented = p.adjust(GO.wall$under_represented_pvalue, method=p_adj_method)
+  write.table(GO.wall, wallenius_tab, sep="\t", row.names = FALSE, quote = FALSE)
+}
 
-GO.nobias=goseq(pwf, genome = genome, id = gene_id, method="Hypergeometric", use_genes_without_cat = use_genes_without_cat, gene2cat=go_map)
+# hypergeometric (no length bias correction)
+if (nobias_tab != "" && nobias_tab != "None") {
+  GO.nobias=goseq(pwf, genome = genome, id = gene_id, method="Hypergeometric", use_genes_without_cat = use_genes_without_cat, gene2cat=go_map)
+  GO.nobias$p.adjust.over_represented = p.adjust(GO.nobias$over_represented_pvalue, method=p_adj_method)
+  GO.nobias$p.adjust.under_represented = p.adjust(GO.nobias$under_represented_pvalue, method=p_adj_method)
+  write.table(GO.nobias, nobias_tab, sep="\t", row.names = FALSE, quote = FALSE)
+}
 
 # Sampling distribution
 if (repcnt > 0) {
   GO.samp=goseq(pwf, genome = genome, id = gene_id, method="Sampling", repcnt=repcnt, use_genes_without_cat = use_genes_without_cat, gene2cat=go_map)
+  GO.samp$p.adjust.over_represented = p.adjust(GO.samp$over_represented_pvalue, method=p_adj_method)
+  GO.samp$p.adjust.under_represented = p.adjust(GO.samp$under_represented_pvalue, method=p_adj_method)
+  write.table(GO.samp, sampling_tab, sep="\t", row.names = FALSE, quote = FALSE)
   # Compare sampling with wallenius
   if (make_plots == TRUE) {
   pdf(sample_vs_wallenius_plot)
@@ -112,17 +116,22 @@
      abline(0,1,col=3,lty=2)
   graphics.off()
   }
-  write.table(GO.samp, sampling_tab, sep="\t", row.names = FALSE, quote = FALSE)
 }
 
-
-write.table(GO.wall, wallenius_tab, sep="\t", row.names = FALSE, quote = FALSE)
-write.table(GO.nobias, nobias_tab, sep="\t", row.names = FALSE, quote = FALSE)
-
 sessionInfo()
 
 # Use the following to get a list of supported genomes / gene ids
 
-# write.table(supportedGenomes(), "available_genomes.tab", row.names = FALSE, quote=FALSE)
+# supported_genomes = subset(supportedGenomes(), AvailableGeneIDs != "")
+# write.table(supported_genomes, "available_genomes.tab", row.names = FALSE, quote=FALSE)
 # write.table(supportedGeneIDs(), "supported_gene_ids.tab", row.name = FALSE, quote = FALSE)
 # write.table(table.summary, "input_gene_count_matrix.tab", row.names = FALSE, quote = FALSE)
+
+## get a list of genome db packages to install:
+# library("stringr")
+# orglist = unique(sapply(supported_genomes$db, function(x) str_extract(x, "[a-zA-Z]+" )))
+## install all genome packages
+# sapply(orglist, function(x) biocLite(paste("org", x, "eg.db", sep=".")))
+## get list of packages:
+# org_packages = sapply(orglist, function(x) paste("org", x, "eg.db", sep="."))
+# write.table(org_packages, "org_packages.tab", row.names = FALSE, col.names=FALSE, quote = FALSE)
\ No newline at end of file
b
diff -r 0e9424413ab0 -r 9ffae7bc23c2 goseq.xml
--- a/goseq.xml Thu Mar 03 09:56:51 2016 -0500
+++ b/goseq.xml Mon Mar 07 13:57:32 2016 -0500
[
b'@@ -1,4 +1,4 @@\n-<tool id="goseq" name="goseq" version="0.2.0">\n+<tool id="goseq" name="goseq" version="0.2.2">\n     <description>tests for overrepresented gene categories</description>\n     <macros>\n         <import>go_macros.xml</import>\n@@ -7,43 +7,62 @@\n     <expand macro="stdio" />\n     <command interpreter="Rscript">\n         goseq.r --dge_file "$dge_file"\n-        --p_adj_column "$p_adj_column"\n-        --cutoff "$p_adj_cutoff"\n         --length_file "$length_file"\n         --category_file "$category_file"\n+        #if "$methods[\'wallenius\']":\n         --wallenius_tab "$wallenius_tab"\n+        #end if\n+        #if "$methods[\'hypergeometric\']":\n+        --nobias_tab "$nobias_tab"\n+        #end if\n+        --repcnt "$methods.repcnt"\n         --sampling_tab "$sampling_tab"\n-        --nobias_tab "$nobias_tab"\n+        --p_adj_method "$p_adj_method"\n+        --use_genes_without_cat "$use_genes_without_cat"\n+        --make_plots "$make_plots"\n         --length_bias_plot "$length_bias_plot"\n         --sample_vs_wallenius_plot "$sample_vs_wallenius_plot"\n-        --repcnt "$repcnt"\n-        --use_genes_without_cat "$use_genes_without_cat"\n-        --make_plots "$make_plots"\n     </command>\n     <inputs>\n-        <param help="deseq2/edger/limma differential gene expression list" label="DGE list" name="dge_file" type="data" format="tabular" />\n-        <param help="Select the column that contains the multiple-testing corrected p-value" label="p adjust column" name="p_adj_column" type="data_column" numeric="true" data_ref="dge_file"/>\n+        <param help="A tabular file with gene names in the first column, and TRUE or FALSE in the last column. TRUE means a gene is differentially expressed. See help section for details." label="Differentially expressed gene file" name="dge_file" type="data" format="tabular" />\n         <param label="Gene length file for length bias correction" help="You can calculate the gene length using the get length and gc content tool" name="length_file" type="data" format="tabular" required="true" />\n         <param label="Gene category file" help="You can obtain a mapping of gene id to gene ontology using the getgo tool" name="category_file" type="data" format="tabular" required="true" />\n         <param help="For example, a large number of gene may have no GO term annotated. If this option is set to FALSE, those genes will be ignored in the calculation of p-values. If this option is set to TRUE, then these genes will count towards the total number of genes outside the category being tested"\n                name="use_genes_without_cat" label="Count genes without any category?" type="boolean"/>\n-        <param help="Typically 0.05 after multiple testing correction" max="1" label="Minimum p adjust value to consider genes as differentially expressed" name="p_adj_cutoff" type="float" value="0.05" />\n+        <section name="methods" title="Method options" expanded="True">\n+            <param name="wallenius" type="boolean" checked="true" label="Use wallenius method" help="See help for details" />\n+            <param name="hypergeometric" type="boolean" checked="false" label="Use hypergeometric method" help="Does not use gene length information. See help for details" />\n+            <param help="Draw this many random control gene sets. Set to 0 to not do sampling. Larger values take a long time" label="sampling depth" name="repcnt" size="3" type="integer" min="0" max="10000" value="0" />\n+        </section>\n+        <param name="p_adj_method" type="select" label="Select a method for multiple hypothesis testing correction">\n+            <option value="BH" selected="true">Benjamini-Hochberg [FDR] (1995)</option>\n+            <option value="holm">Holm (1979)</option>\n+            <option value="hommel">Hommel (1988)</option>\n+            <option value="hochberg">Hochberg (1988)</option>\n+            <option value="bonferroni">Bonferroni</option>\n+            <option value="BY">Benjamini - Yekutieli (2001)</option>\n'..b'"pdf" label="Plot P-value from sampling against wallenius distribution" name="sample_vs_wallenius_plot">\n-            <filter>repcnt != 0</filter>\n+            <filter>methods[\'repcnt\'] != 0</filter>\n+            <filter>methods[\'wallenius\']</filter>\n             <filter>make_plots</filter>\n         </data>\n-        <data format="tabular" label="Ranked category list - no length bias correction" name="nobias_tab" />\n+        <data format="tabular" label="Ranked category list - no length bias correction" name="nobias_tab">\n+            <filter>methods[\'hypergeometric\']</filter>\n+        </data>\n         <data format="tabular" label="Ranked category list - sampling" name="sampling_tab">\n-            <filter>repcnt != 0</filter>\n+            <filter>methods[\'repcnt\'] != 0</filter>\n         </data>\n-        <data format="tabular" label="Ranked category list - wallenius approx. of p-values" name="wallenius_tab" />\n+        <data format="tabular" label="Ranked category list - wallenius method" name="wallenius_tab">\n+            <filter>methods[\'wallenius\']</filter>\n+        </data>\n     </outputs>\n     <tests>\n         <test>\n@@ -66,14 +85,39 @@\n \n         **Input files**\n \n-        goseq needs information about the length of a gene to correct for potential length bias in differentially expressed genes.\n+        *DGE list:*\n+        goseq needs a tabular file with genes in the first column, and TRUE or FALSE in the last column.\n+        TRUE means the gene should count as differentially expressed, FALSE means it is not differentially expressed.\n+        You can use the "Compute an expression on every row" tool to create a TRUE / FALSE column for your dataset.\n+\n+        *Gene length file:*\n+        goseq needs information about the length of a gene to correct for potential length bias in differentially expressed genes\n+        using a prodbability weight function (PWF).\n         The format of this file is tabular, with gene_id in the first column and length in the second column.\n         The "get length and gc content" tool can produce such a file.\n \n+        *Gene category file:*\n         You will also need a file describing the membership of genes in categories. The format of this file is gene_id in the first column,\n         category name in the second column. If you are interested in gene ontology categories you can use the getgo file to retrive\n         gene ontologies for model organisms, or you can construct your own file.\n \n+        **Method options**\n+\n+        3 methods, "Wallenius", "Sampling" and "Hypergeometric", can be used to calculate the p-values as follows.\n+\n+        *"Wallenius"* approximates the true distribution of numbers of members of a category amongst DE genes by the Wallenius non-central hypergeometric distribution.\n+        This distribution assumes that within a category all genes have the same probability of being chosen.\n+        Therefore, this approximation works best when the range in probabilities obtained by the probability weighting function is small.\n+\n+        *"Sampling"* uses random sampling to approximate the true distribution and uses it to calculate the p-values for over (and under) representation of categories.\n+        Although this is the most accurate method given a high enough value of sampling depth, its use quickly becomes computationally prohibitive.\n+\n+        *"Hypergeometric"* assumes there is no bias in power to detect differential expression at all and calculates the p-values using a standard hypergeometric distribution.\n+        Useful if you wish to test the effect of selection bias on your results.\n+\n+        CAUTION:  "Hypergeometric" should NEVER be used for producing results for biological interpretation.\n+        If there is genuinely no bias in power to detect DE in your experiment, the PWF will reflect this and the other methods will produce accuracte results.\n+\n         .. _manual: https://bioconductor.org/packages/release/bioc/vignettes/goseq/inst/doc/goseq.pdf\n \n \n'
b
diff -r 0e9424413ab0 -r 9ffae7bc23c2 test-data/dge_list.tab
--- a/test-data/dge_list.tab Thu Mar 03 09:56:51 2016 -0500
+++ b/test-data/dge_list.tab Mon Mar 07 13:57:32 2016 -0500
b
b'@@ -1,1000 +1,1000 @@\n-ENSG00000140459\t0.72654265501997\n-ENSG00000236824\t0.621241793648661\n-ENSG00000162526\t0.104072112354657\n-ENSG00000090402\t0.00550590320364419\n-ENSG00000169188\t0.752973943574106\n-ENSG00000124103\t0.508292390900193\n-ENSG00000241680\t0.297679791800193\n-ENSG00000089009\t0.300444395667807\n-ENSG00000196696\t0.374747091864761\n-ENSG00000006837\t0.883750148448997\n-ENSG00000112312\t0.00157610534964364\n-ENSG00000240392\t0.302701874577034\n-ENSG00000010932\t0.118981349588869\n-ENSG00000167685\t0.076500408607647\n-ENSG00000237101\t0.748031404245103\n-ENSG00000244270\t0.567972685627182\n-ENSG00000104331\t0.00579192580215921\n-ENSG00000242858\t0.0378412177811479\n-ENSG00000148484\t0.718026595230658\n-ENSG00000057608\t0.964227972088948\n-ENSG00000182841\t0.0884209354151656\n-ENSG00000230903\t0.350797225752382\n-ENSG00000106868\t0.788981237232149\n-ENSG00000214564\t0.655009438199043\n-ENSG00000169762\t0.255621294102106\n-ENSG00000168758\t0.163373910729433\n-ENSG00000182827\t0.880121187926376\n-ENSG00000125637\t0.0396047898199658\n-ENSG00000118873\t0.259118545361492\n-ENSG00000186532\t0.884943302417759\n-ENSG00000106771\t0.107076952807406\n-ENSG00000204348\t0.38585136650363\n-ENSG00000197062\t0.244378087660012\n-ENSG00000171067\t0.860339995928752\n-ENSG00000228118\t0.837580099847927\n-ENSG00000213077\t0.0346627558595947\n-ENSG00000188549\t0.0364688234065438\n-ENSG00000135537\t0.818437150201755\n-ENSG00000173715\t0.313716721815305\n-ENSG00000227742\t0.00693864770618258\n-ENSG00000148158\t0.00356590491562172\n-ENSG00000134461\t0.0799694519824768\n-ENSG00000174442\t0.9104363820863\n-ENSG00000198648\t5.66237569853738e-54\n-ENSG00000228599\t0.171370116774069\n-ENSG00000167842\t1.68461902141834e-06\n-ENSG00000108953\t0.018535085127156\n-ENSG00000185504\t0.000252088854916783\n-ENSG00000178950\t0.374511091101791\n-ENSG00000160051\t0.837754660842895\n-ENSG00000130787\t0.627567039717229\n-ENSG00000154146\t0.21971850994087\n-ENSG00000204956\t0.922155399062633\n-ENSG00000231181\t0.798470252573313\n-ENSG00000149308\t0.205056998763193\n-ENSG00000151748\t0.960438036765227\n-ENSG00000141510\t0.843199243028581\n-ENSG00000105325\t0.256030223197636\n-ENSG00000173163\t0.307924645611919\n-ENSG00000064545\t0.0294202433903509\n-ENSG00000236946\t0.787953789147351\n-ENSG00000104450\t0.0261557859283198\n-ENSG00000174469\t0.371325165629903\n-ENSG00000010322\t0.0208260631889359\n-ENSG00000126562\t0.788271827203178\n-ENSG00000143919\t0.883536889885289\n-ENSG00000236285\t0.652881364924924\n-ENSG00000160213\t0.891666551921221\n-ENSG00000185798\t0.808815635747676\n-ENSG00000073614\t0.730900557418546\n-ENSG00000138587\t0.892556542035936\n-ENSG00000090273\t0.485697340128452\n-ENSG00000123384\t0.182965348704756\n-ENSG00000070961\t5.54110180984277e-14\n-ENSG00000159346\t0.577707704641258\n-ENSG00000141425\t0.209299850711904\n-ENSG00000072071\t0.264953967987316\n-ENSG00000057935\t0.0876841507255324\n-ENSG00000226790\t0.739812259382103\n-ENSG00000117410\t0.0991426717444789\n-ENSG00000100038\t5.5224120355487e-05\n-ENSG00000169660\t0.957344873331126\n-ENSG00000227968\t0.968126132117202\n-ENSG00000220483\t0.834400227373994\n-ENSG00000186130\t0.0886115611903655\n-ENSG00000018607\t0.892228191251005\n-ENSG00000142676\t3.05327141290058e-07\n-ENSG00000226144\t0.15035721878846\n-ENSG00000233454\t0.535010072830088\n-ENSG00000230006\t0.993550786209047\n-ENSG00000225405\t0.51182760145349\n-ENSG00000206192\t0.998818135341878\n-ENSG00000141012\t0.675869428835717\n-ENSG00000133138\t0.596116982047846\n-ENSG00000240418\t0.0414032135189338\n-ENSG00000230074\t0.176837449607711\n-ENSG00000106803\t0.110457736393565\n-ENSG00000134987\t0.419483726256258\n-ENSG00000179119\t0.90886027052608\n-ENSG00000130770\t0.797934384822854\n-ENSG00000213760\t0.733546382048368\n-ENSG00000167785\t0.819823215696948\n-ENSG00000152782\t0.187934176357927\n-ENSG00000103121\t0.000116075418643732\n-ENSG00000167614\t0.97150896023414\n-ENSG00000145990\t0.600668890368056\n-ENSG00000233846\t0.617587088091658\n-ENSG00000137285\t0.762128131856854\n-ENSG00000186743\t0.390864600953697\n-ENSG00000130717\t0.786671083021599\n-ENSG00000235363\t0.310504546625491\n-ENSG00000152642\t0.762465600065342\n-ENSG00000239377\t0.2140'..b'0234639\tFalse\n+ENSG00000101294\tFalse\n+ENSG00000042445\tFalse\n+ENSG00000229044\tFalse\n+ENSG00000105355\tFalse\n+ENSG00000157637\tFalse\n+ENSG00000186056\tFalse\n+ENSG00000090020\tFalse\n+ENSG00000114120\tTrue\n+ENSG00000214975\tFalse\n+ENSG00000164209\tFalse\n+ENSG00000118096\tFalse\n+ENSG00000236163\tFalse\n+ENSG00000230243\tFalse\n+ENSG00000147669\tTrue\n+ENSG00000213904\tFalse\n+ENSG00000213880\tFalse\n+ENSG00000124181\tTrue\n+ENSG00000197697\tFalse\n+ENSG00000235698\tFalse\n+ENSG00000112531\tTrue\n+ENSG00000241772\tFalse\n+ENSG00000164308\tFalse\n+ENSG00000189143\tFalse\n+ENSG00000198865\tTrue\n+ENSG00000167642\tTrue\n+ENSG00000156973\tFalse\n+ENSG00000139233\tFalse\n+ENSG00000074211\tFalse\n+ENSG00000110906\tFalse\n+ENSG00000236570\tFalse\n+ENSG00000112365\tFalse\n+ENSG00000162444\tFalse\n+ENSG00000143970\tTrue\n+ENSG00000179918\tTrue\n+ENSG00000170619\tFalse\n+ENSG00000187172\tFalse\n+ENSG00000119669\tFalse\n+ENSG00000074054\tFalse\n+ENSG00000114416\tFalse\n+ENSG00000204805\tFalse\n+ENSG00000226637\tFalse\n+ENSG00000213092\tFalse\n+ENSG00000116209\tTrue\n+ENSG00000241923\tFalse\n+ENSG00000092208\tFalse\n+ENSG00000161692\tFalse\n+ENSG00000018699\tFalse\n+ENSG00000134765\tTrue\n+ENSG00000232943\tFalse\n+ENSG00000171055\tTrue\n+ENSG00000170412\tFalse\n+ENSG00000180884\tFalse\n+ENSG00000213066\tFalse\n+ENSG00000189343\tFalse\n+ENSG00000152377\tTrue\n+ENSG00000137642\tFalse\n+ENSG00000230406\tFalse\n+ENSG00000027697\tTrue\n+ENSG00000138685\tFalse\n+ENSG00000125691\tTrue\n+ENSG00000139192\tFalse\n+ENSG00000170142\tTrue\n+ENSG00000236735\tFalse\n+ENSG00000127226\tFalse\n+ENSG00000213033\tFalse\n+ENSG00000174483\tFalse\n+ENSG00000232676\tFalse\n+ENSG00000181359\tFalse\n+ENSG00000114735\tFalse\n+ENSG00000084073\tFalse\n+ENSG00000132879\tTrue\n+ENSG00000187504\tTrue\n+ENSG00000131100\tTrue\n+ENSG00000022556\tFalse\n+ENSG00000128590\tTrue\n+ENSG00000214029\tFalse\n+ENSG00000163322\tFalse\n+ENSG00000164332\tFalse\n+ENSG00000188529\tTrue\n+ENSG00000164930\tFalse\n+ENSG00000188863\tFalse\n+ENSG00000198746\tFalse\n+ENSG00000231434\tFalse\n+ENSG00000168916\tTrue\n+ENSG00000203837\tTrue\n+ENSG00000118507\tFalse\n+ENSG00000184319\tFalse\n+ENSG00000130349\tTrue\n+ENSG00000100478\tFalse\n+ENSG00000185189\tFalse\n+ENSG00000113621\tTrue\n+ENSG00000238251\tFalse\n+ENSG00000198250\tTrue\n+ENSG00000232905\tFalse\n+ENSG00000206560\tTrue\n+ENSG00000225374\tFalse\n+ENSG00000236330\tFalse\n+ENSG00000136048\tFalse\n+ENSG00000146574\tFalse\n+ENSG00000129518\tTrue\n+ENSG00000111652\tFalse\n+ENSG00000136709\tFalse\n+ENSG00000159259\tFalse\n+ENSG00000205628\tFalse\n+ENSG00000236739\tFalse\n+ENSG00000118680\tTrue\n+ENSG00000174799\tFalse\n+ENSG00000227376\tFalse\n+ENSG00000079215\tFalse\n+ENSG00000224628\tFalse\n+ENSG00000197121\tFalse\n+ENSG00000151690\tTrue\n+ENSG00000230531\tFalse\n+ENSG00000126226\tFalse\n+ENSG00000074071\tTrue\n+ENSG00000100577\tFalse\n+ENSG00000086289\tFalse\n+ENSG00000205208\tFalse\n+ENSG00000134326\tFalse\n+ENSG00000157423\tFalse\n+ENSG00000239569\tFalse\n+ENSG00000164241\tFalse\n+ENSG00000161040\tFalse\n+ENSG00000174705\tFalse\n+ENSG00000197888\tTrue\n+ENSG00000141448\tFalse\n+ENSG00000181690\tFalse\n+ENSG00000166788\tFalse\n+ENSG00000101473\tTrue\n+ENSG00000204396\tTrue\n+ENSG00000168826\tFalse\n+ENSG00000155729\tFalse\n+ENSG00000142082\tFalse\n+ENSG00000143727\tFalse\n+ENSG00000203995\tFalse\n+ENSG00000165055\tFalse\n+ENSG00000213971\tFalse\n+ENSG00000224453\tFalse\n+ENSG00000108960\tFalse\n+ENSG00000183506\tFalse\n+ENSG00000099139\tFalse\n+ENSG00000111331\tTrue\n+ENSG00000133226\tFalse\n+ENSG00000217801\tFalse\n+ENSG00000130227\tFalse\n+ENSG00000164144\tFalse\n+ENSG00000128731\tFalse\n+ENSG00000079785\tFalse\n+ENSG00000106948\tFalse\n+ENSG00000115107\tTrue\n+ENSG00000236696\tFalse\n+ENSG00000198482\tFalse\n+ENSG00000173681\tFalse\n+ENSG00000204164\tFalse\n+ENSG00000228612\tFalse\n+ENSG00000003096\tTrue\n+ENSG00000180881\tFalse\n+ENSG00000205084\tFalse\n+ENSG00000159173\tFalse\n+ENSG00000197535\tFalse\n+ENSG00000223382\tTrue\n+ENSG00000183309\tFalse\n+ENSG00000215099\tFalse\n+ENSG00000116685\tFalse\n+ENSG00000181472\tFalse\n+ENSG00000132274\tFalse\n+ENSG00000145494\tFalse\n+ENSG00000122644\tTrue\n+ENSG00000157107\tTrue\n+ENSG00000145354\tFalse\n+ENSG00000158467\tFalse\n+ENSG00000164934\tFalse\n+ENSG00000134986\tTrue\n+ENSG00000121988\tFalse\n+ENSG00000178996\tFalse\n'
b
diff -r 0e9424413ab0 -r 9ffae7bc23c2 test-data/wal.tab
--- a/test-data/wal.tab Thu Mar 03 09:56:51 2016 -0500
+++ b/test-data/wal.tab Mon Mar 07 13:57:32 2016 -0500
b
@@ -1,3 +1,3 @@
-category over_represented_pvalue under_represented_pvalue numDEInCat numInCat term ontology
-GO:0000278 0.01123506125343 0.999376653834006 4 5 mitotic cell cycle BP
-GO:0000003 1 0.805913166914891 0 1 reproduction BP
+category over_represented_pvalue under_represented_pvalue numDEInCat numInCat term ontology p.adjust.over_represented p.adjust.under_represented
+GO:0000278 0.416311963944304 1 4 5 mitotic cell cycle BP 0.832623927888609 1
+GO:0000003 1 0.416311963944305 0 1 reproduction BP 1 0.83262392788861
b
diff -r 0e9424413ab0 -r 9ffae7bc23c2 tool_dependencies.xml
--- a/tool_dependencies.xml Thu Mar 03 09:56:51 2016 -0500
+++ b/tool_dependencies.xml Mon Mar 07 13:57:32 2016 -0500
b
@@ -4,6 +4,6 @@
          <repository changeset_revision="9f31a291b305" name="package_r_3_2_1" owner="iuc" toolshed="https://testtoolshed.g2.bx.psu.edu" />
     </package>
     <package name="goseq" version="1.22.0">
-         <repository changeset_revision="6aec352282a6" name="package_r_3_2_1_goseq_1_22_0" owner="mvdbeek" toolshed="https://testtoolshed.g2.bx.psu.edu" />
+         <repository changeset_revision="4f43af0c6b44" name="package_r_3_2_1_goseq_1_22_0" owner="mvdbeek" toolshed="https://testtoolshed.g2.bx.psu.edu" />
     </package>
 </tool_dependency>