Mercurial > repos > galaxyp > proteomics_rnaseq_sap_db_workflow
changeset 0:3a11830963e3 default tip
Initial upload
| author | Jim Johnson <jj@umn.edu> | 
|---|---|
| date | Mon, 17 Mar 2014 15:59:57 -0500 | 
| parents | |
| children | |
| files | README.rst proteomics_rnaseq_human_splice_db_workflow.ga proteomics_rnaseq_mouse_splice_db_workflow.ga proteomics_rnaseq_splice_db_workflow.ga repository_dependencies.xml | 
| diffstat | 5 files changed, 1191 insertions(+), 0 deletions(-) [+] | 
line wrap: on
 line diff
--- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/README.rst Mon Mar 17 15:59:57 2014 -0500 @@ -0,0 +1,60 @@ +This package contains a Galaxy workflow for the detection and incorporation of single amino acid polymorphism (SAP) into a custom proteomics search database. + +The workflow aligns RNA-Seq reads to the organism's genome using Tophat, call SNPs using SAMtools mpileup command, and annotates the SNPs that reside within protein-coding regions using SNPeff. +Galaxy tool "SNPeff to Peptide Fasta" generates peptide sequences with the polymorhisms. + +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_sap_db_workflow + + +Reference Data +============== + +For Human RNAseq data this workflow was tested with a genome build named "GRCh37_canon" 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 with a genome build named "GRCm38_canon" 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 + + +Genome builds "GRCh37_canon" and "GRCm38_canon" were built according to instructions in: https://wiki.galaxyproject.org/Admin/NGS%20Local%20Setup +The builds used only the standard chromosomesi sequences from the reference fasta; the other sequences were filtered out. +The GTF was filtered to retain only those entries that referenced the standard chromosomes. + + +Dependencies +============ + +These dependencies should be resolved automatically via the Galaxy Tool Shed: + +* http://toolshed.g2.bx.psu.edu/view/devteam/tophat +* http://toolshed.g2.bx.psu.edu/view/devteam/samtools_mpileup +* http://toolshed.g2.bx.psu.edu/view/nilesh/bcftools +* http://toolshed.g2.bx.psu.edu/view/iuc/snpeff +* http://toolshed.g2.bx.psu.edu/view/jjohnson/snpeff_to_peptides + +History +======= + +======= ====================================================================== +Version Changes +------- ---------------------------------------------------------------------- +v0.0.1 - Initial release to Tool Shed (March, 2014) +======= ====================================================================== + +
--- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/proteomics_rnaseq_human_splice_db_workflow.ga Mon Mar 17 15:59:57 2014 -0500 @@ -0,0 +1,368 @@ +{ + "a_galaxy_workflow": "true", + "annotation": "The SAP Database Workflow creates a database of polypeptide sequences containing single amino acid polymorphisms (SAPs) detected in RNA-Seq data.", + "format-version": "0.1", + "name": "Proteomics SAP DB", + "steps": { + "0": { + "annotation": "", + "id": 0, + "input_connections": {}, + "inputs": [ + { + "description": "", + "name": "RNA-Seq Left mate pair fastq" + } + ], + "name": "Input dataset", + "outputs": [], + "position": { + "left": 257, + "top": 163 + }, + "tool_errors": null, + "tool_id": null, + "tool_state": "{\"name\": \"RNA-Seq Left mate pair fastq\"}", + "tool_version": null, + "type": "data_input", + "user_outputs": [] + }, + "1": { + "annotation": "", + "id": 1, + "input_connections": {}, + "inputs": [ + { + "description": "", + "name": "RNA-Seq right mate pair fastq" + } + ], + "name": "Input dataset", + "outputs": [], + "position": { + "left": 257, + "top": 393 + }, + "tool_errors": null, + "tool_id": null, + "tool_state": "{\"name\": \"RNA-Seq right mate pair fastq\"}", + "tool_version": null, + "type": "data_input", + "user_outputs": [] + }, + "2": { + "annotation": "", + "id": 2, + "input_connections": {}, + "inputs": [ + { + "description": "", + "name": "Ensembl GTF for the reference genome" + } + ], + "name": "Input dataset", + "outputs": [], + "position": { + "left": 500, + "top": 526 + }, + "tool_errors": null, + "tool_id": null, + "tool_state": "{\"name\": \"Ensembl GTF for the reference genome\"}", + "tool_version": null, + "type": "data_input", + "user_outputs": [] + }, + "3": { + "annotation": "", + "id": 3, + "input_connections": {}, + "inputs": [ + { + "description": "", + "name": "The Ensembl peptide sequences fasta" + } + ], + "name": "Input dataset", + "outputs": [], + "position": { + "left": 1551, + "top": 552 + }, + "tool_errors": null, + "tool_id": null, + "tool_state": "{\"name\": \"The Ensembl peptide sequences fasta\"}", + "tool_version": null, + "type": "data_input", + "user_outputs": [] + }, + "4": { + "annotation": "", + "id": 4, + "input_connections": { + "input": { + "id": 0, + "output_name": "output" + } + }, + "inputs": [], + "name": "Select first", + "outputs": [ + { + "name": "out_file1", + "type": "input" + } + ], + "position": { + "left": 482, + "top": 209 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "Show beginning1", + "tool_state": "{\"__page__\": 0, \"input\": \"null\", \"__rerun_remap_job_id__\": null, \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/hg19.len\\\"\", \"lineNum\": \"\\\"100000\\\"\"}", + "tool_version": "1.0.0", + "type": "tool", + "user_outputs": [] + }, + "5": { + "annotation": "", + "id": 5, + "input_connections": { + "input": { + "id": 1, + "output_name": "output" + } + }, + "inputs": [], + "name": "Select first", + "outputs": [ + { + "name": "out_file1", + "type": "input" + } + ], + "position": { + "left": 477, + "top": 338 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "Show beginning1", + "tool_state": "{\"__page__\": 0, \"input\": \"null\", \"__rerun_remap_job_id__\": null, \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/hg19.len\\\"\", \"lineNum\": \"\\\"100000\\\"\"}", + "tool_version": "1.0.0", + "type": "tool", + "user_outputs": [] + }, + "6": { + "annotation": "", + "id": 6, + "input_connections": { + "input1": { + "id": 2, + "output_name": "output" + } + }, + "inputs": [], + "name": "Convert GFF to BED", + "outputs": [ + { + "name": "output1", + "type": "bed" + } + ], + "position": { + "left": 823, + "top": 541 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "CONVERTER_gff_to_bed_0", + "tool_state": "{\"__page__\": 0, \"__rerun_remap_job_id__\": null, \"input1\": \"null\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCh37_canon.len\\\"\"}", + "tool_version": "1.0.0", + "type": "tool", + "user_outputs": [] + }, + "7": { + "annotation": "", + "id": 7, + "input_connections": { + "input1": { + "id": 4, + "output_name": "out_file1" + }, + "singlePaired|input2": { + "id": 5, + "output_name": "out_file1" + }, + "singlePaired|pParams|own_junctions|gene_model_ann|gene_annotation_model": { + "id": 2, + "output_name": "output" + } + }, + "inputs": [], + "name": "Tophat for Illumina", + "outputs": [ + { + "name": "insertions", + "type": "bed" + }, + { + "name": "deletions", + "type": "bed" + }, + { + "name": "junctions", + "type": "bed" + }, + { + "name": "accepted_hits", + "type": "bam" + } + ], + "position": { + "left": 816, + "top": 191 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "toolshed.g2.bx.psu.edu/repos/devteam/tophat/tophat/1.5.0", + "tool_state": "{\"__page__\": 0, \"input1\": \"null\", \"singlePaired\": \"{\\\"input2\\\": null, \\\"sPaired\\\": \\\"paired\\\", \\\"pParams\\\": {\\\"library_type\\\": \\\"fr-unstranded\\\", \\\"closure_search\\\": {\\\"use_search\\\": \\\"No\\\", \\\"__current_case__\\\": 1}, \\\"__current_case__\\\": 1, \\\"indel_search\\\": {\\\"max_insertion_length\\\": \\\"3\\\", \\\"max_deletion_length\\\": \\\"3\\\", \\\"__current_case__\\\": 1, \\\"allow_indel_search\\\": \\\"Yes\\\"}, \\\"seg_length\\\": \\\"25\\\", \\\"max_intron_length\\\": \\\"500000\\\", \\\"pSettingsType\\\": \\\"full\\\", \\\"min_intron_length\\\": \\\"70\\\", \\\"microexon_search\\\": \\\"No\\\", \\\"min_segment_intron\\\": \\\"50\\\", \\\"max_multihits\\\": \\\"20\\\", \\\"coverage_search\\\": {\\\"use_search\\\": \\\"No\\\", \\\"__current_case__\\\": 1}, \\\"splice_mismatches\\\": \\\"0\\\", \\\"anchor_length\\\": \\\"5\\\", \\\"mate_std_dev\\\": \\\"20\\\", \\\"own_junctions\\\": {\\\"gene_model_ann\\\": {\\\"gene_annotation_model\\\": null, \\\"use_annotations\\\": \\\"Yes\\\", \\\"__current_case__\\\": 1}, \\\"no_novel_juncs\\\": \\\"Yes\\\", \\\"use_junctions\\\": \\\"Yes\\\", \\\"__current_case__\\\": 0, \\\"raw_juncs\\\": {\\\"use_juncs\\\": \\\"No\\\", \\\"__current_case__\\\": 0}}, \\\"seg_mismatches\\\": \\\"2\\\", \\\"initial_read_mismatches\\\": \\\"2\\\", \\\"max_segment_intron\\\": \\\"500000\\\"}, \\\"__current_case__\\\": 1, \\\"mate_inner_distance\\\": \\\"150\\\"}\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/hg19.len\\\"\", \"__rerun_remap_job_id__\": null, \"refGenomeSource\": \"{\\\"genomeSource\\\": \\\"indexed\\\", \\\"index\\\": \\\"GRCh37_canon\\\", \\\"__current_case__\\\": 0}\"}", + "tool_version": "1.5.0", + "type": "tool", + "user_outputs": [] + }, + "8": { + "annotation": "", + "id": 8, + "input_connections": { + "advanced_options|position_list": { + "id": 6, + "output_name": "output1" + }, + "reference_source|input_bams_0|input_bam": { + "id": 7, + "output_name": "accepted_hits" + } + }, + "inputs": [], + "name": "MPileup", + "outputs": [ + { + "name": "output_mpileup", + "type": "pileup" + }, + { + "name": "output_log", + "type": "txt" + } + ], + "position": { + "left": 1064, + "top": 431 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "toolshed.g2.bx.psu.edu/repos/devteam/samtools_mpileup/samtools_mpileup/0.0.1", + "tool_state": "{\"__page__\": 0, \"genotype_likelihood_computation_type\": \"{\\\"__current_case__\\\": 0, \\\"perform_indel_calling\\\": {\\\"__current_case__\\\": 1, \\\"perform_indel_calling_selector\\\": \\\"do_not_perform_indel_calling\\\"}, \\\"platform_list_repeat\\\": [], \\\"gap_open_sequencing_error_probability\\\": \\\"40\\\", \\\"coefficient_for_modeling_homopolymer_errors\\\": \\\"100\\\", \\\"genotype_likelihood_computation_type_selector\\\": \\\"perform_genotype_likelihood_computation\\\", \\\"gap_extension_sequencing_error_probability\\\": \\\"20\\\"}\", \"__rerun_remap_job_id__\": null, \"advanced_options\": \"{\\\"max_reads_per_bam\\\": \\\"250\\\", \\\"advanced_options_selector\\\": \\\"advanced\\\", \\\"extended_BAQ_computation\\\": \\\"False\\\", \\\"region_string\\\": \\\"\\\", \\\"output_per_sample_strand_bias_p_value\\\": \\\"False\\\", \\\"minimum_base_quality\\\": \\\"13\\\", \\\"disable_probabilistic_realignment\\\": \\\"False\\\", \\\"skip_anomalous_read_pairs\\\": \\\"False\\\", \\\"minimum_mapping_quality\\\": \\\"0\\\", \\\"output_per_sample_read_depth\\\": \\\"True\\\", \\\"__current_case__\\\": 0, \\\"position_list\\\": null, \\\"coefficient_for_downgrading\\\": \\\"0\\\"}\", \"reference_source\": \"{\\\"ref_file\\\": \\\"GRCh37_canon\\\", \\\"reference_source_selector\\\": \\\"cached\\\", \\\"input_bams\\\": [{\\\"__index__\\\": 0, \\\"input_bam\\\": null}], \\\"__current_case__\\\": 0}\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCh37_canon.len\\\"\"}", + "tool_version": "0.0.1", + "type": "tool", + "user_outputs": [] + }, + "9": { + "annotation": "", + "id": 9, + "input_connections": { + "input": { + "id": 8, + "output_name": "output_mpileup" + } + }, + "inputs": [], + "name": "bcftools view", + "outputs": [ + { + "name": "output", + "type": "vcf" + } + ], + "position": { + "left": 1357, + "top": 352 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "toolshed.g2.bx.psu.edu/repos/nilesh/bcftools/bcftools_view/1.0.0", + "tool_state": "{\"A\": \"\\\"true\\\"\", \"__page__\": 0, \"c\": \"\\\"true\\\"\", \"b\": \"\\\"false\\\"\", \"e\": \"\\\"false\\\"\", \"D\": \"{\\\"seq_dictionary\\\": \\\"false\\\", \\\"__current_case__\\\": 1}\", \"G\": \"\\\"false\\\"\", \"F\": \"\\\"false\\\"\", \"i\": \"{\\\"__current_case__\\\": 1, \\\"alt_indel_snp_ratio\\\": \\\"false\\\"}\", \"__rerun_remap_job_id__\": null, \"N\": \"\\\"false\\\"\", \"p\": \"{\\\"variant_filter\\\": \\\"false\\\", \\\"__current_case__\\\": 1}\", \"S\": \"\\\"false\\\"\", \"g\": \"\\\"false\\\"\", \"t\": \"{\\\"mutation_rate\\\": \\\"false\\\", \\\"__current_case__\\\": 1}\", \"v\": \"\\\"true\\\"\", \"u\": \"\\\"false\\\"\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCh37_canon.len\\\"\", \"input\": \"null\"}", + "tool_version": "1.0.0", + "type": "tool", + "user_outputs": [] + }, + "10": { + "annotation": "", + "id": 10, + "input_connections": { + "input": { + "id": 9, + "output_name": "output" + } + }, + "inputs": [], + "name": "SnpEff", + "outputs": [ + { + "name": "snpeff_output", + "type": "vcf" + }, + { + "name": "statsFile", + "type": "html" + } + ], + "position": { + "left": 1576, + "top": 317 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "toolshed.g2.bx.psu.edu/repos/iuc/snpeff/snpEff/3.4", + "tool_state": "{\"spliceSiteSize\": \"\\\"1\\\"\", \"filterHomHet\": \"\\\"no_filter\\\"\", \"outputFormat\": \"\\\"vcf\\\"\", \"udLength\": \"\\\"0\\\"\", \"inputFormat\": \"\\\"vcf\\\"\", \"filterIn\": \"\\\"-snp\\\"\", \"__page__\": 0, \"__rerun_remap_job_id__\": null, \"filterOut\": \"[\\\"-no-downstream\\\", \\\"-no-intergenic\\\", \\\"-no-intron\\\", \\\"-no-upstream\\\", \\\"-no-utr\\\"]\", \"generate_stats\": \"\\\"True\\\"\", \"noLog\": \"\\\"True\\\"\", \"chr\": \"\\\"\\\"\", \"intervals\": \"null\", \"snpDb\": \"{\\\"genome_version\\\": \\\"GRCh37.73\\\", \\\"genomeSrc\\\": \\\"named\\\", \\\"__current_case__\\\": 2}\", \"offset\": \"\\\"\\\"\", \"input\": \"null\", \"transcripts\": \"null\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCh37_canon.len\\\"\", \"annotations\": \"null\"}", + "tool_version": "3.4", + "type": "tool", + "user_outputs": [] + }, + "11": { + "annotation": "", + "id": 11, + "input_connections": { + "all_pep_fasta": { + "id": 3, + "output_name": "output" + }, + "snpeff_vcf": { + "id": 10, + "output_name": "snpeff_output" + } + }, + "inputs": [], + "name": "SnpEff to Peptide fasta", + "outputs": [ + { + "name": "peptide_variant_fasta", + "type": "fasta" + } + ], + "position": { + "left": 1885, + "top": 455 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "toolshed.g2.bx.psu.edu/repos/jjohnson/snpeff_to_peptides/snpeff_to_peptides/0.0.1", + "tool_state": "{\"__page__\": 0, \"leading_aa_num\": \"\\\"66\\\"\", \"all_pep_fasta\": \"null\", \"__rerun_remap_job_id__\": null, \"trailing_aa_num\": \"\\\"66\\\"\", \"snpeff_vcf\": \"null\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCh37_canon.len\\\"\"}", + "tool_version": "0.0.1", + "type": "tool", + "user_outputs": [] + } + } +} \ No newline at end of file
--- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/proteomics_rnaseq_mouse_splice_db_workflow.ga Mon Mar 17 15:59:57 2014 -0500 @@ -0,0 +1,368 @@ +{ + "a_galaxy_workflow": "true", + "annotation": "The SAP Database Workflow creates a database of polypeptide sequences containing single amino acid polymorphisms (SAPs) detected in RNA-Seq data.", + "format-version": "0.1", + "name": "Mouse SAP DB", + "steps": { + "0": { + "annotation": "", + "id": 0, + "input_connections": {}, + "inputs": [ + { + "description": "", + "name": "RNA-Seq left mate pair fastq" + } + ], + "name": "Input dataset", + "outputs": [], + "position": { + "left": 257, + "top": 163 + }, + "tool_errors": null, + "tool_id": null, + "tool_state": "{\"name\": \"RNA-Seq left mate pair fastq\"}", + "tool_version": null, + "type": "data_input", + "user_outputs": [] + }, + "1": { + "annotation": "", + "id": 1, + "input_connections": {}, + "inputs": [ + { + "description": "", + "name": "RNA-Seq right mate pair fastq" + } + ], + "name": "Input dataset", + "outputs": [], + "position": { + "left": 257, + "top": 393 + }, + "tool_errors": null, + "tool_id": null, + "tool_state": "{\"name\": \"RNA-Seq right mate pair fastq\"}", + "tool_version": null, + "type": "data_input", + "user_outputs": [] + }, + "2": { + "annotation": "", + "id": 2, + "input_connections": {}, + "inputs": [ + { + "description": "", + "name": "Ensembl GTF file (gene models)" + } + ], + "name": "Input dataset", + "outputs": [], + "position": { + "left": 500, + "top": 526 + }, + "tool_errors": null, + "tool_id": null, + "tool_state": "{\"name\": \"Ensembl GTF file (gene models)\"}", + "tool_version": null, + "type": "data_input", + "user_outputs": [] + }, + "3": { + "annotation": "", + "id": 3, + "input_connections": {}, + "inputs": [ + { + "description": "", + "name": "The Ensembl protein FASTA file (reference proteome)" + } + ], + "name": "Input dataset", + "outputs": [], + "position": { + "left": 1551, + "top": 552 + }, + "tool_errors": null, + "tool_id": null, + "tool_state": "{\"name\": \"The Ensembl protein FASTA file (reference proteome)\"}", + "tool_version": null, + "type": "data_input", + "user_outputs": [] + }, + "4": { + "annotation": "", + "id": 4, + "input_connections": { + "input": { + "id": 0, + "output_name": "output" + } + }, + "inputs": [], + "name": "Select first", + "outputs": [ + { + "name": "out_file1", + "type": "input" + } + ], + "position": { + "left": 482, + "top": 209 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "Show beginning1", + "tool_state": "{\"__page__\": 0, \"input\": \"null\", \"__rerun_remap_job_id__\": null, \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/hg19.len\\\"\", \"lineNum\": \"\\\"100000\\\"\"}", + "tool_version": "1.0.0", + "type": "tool", + "user_outputs": [] + }, + "5": { + "annotation": "", + "id": 5, + "input_connections": { + "input": { + "id": 1, + "output_name": "output" + } + }, + "inputs": [], + "name": "Select first", + "outputs": [ + { + "name": "out_file1", + "type": "input" + } + ], + "position": { + "left": 477, + "top": 338 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "Show beginning1", + "tool_state": "{\"__page__\": 0, \"input\": \"null\", \"__rerun_remap_job_id__\": null, \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/hg19.len\\\"\", \"lineNum\": \"\\\"100000\\\"\"}", + "tool_version": "1.0.0", + "type": "tool", + "user_outputs": [] + }, + "6": { + "annotation": "", + "id": 6, + "input_connections": { + "input1": { + "id": 2, + "output_name": "output" + } + }, + "inputs": [], + "name": "Convert GFF to BED", + "outputs": [ + { + "name": "output1", + "type": "bed" + } + ], + "position": { + "left": 823, + "top": 541 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "CONVERTER_gff_to_bed_0", + "tool_state": "{\"__page__\": 0, \"__rerun_remap_job_id__\": null, \"input1\": \"null\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCh37_canon.len\\\"\"}", + "tool_version": "1.0.0", + "type": "tool", + "user_outputs": [] + }, + "7": { + "annotation": "", + "id": 7, + "input_connections": { + "input1": { + "id": 4, + "output_name": "out_file1" + }, + "singlePaired|input2": { + "id": 5, + "output_name": "out_file1" + }, + "singlePaired|pParams|own_junctions|gene_model_ann|gene_annotation_model": { + "id": 2, + "output_name": "output" + } + }, + "inputs": [], + "name": "Tophat for Illumina", + "outputs": [ + { + "name": "insertions", + "type": "bed" + }, + { + "name": "deletions", + "type": "bed" + }, + { + "name": "junctions", + "type": "bed" + }, + { + "name": "accepted_hits", + "type": "bam" + } + ], + "position": { + "left": 816, + "top": 191 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "toolshed.g2.bx.psu.edu/repos/devteam/tophat/tophat/1.5.0", + "tool_state": "{\"__page__\": 0, \"input1\": \"null\", \"singlePaired\": \"{\\\"input2\\\": null, \\\"sPaired\\\": \\\"paired\\\", \\\"pParams\\\": {\\\"library_type\\\": \\\"fr-unstranded\\\", \\\"closure_search\\\": {\\\"use_search\\\": \\\"No\\\", \\\"__current_case__\\\": 1}, \\\"__current_case__\\\": 1, \\\"indel_search\\\": {\\\"max_insertion_length\\\": \\\"3\\\", \\\"max_deletion_length\\\": \\\"3\\\", \\\"__current_case__\\\": 1, \\\"allow_indel_search\\\": \\\"Yes\\\"}, \\\"seg_length\\\": \\\"25\\\", \\\"max_intron_length\\\": \\\"500000\\\", \\\"pSettingsType\\\": \\\"full\\\", \\\"min_intron_length\\\": \\\"70\\\", \\\"microexon_search\\\": \\\"No\\\", \\\"min_segment_intron\\\": \\\"50\\\", \\\"max_multihits\\\": \\\"20\\\", \\\"coverage_search\\\": {\\\"use_search\\\": \\\"No\\\", \\\"__current_case__\\\": 1}, \\\"splice_mismatches\\\": \\\"0\\\", \\\"anchor_length\\\": \\\"5\\\", \\\"mate_std_dev\\\": \\\"20\\\", \\\"own_junctions\\\": {\\\"gene_model_ann\\\": {\\\"gene_annotation_model\\\": null, \\\"use_annotations\\\": \\\"Yes\\\", \\\"__current_case__\\\": 1}, \\\"no_novel_juncs\\\": \\\"Yes\\\", \\\"use_junctions\\\": \\\"Yes\\\", \\\"__current_case__\\\": 0, \\\"raw_juncs\\\": {\\\"use_juncs\\\": \\\"No\\\", \\\"__current_case__\\\": 0}}, \\\"seg_mismatches\\\": \\\"2\\\", \\\"initial_read_mismatches\\\": \\\"2\\\", \\\"max_segment_intron\\\": \\\"500000\\\"}, \\\"__current_case__\\\": 1, \\\"mate_inner_distance\\\": \\\"150\\\"}\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/hg19.len\\\"\", \"__rerun_remap_job_id__\": null, \"refGenomeSource\": \"{\\\"genomeSource\\\": \\\"indexed\\\", \\\"index\\\": \\\"GRCm38_canon\\\", \\\"__current_case__\\\": 0}\"}", + "tool_version": "1.5.0", + "type": "tool", + "user_outputs": [] + }, + "8": { + "annotation": "", + "id": 8, + "input_connections": { + "advanced_options|position_list": { + "id": 6, + "output_name": "output1" + }, + "reference_source|input_bams_0|input_bam": { + "id": 7, + "output_name": "accepted_hits" + } + }, + "inputs": [], + "name": "MPileup", + "outputs": [ + { + "name": "output_mpileup", + "type": "pileup" + }, + { + "name": "output_log", + "type": "txt" + } + ], + "position": { + "left": 1064, + "top": 431 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "toolshed.g2.bx.psu.edu/repos/devteam/samtools_mpileup/samtools_mpileup/0.0.1", + "tool_state": "{\"__page__\": 0, \"genotype_likelihood_computation_type\": \"{\\\"__current_case__\\\": 0, \\\"perform_indel_calling\\\": {\\\"__current_case__\\\": 1, \\\"perform_indel_calling_selector\\\": \\\"do_not_perform_indel_calling\\\"}, \\\"platform_list_repeat\\\": [], \\\"gap_open_sequencing_error_probability\\\": \\\"40\\\", \\\"coefficient_for_modeling_homopolymer_errors\\\": \\\"100\\\", \\\"genotype_likelihood_computation_type_selector\\\": \\\"perform_genotype_likelihood_computation\\\", \\\"gap_extension_sequencing_error_probability\\\": \\\"20\\\"}\", \"__rerun_remap_job_id__\": null, \"advanced_options\": \"{\\\"max_reads_per_bam\\\": \\\"250\\\", \\\"advanced_options_selector\\\": \\\"advanced\\\", \\\"extended_BAQ_computation\\\": \\\"False\\\", \\\"region_string\\\": \\\"\\\", \\\"output_per_sample_strand_bias_p_value\\\": \\\"False\\\", \\\"minimum_base_quality\\\": \\\"13\\\", \\\"disable_probabilistic_realignment\\\": \\\"False\\\", \\\"skip_anomalous_read_pairs\\\": \\\"False\\\", \\\"minimum_mapping_quality\\\": \\\"0\\\", \\\"output_per_sample_read_depth\\\": \\\"True\\\", \\\"__current_case__\\\": 0, \\\"position_list\\\": null, \\\"coefficient_for_downgrading\\\": \\\"0\\\"}\", \"reference_source\": \"{\\\"ref_file\\\": \\\"GRCm38_canon\\\", \\\"reference_source_selector\\\": \\\"cached\\\", \\\"input_bams\\\": [{\\\"__index__\\\": 0, \\\"input_bam\\\": null}], \\\"__current_case__\\\": 0}\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCh37_canon.len\\\"\"}", + "tool_version": "0.0.1", + "type": "tool", + "user_outputs": [] + }, + "9": { + "annotation": "", + "id": 9, + "input_connections": { + "input": { + "id": 8, + "output_name": "output_mpileup" + } + }, + "inputs": [], + "name": "bcftools view", + "outputs": [ + { + "name": "output", + "type": "vcf" + } + ], + "position": { + "left": 1357, + "top": 352 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "toolshed.g2.bx.psu.edu/repos/nilesh/bcftools/bcftools_view/1.0.0", + "tool_state": "{\"A\": \"\\\"true\\\"\", \"__page__\": 0, \"c\": \"\\\"true\\\"\", \"b\": \"\\\"false\\\"\", \"e\": \"\\\"false\\\"\", \"D\": \"{\\\"seq_dictionary\\\": \\\"false\\\", \\\"__current_case__\\\": 1}\", \"G\": \"\\\"false\\\"\", \"F\": \"\\\"false\\\"\", \"i\": \"{\\\"__current_case__\\\": 1, \\\"alt_indel_snp_ratio\\\": \\\"false\\\"}\", \"__rerun_remap_job_id__\": null, \"N\": \"\\\"false\\\"\", \"p\": \"{\\\"variant_filter\\\": \\\"false\\\", \\\"__current_case__\\\": 1}\", \"S\": \"\\\"false\\\"\", \"g\": \"\\\"false\\\"\", \"t\": \"{\\\"mutation_rate\\\": \\\"false\\\", \\\"__current_case__\\\": 1}\", \"v\": \"\\\"true\\\"\", \"u\": \"\\\"false\\\"\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCh37_canon.len\\\"\", \"input\": \"null\"}", + "tool_version": "1.0.0", + "type": "tool", + "user_outputs": [] + }, + "10": { + "annotation": "", + "id": 10, + "input_connections": { + "input": { + "id": 9, + "output_name": "output" + } + }, + "inputs": [], + "name": "SnpEff", + "outputs": [ + { + "name": "snpeff_output", + "type": "vcf" + }, + { + "name": "statsFile", + "type": "html" + } + ], + "position": { + "left": 1576, + "top": 317 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "toolshed.g2.bx.psu.edu/repos/iuc/snpeff/snpEff/3.4", + "tool_state": "{\"spliceSiteSize\": \"\\\"1\\\"\", \"filterHomHet\": \"\\\"no_filter\\\"\", \"outputFormat\": \"\\\"vcf\\\"\", \"udLength\": \"\\\"0\\\"\", \"inputFormat\": \"\\\"vcf\\\"\", \"filterIn\": \"\\\"-snp\\\"\", \"__page__\": 0, \"__rerun_remap_job_id__\": null, \"filterOut\": \"[\\\"-no-downstream\\\", \\\"-no-intergenic\\\", \\\"-no-intron\\\", \\\"-no-upstream\\\", \\\"-no-utr\\\"]\", \"generate_stats\": \"\\\"True\\\"\", \"noLog\": \"\\\"True\\\"\", \"chr\": \"\\\"\\\"\", \"intervals\": \"null\", \"snpDb\": \"{\\\"genome_version\\\": \\\"GRCm38.73\\\", \\\"genomeSrc\\\": \\\"named\\\", \\\"__current_case__\\\": 2}\", \"offset\": \"\\\"\\\"\", \"input\": \"null\", \"transcripts\": \"null\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCh37_canon.len\\\"\", \"annotations\": \"null\"}", + "tool_version": "3.4", + "type": "tool", + "user_outputs": [] + }, + "11": { + "annotation": "", + "id": 11, + "input_connections": { + "all_pep_fasta": { + "id": 3, + "output_name": "output" + }, + "snpeff_vcf": { + "id": 10, + "output_name": "snpeff_output" + } + }, + "inputs": [], + "name": "SnpEff to Peptide fasta", + "outputs": [ + { + "name": "peptide_variant_fasta", + "type": "fasta" + } + ], + "position": { + "left": 1885, + "top": 455 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "toolshed.g2.bx.psu.edu/repos/jjohnson/snpeff_to_peptides/snpeff_to_peptides/0.0.1", + "tool_state": "{\"__page__\": 0, \"leading_aa_num\": \"\\\"66\\\"\", \"all_pep_fasta\": \"null\", \"__rerun_remap_job_id__\": null, \"trailing_aa_num\": \"\\\"66\\\"\", \"snpeff_vcf\": \"null\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCh37_canon.len\\\"\"}", + "tool_version": "0.0.1", + "type": "tool", + "user_outputs": [] + } + } +} \ No newline at end of file
--- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/proteomics_rnaseq_splice_db_workflow.ga Mon Mar 17 15:59:57 2014 -0500 @@ -0,0 +1,387 @@ +{ + "a_galaxy_workflow": "true", + "annotation": "The SAP Database Workflow creates a database of polypeptide sequences containing single amino acid polymorphisms (SAPs) detected in RNA-Seq data.", + "format-version": "0.1", + "name": "Proteomics SAP DB", + "steps": { + "0": { + "annotation": "", + "id": 0, + "input_connections": {}, + "inputs": [ + { + "description": "", + "name": "RNA-Seq Left mate pair fastq" + } + ], + "name": "Input dataset", + "outputs": [], + "position": { + "left": 257, + "top": 163 + }, + "tool_errors": null, + "tool_id": null, + "tool_state": "{\"name\": \"RNA-Seq Left mate pair fastq\"}", + "tool_version": null, + "type": "data_input", + "user_outputs": [] + }, + "1": { + "annotation": "", + "id": 1, + "input_connections": {}, + "inputs": [ + { + "description": "", + "name": "RNA-Seq right mate pair fastq" + } + ], + "name": "Input dataset", + "outputs": [], + "position": { + "left": 257, + "top": 393 + }, + "tool_errors": null, + "tool_id": null, + "tool_state": "{\"name\": \"RNA-Seq right mate pair fastq\"}", + "tool_version": null, + "type": "data_input", + "user_outputs": [] + }, + "2": { + "annotation": "", + "id": 2, + "input_connections": {}, + "inputs": [ + { + "description": "", + "name": "Ensembl GTF for the reference genome" + } + ], + "name": "Input dataset", + "outputs": [], + "position": { + "left": 500, + "top": 526 + }, + "tool_errors": null, + "tool_id": null, + "tool_state": "{\"name\": \"Ensembl GTF for the reference genome\"}", + "tool_version": null, + "type": "data_input", + "user_outputs": [] + }, + "3": { + "annotation": "", + "id": 3, + "input_connections": {}, + "inputs": [ + { + "description": "", + "name": "The Ensembl peptide sequences fasta" + } + ], + "name": "Input dataset", + "outputs": [], + "position": { + "left": 1551, + "top": 552 + }, + "tool_errors": null, + "tool_id": null, + "tool_state": "{\"name\": \"The Ensembl peptide sequences fasta\"}", + "tool_version": null, + "type": "data_input", + "user_outputs": [] + }, + "4": { + "annotation": "", + "id": 4, + "input_connections": { + "input": { + "id": 0, + "output_name": "output" + } + }, + "inputs": [], + "name": "Select first", + "outputs": [ + { + "name": "out_file1", + "type": "input" + } + ], + "position": { + "left": 482, + "top": 209 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "Show beginning1", + "tool_state": "{\"__page__\": 0, \"input\": \"null\", \"__rerun_remap_job_id__\": null, \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/hg19.len\\\"\", \"lineNum\": \"\\\"100000\\\"\"}", + "tool_version": "1.0.0", + "type": "tool", + "user_outputs": [] + }, + "5": { + "annotation": "", + "id": 5, + "input_connections": { + "input": { + "id": 1, + "output_name": "output" + } + }, + "inputs": [], + "name": "Select first", + "outputs": [ + { + "name": "out_file1", + "type": "input" + } + ], + "position": { + "left": 477, + "top": 338 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "Show beginning1", + "tool_state": "{\"__page__\": 0, \"input\": \"null\", \"__rerun_remap_job_id__\": null, \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/hg19.len\\\"\", \"lineNum\": \"\\\"100000\\\"\"}", + "tool_version": "1.0.0", + "type": "tool", + "user_outputs": [] + }, + "6": { + "annotation": "", + "id": 6, + "input_connections": { + "input1": { + "id": 2, + "output_name": "output" + } + }, + "inputs": [], + "name": "Convert GFF to BED", + "outputs": [ + { + "name": "output1", + "type": "bed" + } + ], + "position": { + "left": 823, + "top": 541 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "CONVERTER_gff_to_bed_0", + "tool_state": "{\"__page__\": 0, \"__rerun_remap_job_id__\": null, \"input1\": \"null\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCh37_canon.len\\\"\"}", + "tool_version": "1.0.0", + "type": "tool", + "user_outputs": [] + }, + "7": { + "annotation": "", + "id": 7, + "input_connections": { + "input1": { + "id": 4, + "output_name": "out_file1" + }, + "singlePaired|input2": { + "id": 5, + "output_name": "out_file1" + }, + "singlePaired|pParams|own_junctions|gene_model_ann|gene_annotation_model": { + "id": 2, + "output_name": "output" + } + }, + "inputs": [ + { + "description": "runtime parameter for tool Tophat for Illumina", + "name": "refGenomeSource" + }, + { + "description": "runtime parameter for tool Tophat for Illumina", + "name": "singlePaired" + } + ], + "name": "Tophat for Illumina", + "outputs": [ + { + "name": "insertions", + "type": "bed" + }, + { + "name": "deletions", + "type": "bed" + }, + { + "name": "junctions", + "type": "bed" + }, + { + "name": "accepted_hits", + "type": "bam" + } + ], + "position": { + "left": 816, + "top": 191 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "toolshed.g2.bx.psu.edu/repos/devteam/tophat/tophat/1.5.0", + "tool_state": "{\"__page__\": 0, \"input1\": \"null\", \"singlePaired\": \"{\\\"input2\\\": null, \\\"sPaired\\\": \\\"paired\\\", \\\"pParams\\\": {\\\"library_type\\\": \\\"fr-unstranded\\\", \\\"closure_search\\\": {\\\"use_search\\\": \\\"No\\\", \\\"__current_case__\\\": 1}, \\\"__current_case__\\\": 1, \\\"indel_search\\\": {\\\"max_insertion_length\\\": \\\"3\\\", \\\"max_deletion_length\\\": \\\"3\\\", \\\"__current_case__\\\": 1, \\\"allow_indel_search\\\": \\\"Yes\\\"}, \\\"seg_length\\\": \\\"25\\\", \\\"max_intron_length\\\": \\\"500000\\\", \\\"pSettingsType\\\": \\\"full\\\", \\\"min_intron_length\\\": \\\"70\\\", \\\"microexon_search\\\": \\\"No\\\", \\\"min_segment_intron\\\": \\\"50\\\", \\\"max_multihits\\\": \\\"20\\\", \\\"coverage_search\\\": {\\\"use_search\\\": \\\"No\\\", \\\"__current_case__\\\": 1}, \\\"splice_mismatches\\\": \\\"0\\\", \\\"anchor_length\\\": \\\"5\\\", \\\"mate_std_dev\\\": \\\"20\\\", \\\"own_junctions\\\": {\\\"gene_model_ann\\\": {\\\"gene_annotation_model\\\": null, \\\"use_annotations\\\": \\\"Yes\\\", \\\"__current_case__\\\": 1}, \\\"no_novel_juncs\\\": \\\"Yes\\\", \\\"use_junctions\\\": \\\"Yes\\\", \\\"__current_case__\\\": 0, \\\"raw_juncs\\\": {\\\"use_juncs\\\": \\\"No\\\", \\\"__current_case__\\\": 0}}, \\\"seg_mismatches\\\": \\\"2\\\", \\\"initial_read_mismatches\\\": \\\"2\\\", \\\"max_segment_intron\\\": \\\"500000\\\"}, \\\"__current_case__\\\": 1, \\\"mate_inner_distance\\\": {\\\"__class__\\\": \\\"RuntimeValue\\\"}}\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/hg19.len\\\"\", \"__rerun_remap_job_id__\": null, \"refGenomeSource\": \"{\\\"genomeSource\\\": \\\"indexed\\\", \\\"index\\\": {\\\"__class__\\\": \\\"RuntimeValue\\\"}, \\\"__current_case__\\\": 0}\"}", + "tool_version": "1.5.0", + "type": "tool", + "user_outputs": [] + }, + "8": { + "annotation": "", + "id": 8, + "input_connections": { + "advanced_options|position_list": { + "id": 6, + "output_name": "output1" + }, + "reference_source|input_bams_0|input_bam": { + "id": 7, + "output_name": "accepted_hits" + } + }, + "inputs": [ + { + "description": "runtime parameter for tool MPileup", + "name": "reference_source" + } + ], + "name": "MPileup", + "outputs": [ + { + "name": "output_mpileup", + "type": "pileup" + }, + { + "name": "output_log", + "type": "txt" + } + ], + "position": { + "left": 1064, + "top": 431 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "toolshed.g2.bx.psu.edu/repos/devteam/samtools_mpileup/samtools_mpileup/0.0.1", + "tool_state": "{\"__page__\": 0, \"genotype_likelihood_computation_type\": \"{\\\"__current_case__\\\": 0, \\\"perform_indel_calling\\\": {\\\"__current_case__\\\": 1, \\\"perform_indel_calling_selector\\\": \\\"do_not_perform_indel_calling\\\"}, \\\"platform_list_repeat\\\": [], \\\"gap_open_sequencing_error_probability\\\": \\\"40\\\", \\\"coefficient_for_modeling_homopolymer_errors\\\": \\\"100\\\", \\\"genotype_likelihood_computation_type_selector\\\": \\\"perform_genotype_likelihood_computation\\\", \\\"gap_extension_sequencing_error_probability\\\": \\\"20\\\"}\", \"__rerun_remap_job_id__\": null, \"advanced_options\": \"{\\\"max_reads_per_bam\\\": \\\"250\\\", \\\"advanced_options_selector\\\": \\\"advanced\\\", \\\"extended_BAQ_computation\\\": \\\"False\\\", \\\"region_string\\\": \\\"\\\", \\\"output_per_sample_strand_bias_p_value\\\": \\\"False\\\", \\\"minimum_base_quality\\\": \\\"13\\\", \\\"disable_probabilistic_realignment\\\": \\\"False\\\", \\\"skip_anomalous_read_pairs\\\": \\\"False\\\", \\\"minimum_mapping_quality\\\": \\\"0\\\", \\\"output_per_sample_read_depth\\\": \\\"True\\\", \\\"__current_case__\\\": 0, \\\"position_list\\\": null, \\\"coefficient_for_downgrading\\\": \\\"0\\\"}\", \"reference_source\": \"{\\\"ref_file\\\": {\\\"__class__\\\": \\\"RuntimeValue\\\"}, \\\"reference_source_selector\\\": \\\"cached\\\", \\\"input_bams\\\": [{\\\"__index__\\\": 0, \\\"input_bam\\\": null}], \\\"__current_case__\\\": 0}\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCh37_canon.len\\\"\"}", + "tool_version": "0.0.1", + "type": "tool", + "user_outputs": [] + }, + "9": { + "annotation": "", + "id": 9, + "input_connections": { + "input": { + "id": 8, + "output_name": "output_mpileup" + } + }, + "inputs": [], + "name": "bcftools view", + "outputs": [ + { + "name": "output", + "type": "vcf" + } + ], + "position": { + "left": 1357, + "top": 352 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "toolshed.g2.bx.psu.edu/repos/nilesh/bcftools/bcftools_view/1.0.0", + "tool_state": "{\"A\": \"\\\"true\\\"\", \"__page__\": 0, \"c\": \"\\\"true\\\"\", \"b\": \"\\\"false\\\"\", \"e\": \"\\\"false\\\"\", \"D\": \"{\\\"seq_dictionary\\\": \\\"false\\\", \\\"__current_case__\\\": 1}\", \"G\": \"\\\"false\\\"\", \"F\": \"\\\"false\\\"\", \"i\": \"{\\\"__current_case__\\\": 1, \\\"alt_indel_snp_ratio\\\": \\\"false\\\"}\", \"__rerun_remap_job_id__\": null, \"N\": \"\\\"false\\\"\", \"p\": \"{\\\"variant_filter\\\": \\\"false\\\", \\\"__current_case__\\\": 1}\", \"S\": \"\\\"false\\\"\", \"g\": \"\\\"false\\\"\", \"t\": \"{\\\"mutation_rate\\\": \\\"false\\\", \\\"__current_case__\\\": 1}\", \"v\": \"\\\"true\\\"\", \"u\": \"\\\"false\\\"\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCh37_canon.len\\\"\", \"input\": \"null\"}", + "tool_version": "1.0.0", + "type": "tool", + "user_outputs": [] + }, + "10": { + "annotation": "", + "id": 10, + "input_connections": { + "input": { + "id": 9, + "output_name": "output" + } + }, + "inputs": [ + { + "description": "runtime parameter for tool SnpEff", + "name": "snpDb" + } + ], + "name": "SnpEff", + "outputs": [ + { + "name": "snpeff_output", + "type": "vcf" + }, + { + "name": "statsFile", + "type": "html" + } + ], + "position": { + "left": 1576, + "top": 317 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "toolshed.g2.bx.psu.edu/repos/iuc/snpeff/snpEff/3.4", + "tool_state": "{\"spliceSiteSize\": \"\\\"1\\\"\", \"filterHomHet\": \"\\\"no_filter\\\"\", \"outputFormat\": \"\\\"vcf\\\"\", \"udLength\": \"\\\"0\\\"\", \"inputFormat\": \"\\\"vcf\\\"\", \"filterIn\": \"\\\"-snp\\\"\", \"__page__\": 0, \"__rerun_remap_job_id__\": null, \"filterOut\": \"[\\\"-no-downstream\\\", \\\"-no-intergenic\\\", \\\"-no-intron\\\", \\\"-no-upstream\\\", \\\"-no-utr\\\"]\", \"generate_stats\": \"\\\"True\\\"\", \"noLog\": \"\\\"True\\\"\", \"chr\": \"\\\"\\\"\", \"intervals\": \"null\", \"snpDb\": \"{\\\"genome_version\\\": {\\\"__class__\\\": \\\"RuntimeValue\\\"}, \\\"genomeSrc\\\": \\\"named\\\", \\\"__current_case__\\\": 2}\", \"offset\": \"\\\"\\\"\", \"input\": \"null\", \"transcripts\": \"null\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCh37_canon.len\\\"\", \"annotations\": \"null\"}", + "tool_version": "3.4", + "type": "tool", + "user_outputs": [] + }, + "11": { + "annotation": "", + "id": 11, + "input_connections": { + "all_pep_fasta": { + "id": 3, + "output_name": "output" + }, + "snpeff_vcf": { + "id": 10, + "output_name": "snpeff_output" + } + }, + "inputs": [], + "name": "SnpEff to Peptide fasta", + "outputs": [ + { + "name": "peptide_variant_fasta", + "type": "fasta" + } + ], + "position": { + "left": 1885, + "top": 455 + }, + "post_job_actions": {}, + "tool_errors": null, + "tool_id": "toolshed.g2.bx.psu.edu/repos/jjohnson/snpeff_to_peptides/snpeff_to_peptides/0.0.1", + "tool_state": "{\"__page__\": 0, \"leading_aa_num\": \"\\\"66\\\"\", \"all_pep_fasta\": \"null\", \"__rerun_remap_job_id__\": null, \"trailing_aa_num\": \"\\\"66\\\"\", \"snpeff_vcf\": \"null\", \"chromInfo\": \"\\\"/website/galaxy.msi.umn.edu/PRODUCTION/tool-data/shared/ucsc/chrom/GRCh37_canon.len\\\"\"}", + "tool_version": "0.0.1", + "type": "tool", + "user_outputs": [] + } + } +} \ No newline at end of file
--- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/repository_dependencies.xml Mon Mar 17 15:59:57 2014 -0500 @@ -0,0 +1,8 @@ +<?xml version="1.0"?> +<repositories description="Required tools for proteomics_rnaseq_splice_db_workflow"> + <repository name="tophat" owner="devteam" toolshed="http://toolshed.g2.bx.psu.edu" changeset_revision="1030acbecce6" /> + <repository name="samtools_mpileup" owner="devteam" toolshed="http://toolshed.g2.bx.psu.edu" changeset_revision="44a18a94d7a9" /> + <repository name="bcftools" owner="nilesh" toolshed="http://toolshed.g2.bx.psu.edu" changeset_revision="3182c7fac413" /> + <repository name="snpeff" owner="iuc" toolshed="http://toolshed.g2.bx.psu.edu" changeset_revision="e8adfc4c0a6b" /> + <repository name="snpeff_to_peptides" owner="jjohnson" toolshed="http://toolshed.g2.bx.psu.edu" changeset_revision="fcb7188fa0d2" /> +</repositories>
