# HG changeset patch # User Jim Johnson # Date 1395090192 18000 # Node ID 9d5e59373c84da93412d3979d6be13cec2914193 Initial upload diff -r 000000000000 -r 9d5e59373c84 README.rst --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/README.rst Mon Mar 17 16:03:12 2014 -0500 @@ -0,0 +1,52 @@ +This package contains a Galaxy workflow that reduces a reference protein sequence database by retaining only the sequences that are detected at significant levels in the RNA-seq sample. +The workflow uses RSEM to quantify transcripts in an RNA-seq sample. + +See http://www.galaxyproject.org for information about the Galaxy Project. + + +Availability +============ + +This workflow is available to download and/or install from the main +Galaxy Tool Shed: + +http://toolshed.g2.bx.psu.edu/view/galaxyp/proteomics_rnaseq_reduced_db_workflow + + +Reference Data +============== + +For Human RNAseq data this workflow was tested using reference data from: + +* ftp://ftp.ensembl.org/pub/release-73/fasta/homo_sapiens/dna/Homo_sapiens.GRCh37.73.dna.chromosome.[1-9XY]*.fa.gz +* ftp://ftp.ensembl.org/pub/release-73/fasta/homo_sapiens/pep/Homo_sapiens.GRCh37.73.pep.all.fa.gz +* ftp://ftp.ensembl.org/pub/release-73/gtf/homo_sapiens/Homo_sapiens.GRCh37.73.gtf.gz + + +For Mouse RNAseq data this workflow was tested using reference data from: + +* ftp://ftp.ensembl.org/pub/release-73/fasta/mus_musculus/dna/Mus_musculus.GRCm38.73.dna.chromosome.[1-9XY]*.fa.gz +* ftp://ftp.ensembl.org/pub/release-73/fasta/mus_musculus/pep/Mus_musculus.GRCm38.73.pep.all.fa.gz +* ftp://ftp.ensembl.org/pub/release-73/gtf/mus_musculus/Mus_musculus.GRCm38.73.gtf.gz + + + +Dependencies +============ + +These dependencies should be resolved automatically via the Galaxy Tool Shed: + +* http://toolshed.g2.bx.psu.edu/view//jjohnson/rsem +* http://toolshed.g2.bx.psu.edu/view/devteam/fasta_formatter + + +History +======= + +======= ====================================================================== +Version Changes +------- ---------------------------------------------------------------------- +v0.0.1 - Initial release to Tool Shed (March, 2014) +======= ====================================================================== + + diff -r 000000000000 -r 9d5e59373c84 proteomics_rnaseq_reduced_db_workflow.ga --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/proteomics_rnaseq_reduced_db_workflow.ga Mon Mar 17 16:03:12 2014 -0500 @@ -0,0 +1,689 @@ +{ + "a_galaxy_workflow": "true", + "annotation": "Filter out proteins that have a transcript expression level, as quantified by RNA-Seq data, below a certain threshold.", + "format-version": "0.1", + "name": "Proteomics Reduced DB", + "steps": { + "0": { + "annotation": "", + "id": 0, + "input_connections": {}, + "inputs": [ + { + "description": "", + "name": "Ensembl Genome Reference Fasta" + } + ], + "name": "Input dataset", + "outputs": [], + "position": { + "left": 264, + "top": 438 + }, + "tool_errors": null, + "tool_id": null, + "tool_state": "{\"name\": \"Ensembl Genome Reference Fasta\"}", + "tool_version": null, + "type": "data_input", + "user_outputs": [] + }, + "1": { + "annotation": "", + "id": 1, + "input_connections": {}, + "inputs": [ + { + "description": "", + "name": "Ensembl GTF File (gene models)" + } + ], + "name": "Input dataset", + "outputs": [], + "position": { + "left": 261, + "top": 521 + }, + "tool_errors": null, + "tool_id": null, + "tool_state": "{\"name\": \"Ensembl GTF File (gene models)\"}", + "tool_version": null, + "type": "data_input", + "user_outputs": [] + }, + "2": { + "annotation": "", + "id": 2, + "input_connections": {}, + "inputs": [ + { + "description": "", + "name": "Ensembl Protein FASTA (reference proteome)" + } + ], + "name": "Input dataset", + "outputs": [], + "position": { + "left": 630, + "top": 286 + }, + "tool_errors": null, + "tool_id": null, + "tool_state": "{\"name\": \"Ensembl Protein FASTA (reference proteome)\"}", + "tool_version": null, + "type": "data_input", + "user_outputs": [] + }, + "3": { + "annotation": "", + "id": 3, + "input_connections": {}, + "inputs": [ + { + "description": "", + "name": "RNA-Seq left paired-end fastq" + } + ], + "name": "Input dataset", + "outputs": [], + "position": { + "left": 585, + "top": 618 + }, + "tool_errors": null, + "tool_id": null, + "tool_state": "{\"name\": \"RNA-Seq left paired-end fastq\"}", + "tool_version": null, + "type": "data_input", + "user_outputs": [] + }, + "4": { + "annotation": "", + "id": 4, + "input_connections": {}, + "inputs": [ + { + "description": "", + "name": "RNA-Seq right paired-end fastq" + } + ], + "name": "Input dataset", + "outputs": [], + "position": { + "left": 586, + "top": 703 + }, + "tool_errors": null, + "tool_id": null, + "tool_state": "{\"name\": \"RNA-Seq right paired-end fastq\"}", + "tool_version": null, + "type": "data_input", + "user_outputs": [] + }, + "5": { + "annotation": "", + "id": 5, + "input_connections": { + "reference|gtf": { + "id": 1, + "output_name": "output" + }, + "reference|reference_fasta_file": { + "id": 0, + "output_name": "output" + } + }, + "inputs": [], + "name": "RSEM prepare reference", + "outputs": [ + { + "name": "reference_file", + "type": "rsem_ref" + } + ], + "position": { + "left": 516, + "top": 425 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "toolshed.g2.bx.psu.edu/repos/jjohnson/rsem/rsem_prepare_reference/1.1.17", + "tool_state": "{\"__page__\": 0, \"reference\": \"{\\\"ref_type\\\": \\\"genomic\\\", \\\"gtf\\\": null, \\\"reference_fasta_file\\\": null, \\\"__current_case__\\\": 1}\", \"reference_name\": \"\\\"primaryEnsemblGtfRef\\\"\", \"__rerun_remap_job_id__\": null, \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCm38_canon.len\\\"\", \"polya\": \"{\\\"polya_use\\\": \\\"add\\\", \\\"polya_length\\\": \\\"125\\\", \\\"__current_case__\\\": 0}\", \"transcript_to_gene_map\": \"null\", \"ntog\": \"\\\"False\\\"\"}", + "tool_version": "1.1.17", + "type": "tool", + "user_outputs": [] + }, + "6": { + "annotation": "", + "id": 6, + "input_connections": { + "input": { + "id": 2, + "output_name": "output" + } + }, + "inputs": [], + "name": "FASTA-to-Tabular", + "outputs": [ + { + "name": "output", + "type": "tabular" + } + ], + "position": { + "left": 900, + "top": 273 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "fasta2tab", + "tool_state": "{\"__page__\": 0, \"keep_first\": \"\\\"0\\\"\", \"descr_columns\": \"\\\"1\\\"\", \"input\": \"null\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCm38_canon.len\\\"\", \"__rerun_remap_job_id__\": null}", + "tool_version": "1.1.0", + "type": "tool", + "user_outputs": [] + }, + "7": { + "annotation": "", + "id": 7, + "input_connections": { + "input|fastq|fastq1": { + "id": 3, + "output_name": "output" + }, + "input|fastq|fastq2": { + "id": 4, + "output_name": "output" + }, + "reference|rsem_ref": { + "id": 5, + "output_name": "reference_file" + } + }, + "inputs": [], + "name": "RSEM calculate expression", + "outputs": [ + { + "name": "gene_abundances", + "type": "tabular" + }, + { + "name": "isoform_abundances", + "type": "tabular" + }, + { + "name": "transcript_bam", + "type": "bam" + }, + { + "name": "transcript_sorted_bam", + "type": "bam" + }, + { + "name": "genome_bam", + "type": "bam" + }, + { + "name": "genome_sorted_bam", + "type": "bam" + }, + { + "name": "log", + "type": "txt" + } + ], + "position": { + "left": 862, + "top": 524 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "toolshed.g2.bx.psu.edu/repos/jjohnson/rsem/rsem_calculate_expression/1.1.17", + "tool_state": "{\"__page__\": 0, \"reference\": \"{\\\"rsem_ref\\\": null, \\\"refSrc\\\": \\\"history\\\", \\\"__current_case__\\\": 1}\", \"rsem_options\": \"{\\\"fullparams\\\": \\\"default\\\", \\\"__current_case__\\\": 0}\", \"rsem_outputs\": \"{\\\"result_bams\\\": \\\"none\\\", \\\"__current_case__\\\": 0}\", \"__rerun_remap_job_id__\": null, \"seedlength\": \"\\\"25\\\"\", \"sample\": \"\\\"rsem_sample\\\"\", \"forward_prob\": \"\\\"0.5\\\"\", \"input\": \"{\\\"fastq\\\": {\\\"fastq2\\\": null, \\\"fastq1\\\": null, \\\"matepair\\\": \\\"paired\\\", \\\"__current_case__\\\": 1}, \\\"bowtie_options\\\": {\\\"fullparams\\\": \\\"default\\\", \\\"__current_case__\\\": 0}, \\\"fastq_select\\\": \\\"--phred33-quals\\\", \\\"__current_case__\\\": 0, \\\"format\\\": \\\"fastq\\\"}\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCm38_canon.len\\\"\"}", + "tool_version": "1.1.17", + "type": "tool", + "user_outputs": [] + }, + "8": { + "annotation": "", + "id": 8, + "input_connections": { + "input": { + "id": 6, + "output_name": "output" + } + }, + "inputs": [], + "name": "Cut", + "outputs": [ + { + "name": "out_file1", + "type": "tabular" + } + ], + "position": { + "left": 1128, + "top": 401 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "Cut1", + "tool_state": "{\"__page__\": 0, \"__rerun_remap_job_id__\": null, \"delimiter\": \"\\\"T\\\"\", \"columnList\": \"\\\"c1\\\"\", \"input\": \"null\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCm38_canon.len\\\"\"}", + "tool_version": "1.0.2", + "type": "tool", + "user_outputs": [] + }, + "9": { + "annotation": "", + "id": 9, + "input_connections": { + "input": { + "id": 7, + "output_name": "isoform_abundances" + } + }, + "inputs": [], + "name": "Filter", + "outputs": [ + { + "name": "out_file1", + "type": "input" + } + ], + "position": { + "left": 1485, + "top": 728 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "Filter1", + "tool_state": "{\"__page__\": 0, \"__rerun_remap_job_id__\": null, \"cond\": \"\\\"c3>0.000001\\\"\", \"input\": \"null\", \"header_lines\": \"\\\"0\\\"\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCm38_canon.len\\\"\"}", + "tool_version": "1.1.0", + "type": "tool", + "user_outputs": [] + }, + "10": { + "annotation": "", + "id": 10, + "input_connections": { + "input": { + "id": 8, + "output_name": "out_file1" + } + }, + "inputs": [], + "name": "Convert", + "outputs": [ + { + "name": "out_file1", + "type": "tabular" + } + ], + "position": { + "left": 1341, + "top": 528 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "Convert characters1", + "tool_state": "{\"__page__\": 0, \"convert_from\": \"\\\"s\\\"\", \"__rerun_remap_job_id__\": null, \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCm38_canon.len\\\"\", \"input\": \"null\"}", + "tool_version": "1.0.0", + "type": "tool", + "user_outputs": [] + }, + "11": { + "annotation": "", + "id": 11, + "input_connections": { + "input": { + "id": 9, + "output_name": "out_file1" + } + }, + "inputs": [], + "name": "Compute", + "outputs": [ + { + "name": "out_file1", + "type": "input" + } + ], + "position": { + "left": 1803, + "top": 682 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "Add_a_column1", + "tool_state": "{\"__page__\": 0, \"__rerun_remap_job_id__\": null, \"cond\": \"\\\"c3*1000000\\\"\", \"input\": \"null\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCm38_canon.len\\\"\", \"round\": \"\\\"no\\\"\"}", + "tool_version": "1.1.0", + "type": "tool", + "user_outputs": [] + }, + "12": { + "annotation": "", + "id": 12, + "input_connections": { + "input": { + "id": 10, + "output_name": "out_file1" + } + }, + "inputs": [], + "name": "Cut", + "outputs": [ + { + "name": "out_file1", + "type": "tabular" + } + ], + "position": { + "left": 1587, + "top": 513 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "Cut1", + "tool_state": "{\"__page__\": 0, \"__rerun_remap_job_id__\": null, \"delimiter\": \"\\\"T\\\"\", \"columnList\": \"\\\"c5\\\"\", \"input\": \"null\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCm38_canon.len\\\"\"}", + "tool_version": "1.0.2", + "type": "tool", + "user_outputs": [] + }, + "13": { + "annotation": "", + "id": 13, + "input_connections": { + "input": { + "id": 12, + "output_name": "out_file1" + } + }, + "inputs": [], + "name": "Convert", + "outputs": [ + { + "name": "out_file1", + "type": "tabular" + } + ], + "position": { + "left": 1808, + "top": 480 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "Convert characters1", + "tool_state": "{\"__page__\": 0, \"convert_from\": \"\\\"Co\\\"\", \"__rerun_remap_job_id__\": null, \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCm38_canon.len\\\"\", \"input\": \"null\"}", + "tool_version": "1.0.0", + "type": "tool", + "user_outputs": [] + }, + "14": { + "annotation": "", + "id": 14, + "input_connections": { + "input": { + "id": 13, + "output_name": "out_file1" + } + }, + "inputs": [], + "name": "Cut", + "outputs": [ + { + "name": "out_file1", + "type": "tabular" + } + ], + "position": { + "left": 2006, + "top": 408 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "Cut1", + "tool_state": "{\"__page__\": 0, \"__rerun_remap_job_id__\": null, \"delimiter\": \"\\\"T\\\"\", \"columnList\": \"\\\"c2\\\"\", \"input\": \"null\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCm38_canon.len\\\"\"}", + "tool_version": "1.0.2", + "type": "tool", + "user_outputs": [] + }, + "15": { + "annotation": "", + "id": 15, + "input_connections": { + "input1": { + "id": 6, + "output_name": "output" + }, + "input2": { + "id": 14, + "output_name": "out_file1" + } + }, + "inputs": [], + "name": "Paste", + "outputs": [ + { + "name": "out_file1", + "type": "input" + } + ], + "position": { + "left": 2219, + "top": 318 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "Paste1", + "tool_state": "{\"input2\": \"null\", \"__page__\": 0, \"input1\": \"null\", \"__rerun_remap_job_id__\": null, \"delimiter\": \"\\\"T\\\"\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCm38_canon.len\\\"\"}", + "tool_version": "1.0.0", + "type": "tool", + "user_outputs": [] + }, + "16": { + "annotation": "", + "id": 16, + "input_connections": { + "input1": { + "id": 15, + "output_name": "out_file1" + }, + "input2": { + "id": 11, + "output_name": "out_file1" + } + }, + "inputs": [], + "name": "Join two Datasets", + "outputs": [ + { + "name": "out_file1", + "type": "input" + } + ], + "position": { + "left": 2417, + "top": 425 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "join1", + "tool_state": "{\"input2\": \"null\", \"__page__\": 0, \"field1\": \"{\\\"__class__\\\": \\\"UnvalidatedValue\\\", \\\"value\\\": \\\"3\\\"}\", \"partial\": \"\\\"\\\"\", \"field2\": \"{\\\"__class__\\\": \\\"UnvalidatedValue\\\", \\\"value\\\": \\\"1\\\"}\", \"__rerun_remap_job_id__\": null, \"fill_empty_columns\": \"{\\\"fill_empty_columns_switch\\\": \\\"no_fill\\\", \\\"__current_case__\\\": 0}\", \"unmatched\": \"\\\"\\\"\", \"input1\": \"null\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCm38_canon.len\\\"\"}", + "tool_version": "2.0.2", + "type": "tool", + "user_outputs": [] + }, + "17": { + "annotation": "", + "id": 17, + "input_connections": { + "input": { + "id": 16, + "output_name": "out_file1" + } + }, + "inputs": [], + "name": "Add column", + "outputs": [ + { + "name": "out_file1", + "type": "input" + } + ], + "position": { + "left": 2619, + "top": 380 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "addValue", + "tool_state": "{\"__page__\": 0, \"__rerun_remap_job_id__\": null, \"exp\": \"\\\" \\\"\", \"iterate\": \"\\\"no\\\"\", \"input\": \"null\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCm38_canon.len\\\"\"}", + "tool_version": "1.0.0", + "type": "tool", + "user_outputs": [] + }, + "18": { + "annotation": "", + "id": 18, + "input_connections": { + "input": { + "id": 17, + "output_name": "out_file1" + } + }, + "inputs": [], + "name": "Add column", + "outputs": [ + { + "name": "out_file1", + "type": "input" + } + ], + "position": { + "left": 2832, + "top": 302 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "addValue", + "tool_state": "{\"__page__\": 0, \"__rerun_remap_job_id__\": null, \"exp\": \"\\\"tpm:\\\"\", \"iterate\": \"\\\"no\\\"\", \"input\": \"null\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCm38_canon.len\\\"\"}", + "tool_version": "1.0.0", + "type": "tool", + "user_outputs": [] + }, + "19": { + "annotation": "", + "id": 19, + "input_connections": { + "input1": { + "id": 18, + "output_name": "out_file1" + } + }, + "inputs": [], + "name": "Merge Columns", + "outputs": [ + { + "name": "out_file1", + "type": "tabular" + } + ], + "position": { + "left": 3026, + "top": 408 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "mergeCols1", + "tool_state": "{\"__page__\": 0, \"input1\": \"null\", \"__rerun_remap_job_id__\": null, \"col2\": \"{\\\"__class__\\\": \\\"UnvalidatedValue\\\", \\\"value\\\": \\\"9\\\"}\", \"col1\": \"{\\\"__class__\\\": \\\"UnvalidatedValue\\\", \\\"value\\\": \\\"1\\\"}\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCm38_canon.len\\\"\", \"columns\": \"[{\\\"__index__\\\": 0, \\\"datacol\\\": {\\\"__class__\\\": \\\"UnvalidatedValue\\\", \\\"value\\\": \\\"10\\\"}}, {\\\"__index__\\\": 1, \\\"datacol\\\": {\\\"__class__\\\": \\\"UnvalidatedValue\\\", \\\"value\\\": \\\"8\\\"}}]\"}", + "tool_version": "1.0.1", + "type": "tool", + "user_outputs": [] + }, + "20": { + "annotation": "", + "id": 20, + "input_connections": { + "input": { + "id": 19, + "output_name": "out_file1" + } + }, + "inputs": [], + "name": "Cut", + "outputs": [ + { + "name": "out_file1", + "type": "tabular" + } + ], + "position": { + "left": 3246, + "top": 368 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "Cut1", + "tool_state": "{\"__page__\": 0, \"__rerun_remap_job_id__\": null, \"delimiter\": \"\\\"T\\\"\", \"columnList\": \"\\\"c11,c2\\\"\", \"input\": \"null\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCm38_canon.len\\\"\"}", + "tool_version": "1.0.2", + "type": "tool", + "user_outputs": [] + }, + "21": { + "annotation": "", + "id": 21, + "input_connections": { + "input": { + "id": 20, + "output_name": "out_file1" + } + }, + "inputs": [], + "name": "Tabular-to-FASTA", + "outputs": [ + { + "name": "output", + "type": "fasta" + } + ], + "position": { + "left": 3455, + "top": 458 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "tab2fasta", + "tool_state": "{\"title_col\": \"{\\\"__class__\\\": \\\"UnvalidatedValue\\\", \\\"value\\\": [\\\"1\\\"]}\", \"__page__\": 0, \"seq_col\": \"{\\\"__class__\\\": \\\"UnvalidatedValue\\\", \\\"value\\\": \\\"2\\\"}\", \"__rerun_remap_job_id__\": null, \"input\": \"null\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCm38_canon.len\\\"\"}", + "tool_version": "1.1.0", + "type": "tool", + "user_outputs": [] + }, + "22": { + "annotation": "", + "id": 22, + "input_connections": { + "input": { + "id": 21, + "output_name": "output" + } + }, + "inputs": [], + "name": "FASTA Width", + "outputs": [ + { + "name": "output", + "type": "input" + } + ], + "position": { + "left": 3653, + "top": 359 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "toolshed.g2.bx.psu.edu/repos/devteam/fasta_formatter/cshl_fasta_formatter/1.0.0", + "tool_state": "{\"__page__\": 0, \"input\": \"null\", \"__rerun_remap_job_id__\": null, \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCm38_canon.len\\\"\", \"width\": \"\\\"80\\\"\"}", + "tool_version": "1.0.0", + "type": "tool", + "user_outputs": [] + } + } +} \ No newline at end of file diff -r 000000000000 -r 9d5e59373c84 repository_dependencies.xml --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/repository_dependencies.xml Mon Mar 17 16:03:12 2014 -0500 @@ -0,0 +1,5 @@ + + + + +