root/galaxy-central/tool_conf.xml

リビジョン 3, 22.4 KB (コミッタ: kohda, 14 年 前)

Install Unix tools  http://hannonlab.cshl.edu/galaxy_unix_tools/galaxy.html

行番号 
1<?xml version="1.0"?>
2<toolbox>
3  <section name="Get Data" id="getext">
4    <tool file="data_source/upload.xml"/>
5    <tool file="data_source/ucsc_tablebrowser.xml" />
6    <tool file="data_source/ucsc_tablebrowser_test.xml" />
7    <tool file="data_source/ucsc_tablebrowser_archaea.xml" />
8    <tool file="data_source/bx_browser.xml" />
9    <tool file="data_source/microbial_import.xml" />
10    <tool file="data_source/biomart.xml" />
11    <tool file="data_source/biomart_test.xml" />
12    <tool file="data_source/cbi_rice_mart.xml" />
13    <tool file="data_source/gramene_mart.xml" />
14    <tool file="data_source/fly_modencode.xml" />
15    <tool file="data_source/flymine.xml" />
16    <tool file="data_source/flymine_test.xml" />
17    <tool file="data_source/modmine.xml" />
18    <tool file="data_source/ratmine.xml" />
19    <tool file="data_source/worm_modencode.xml" />
20    <tool file="data_source/wormbase.xml" />
21    <tool file="data_source/wormbase_test.xml" />
22    <tool file="data_source/eupathdb.xml" />
23    <tool file="data_source/encode_db.xml" />
24    <tool file="data_source/epigraph_import.xml" />
25    <tool file="data_source/epigraph_import_test.xml" />
26    <tool file="data_source/hbvar.xml" />
27    <tool file="validation/fix_errors.xml" />
28  </section>
29  <section name="Send Data" id="send">
30    <tool file="data_destination/epigraph.xml" />
31    <tool file="data_destination/epigraph_test.xml" />
32  </section>
33  <section name="ENCODE Tools" id="EncodeTools">
34    <tool file="encode/gencode_partition.xml" />
35    <tool file="encode/random_intervals.xml" />
36  </section>
37  <section name="Lift-Over" id="liftOver">
38    <tool file="extract/liftOver_wrapper.xml" />
39  </section>
40  <section name="Text Manipulation" id="textutil">
41    <tool file="filters/fixedValueColumn.xml" />
42    <tool file="stats/column_maker.xml" />
43    <tool file="filters/catWrapper.xml" />
44    <tool file="filters/cutWrapper.xml" />
45    <tool file="filters/mergeCols.xml" />
46    <tool file="filters/convert_characters.xml" />
47    <tool file="filters/CreateInterval.xml" />
48    <tool file="filters/cutWrapper.xml" />
49    <tool file="filters/changeCase.xml" />
50    <tool file="filters/pasteWrapper.xml" />
51    <tool file="filters/remove_beginning.xml" />
52    <tool file="filters/randomlines.xml" />
53    <tool file="filters/headWrapper.xml" />
54    <tool file="filters/tailWrapper.xml" />
55    <tool file="filters/trimmer.xml" />
56    <tool file="stats/dna_filtering.xml" />
57    <tool file="new_operations/tables_arithmetic_operations.xml" />
58<!--
59        add galaxy-unix tools from here
60-->
61        <tool file="unix_tools/remove_ending.xml" />
62        <tool file="unix_tools/find_and_replace.xml" />
63<!--
64        add galaxy-unix tools end
65-->
66  </section>
67  <section name="Filter and Sort" id="filter">
68<!--
69        add galaxy-unix tools from here
70-->
71    <tool file="unix_tools/word_list_grep.xml" />
72<!--
73        add galaxy-unix tools end
74-->
75    <tool file="stats/filtering.xml" />
76    <tool file="filters/sorter.xml" />
77    <tool file="filters/grep.xml" />
78    <label text="GFF" id="gff" />
79        <tool file="filters/gff/extract_GFF_Features.xml" />
80        <tool file="filters/gff/gff_filter_by_attribute.xml" />
81        <tool file="filters/gff/gff_filter_by_feature_count.xml" />
82  </section>
83  <section name="Join, Subtract and Group" id="group">
84    <tool file="filters/joiner.xml" />
85    <tool file="filters/compare.xml"/>
86    <tool file="new_operations/subtract_query.xml"/>
87    <tool file="stats/grouping.xml" />
88    <tool file="new_operations/column_join.xml" />
89  </section>
90  <section name="Convert Formats" id="convert">
91    <tool file="filters/axt_to_concat_fasta.xml" />
92    <tool file="filters/axt_to_fasta.xml" />
93    <tool file="filters/axt_to_lav.xml" />
94    <tool file="filters/bed2gff.xml" />
95    <tool file="fasta_tools/fasta_to_tabular.xml" />
96    <tool file="filters/gff2bed.xml" />
97    <tool file="filters/lav_to_bed.xml" />
98    <tool file="maf/maf_to_bed.xml" />
99    <tool file="maf/maf_to_interval.xml" />
100    <tool file="maf/maf_to_fasta.xml" />
101    <tool file="fasta_tools/tabular_to_fasta.xml" />
102    <tool file="fastq/fastq_to_fasta.xml" />
103    <tool file="filters/wiggle_to_simple.xml" />
104    <tool file="filters/sff_extractor.xml" />
105    <tool file="filters/gtf2bedgraph.xml" />
106    <tool file="filters/wig_to_bigwig.xml" />
107  </section>
108  <section name="Extract Features" id="features">
109    <tool file="filters/ucsc_gene_bed_to_exon_bed.xml" />
110  </section>
111  <section name="Fetch Sequences" id="fetchSeq">
112    <tool file="extract/extract_genomic_dna.xml" />
113  </section>
114  <section name="Fetch Alignments" id="fetchAlign">
115    <tool file="maf/interval2maf_pairwise.xml" />
116    <tool file="maf/interval2maf.xml" />
117    <tool file="maf/maf_split_by_species.xml"/>
118    <tool file="maf/interval_maf_to_merged_fasta.xml" />
119    <tool file="maf/genebed_maf_to_fasta.xml"/>
120    <tool file="maf/maf_stats.xml"/>
121    <tool file="maf/maf_thread_for_species.xml"/>
122    <tool file="maf/maf_limit_to_species.xml"/>
123    <tool file="maf/maf_limit_size.xml"/>
124    <tool file="maf/maf_by_block_number.xml"/>
125    <tool file="maf/maf_reverse_complement.xml"/>
126    <tool file="maf/maf_filter.xml"/>
127  </section>
128  <section name="Get Genomic Scores" id="scores">
129    <tool file="stats/wiggle_to_simple.xml" />
130    <tool file="stats/aggregate_binned_scores_in_intervals.xml" />
131    <tool file="extract/phastOdds/phastOdds_tool.xml" />
132  </section>
133  <section name="Operate on Genomic Intervals" id="bxops">
134    <tool file="new_operations/intersect.xml" />
135    <tool file="new_operations/subtract.xml" />
136    <tool file="new_operations/merge.xml" />
137    <tool file="new_operations/concat.xml" />
138    <tool file="new_operations/basecoverage.xml" />
139    <tool file="new_operations/coverage.xml" />
140    <tool file="new_operations/complement.xml" />
141    <tool file="new_operations/cluster.xml" id="cluster" />
142    <tool file="new_operations/join.xml" />
143    <tool file="new_operations/get_flanks.xml" />
144    <tool file="new_operations/flanking_features.xml" />
145    <tool file="annotation_profiler/annotation_profiler.xml" />
146  </section>
147  <section name="Statistics" id="stats">
148    <tool file="stats/gsummary.xml" />
149    <tool file="filters/uniq.xml" />
150    <tool file="stats/cor.xml" />
151    <tool file="stats/generate_matrix_for_pca_lda.xml" />
152    <tool file="stats/lda_analy.xml" />
153    <tool file="stats/plot_from_lda.xml" />
154    <tool file="regVariation/t_test_two_samples.xml" />
155    <tool file="regVariation/compute_q_values.xml" />
156  </section>
157  <section name="Wavelet Analysis" id="dwt">
158        <tool file="discreteWavelet/execute_dwt_IvC_all.xml" />
159        <tool file="discreteWavelet/execute_dwt_cor_aVa_perClass.xml" />
160        <tool file="discreteWavelet/execute_dwt_cor_aVb_all.xml" />
161        <tool file="discreteWavelet/execute_dwt_var_perClass.xml" />
162 </section>
163  <section name="Graph/Display Data" id="plots">
164    <tool file="plotting/histogram2.xml" />
165    <tool file="plotting/scatterplot.xml" />
166    <tool file="plotting/bar_chart.xml" />
167    <tool file="plotting/xy_plot.xml" />
168    <tool file="plotting/boxplot.xml" />
169    <tool file="visualization/GMAJ.xml" />
170    <tool file="visualization/LAJ.xml" />
171    <tool file="visualization/build_ucsc_custom_track.xml" />
172    <tool file="maf/vcf_to_maf_customtrack.xml" />
173    <tool file="mutation/visualize.xml" />
174  </section>
175  <section name="Regional Variation" id="regVar">
176    <tool file="regVariation/windowSplitter.xml" />
177    <tool file="regVariation/featureCounter.xml" />
178    <tool file="regVariation/quality_filter.xml" />
179    <tool file="regVariation/maf_cpg_filter.xml" />
180    <tool file="regVariation/getIndels_2way.xml" />
181    <tool file="regVariation/getIndels_3way.xml" />
182    <tool file="regVariation/getIndelRates_3way.xml" />
183    <tool file="regVariation/substitutions.xml" />
184    <tool file="regVariation/substitution_rates.xml" />
185    <tool file="regVariation/microsats_alignment_level.xml" />
186    <tool file="regVariation/microsats_mutability.xml" />
187    <tool file="regVariation/delete_overlapping_indels.xml" />
188    <tool file="regVariation/compute_motifs_frequency.xml" />
189    <tool file="regVariation/compute_motif_frequencies_for_all_motifs.xml" />
190    <tool file="regVariation/categorize_elements_satisfying_criteria.xml" />s
191    <tool file="regVariation/draw_stacked_barplots.xml" />
192  </section>
193  <section name="Multiple regression" id="multReg">
194    <tool file="regVariation/linear_regression.xml" />
195    <tool file="regVariation/best_regression_subsets.xml" />
196    <tool file="regVariation/rcve.xml" />
197  </section>
198  <section name="Multivariate Analysis" id="multVar">
199    <tool file="multivariate_stats/pca.xml" />
200    <tool file="multivariate_stats/cca.xml" />
201    <tool file="multivariate_stats/kpca.xml" />
202    <tool file="multivariate_stats/kcca.xml" />
203  </section>
204 <section name="Evolution" id="hyphy">
205    <tool file="hyphy/hyphy_branch_lengths_wrapper.xml" />
206    <tool file="hyphy/hyphy_nj_tree_wrapper.xml" />
207    <tool file="hyphy/hyphy_dnds_wrapper.xml" />
208    <tool file="evolution/mutate_snp_codon.xml" />
209    <tool file="evolution/codingSnps.xml" />
210    <tool file="evolution/add_scores.xml" />
211 </section>
212 <section name="Metagenomic analyses" id="tax_manipulation">
213    <tool file="taxonomy/gi2taxonomy.xml" />
214    <tool file="taxonomy/t2t_report.xml" />
215    <tool file="taxonomy/t2ps_wrapper.xml" />
216    <tool file="taxonomy/find_diag_hits.xml" />
217    <tool file="taxonomy/lca.xml" />
218    <tool file="taxonomy/poisson2test.xml" />
219  </section>
220  <section name="FASTA manipulation" id="fasta_manipulation">
221    <tool file="fasta_tools/fasta_compute_length.xml" />
222    <tool file="fasta_tools/fasta_filter_by_length.xml" />
223    <tool file="fasta_tools/fasta_concatenate_by_species.xml" />
224    <tool file="fasta_tools/fasta_to_tabular.xml" />
225    <tool file="fasta_tools/tabular_to_fasta.xml" />
226    <tool file="fastx_toolkit/fasta_formatter.xml" />
227    <tool file="fastx_toolkit/fasta_nucleotide_changer.xml" />
228    <tool file="fastx_toolkit/fastx_collapser.xml" />
229  </section>
230  <section name="NGS: QC and manipulation" id="cshl_library_information">
231    <label text="Illumina data" id="illumina" />
232        <tool file="fastq/fastq_groomer.xml" />
233        <tool file="fastq/fastq_paired_end_splitter.xml" />
234        <tool file="fastq/fastq_paired_end_joiner.xml" />
235        <tool file="fastq/fastq_stats.xml" />
236    <label text="Roche-454 data" id="454" />
237        <tool file="metag_tools/short_reads_figure_score.xml" />
238        <tool file="metag_tools/short_reads_trim_seq.xml" />
239        <tool file="fastq/fastq_combiner.xml" />
240    <label text="AB-SOLiD data" id="solid" />
241        <tool file="next_gen_conversion/solid2fastq.xml" />
242        <tool file="solid_tools/solid_qual_stats.xml" />
243        <tool file="solid_tools/solid_qual_boxplot.xml" />
244    <label text="Generic FASTQ manipulation" id="generic_fastq" />
245        <tool file="fastq/fastq_filter.xml" />
246        <tool file="fastq/fastq_trimmer.xml" />
247        <tool file="fastq/fastq_trimmer_by_quality.xml" />
248        <tool file="fastq/fastq_masker_by_quality.xml" />
249        <tool file="fastq/fastq_manipulation.xml" />
250        <tool file="fastq/fastq_to_fasta.xml" />
251        <tool file="fastq/fastq_to_tabular.xml" />
252        <tool file="fastq/tabular_to_fastq.xml" />
253    <label text="FASTX-Toolkit for FASTQ data" id="fastx_toolkit" />
254        <tool file="fastx_toolkit/fastq_quality_converter.xml" />
255        <tool file="fastx_toolkit/fastx_quality_statistics.xml" />
256        <tool file="fastx_toolkit/fastq_quality_boxplot.xml" />
257        <tool file="fastx_toolkit/fastx_nucleotides_distribution.xml" />
258        <tool file="fastx_toolkit/fastq_to_fasta.xml" />
259        <tool file="fastx_toolkit/fastq_quality_filter.xml" />
260        <tool file="fastx_toolkit/fastq_to_fasta.xml" />
261        <tool file="fastx_toolkit/fastx_artifacts_filter.xml" />
262        <tool file="fastx_toolkit/fastx_barcode_splitter.xml" />
263        <tool file="fastx_toolkit/fastx_clipper.xml" />
264        <tool file="fastx_toolkit/fastx_collapser.xml" />
265        <tool file="fastx_toolkit/fastx_renamer.xml" />
266        <tool file="fastx_toolkit/fastx_reverse_complement.xml" />
267        <tool file="fastx_toolkit/fastx_trimmer.xml" /> 
268  </section>
269  <!--
270  Keep this section commented until it includes tools that
271  will be hosted on test/main.  The velvet wrappers have been
272  included in the distribution but will not be hosted on our
273  public servers for the current time.
274  <section name="NGS: Assembly" id="ngs_assembly">
275        <label text="Velvet" id="velvet"/>
276        <tool file="sr_assembly/velvetg.xml" />
277        <tool file="sr_assembly/velveth.xml" />
278  </section>
279  -->
280  <section name="NCBI BLAST+" id="ncbi_blast_plus_tools">
281   <tool file="ncbi_blast_plus/ncbi_blastn_wrapper.xml" />
282   <tool file="ncbi_blast_plus/ncbi_blastp_wrapper.xml" />
283   <tool file="ncbi_blast_plus/ncbi_blastx_wrapper.xml" />
284   <tool file="ncbi_blast_plus/ncbi_tblastn_wrapper.xml" />
285   <tool file="ncbi_blast_plus/ncbi_tblastx_wrapper.xml" />
286   <tool file="ncbi_blast_plus/blast_filter_fasta.xml" />
287  </section>
288  <section name="NGS: Mapping" id="solexa_tools">
289   <tool file="sr_mapping/lastz_wrapper.xml" />
290   <tool file="sr_mapping/lastz_paired_reads_wrapper.xml" />
291   <tool file="sr_mapping/bowtie_wrapper.xml" />
292   <tool file="sr_mapping/bowtie_color_wrapper.xml" />
293   <tool file="sr_mapping/bwa_wrapper.xml" />
294   <tool file="sr_mapping/bfast_wrapper.xml" />
295   <tool file="metag_tools/megablast_wrapper.xml" />
296   <tool file="metag_tools/megablast_xml_parser.xml" />
297   <tool file="sr_mapping/PerM.xml" />
298   <tool file="sr_mapping/srma_wrapper.xml" />
299  </section>
300  <section name="NGS: Indel Analysis" id="indel_analysis">
301   <tool file="indels/sam_indel_filter.xml" />
302   <tool file="indels/indel_sam2interval.xml" />
303   <tool file="indels/indel_table.xml" />"
304   <tool file="indels/indel_analysis.xml" />
305  </section>
306  <section name="NGS: RNA Analysis" id="ngs-rna-tools">
307   <label text="RNA-seq" id="rna_seq" />
308      <tool file="ngs_rna/tophat_wrapper.xml" />
309      <tool file="ngs_rna/cufflinks_wrapper.xml" />
310      <tool file="ngs_rna/cuffcompare_wrapper.xml" />
311      <tool file="ngs_rna/cuffdiff_wrapper.xml" />
312   <label text="Filtering" id="filtering" />
313      <tool file="ngs_rna/filter_transcripts_via_tracking.xml" />
314  </section>
315  <section name="NGS: SAM Tools" id="samtools">
316   <tool file="samtools/sam_bitwise_flag_filter.xml" />
317   <tool file="samtools/sam2interval.xml" />
318   <tool file="samtools/sam_to_bam.xml" />
319   <tool file="samtools/bam_to_sam.xml" />
320   <tool file="samtools/sam_merge.xml" />
321   <tool file="samtools/sam_pileup.xml" />
322   <tool file="samtools/pileup_parser.xml" />
323   <tool file="samtools/pileup_interval.xml" />
324  </section>
325  <section name="NGS: Peak Calling" id="peak_calling">
326   <tool file="peak_calling/macs_wrapper.xml" />
327   <tool file="genetrack/genetrack_indexer.xml" />
328   <tool file="genetrack/genetrack_peak_prediction.xml" />
329  </section>
330  <section name="SNP/WGA: Data; Filters" id="rgdat">
331  <label text="Data: Import and upload" id="rgimport" />
332    <tool file="data_source/upload.xml"/>
333    <tool file="data_source/access_libraries.xml" />
334    <tool file="data_source/hapmapmart.xml" />
335  <label text="Data: Filter and Clean" id="rgfilter" />
336    <tool file="rgenetics/rgClean.xml"/>
337    <tool file="rgenetics/rgPedSub.xml"/>
338    <tool file="rgenetics/rgLDIndep.xml"/>
339  <label text="Simulate" id="rgsim" />
340    <tool file="rgenetics/rgfakePhe.xml"/>
341    <tool file="rgenetics/rgfakePed.xml"/>
342  </section>
343  <section name="SNP/WGA: QC; LD; Plots" id="rgqcplot">
344  <label text="QC; Eigenstrat" id="rgvisual" />
345    <tool file="rgenetics/rgQC.xml"/>
346    <tool file="rgenetics/rgEigPCA.xml"/>
347  <label text="LD; Manhattan/QQ; GRR" id="rgld" />
348    <tool file="rgenetics/rgHaploView.xml"/>
349    <tool file="rgenetics/rgManQQ.xml"/>
350    <tool file="rgenetics/rgGRR.xml"/>
351  </section>
352  <section name="SNP/WGA: Statistical Models" id="rgmodel">
353    <tool file="rgenetics/rgCaCo.xml"/>
354    <tool file="rgenetics/rgTDT.xml"/>
355    <tool file="rgenetics/rgGLM.xml"/>
356    <tool file="rgenetics/rgManQQ.xml"/>
357  </section>
358  <section name="Human Genome Variation" id="hgv">
359    <tool file="evolution/codingSnps.xml" />
360    <tool file="evolution/add_scores.xml" />
361    <tool file="human_genome_variation/sift.xml" />
362    <tool file="human_genome_variation/linkToGProfile.xml" />
363    <tool file="human_genome_variation/linkToDavid.xml"/>
364    <tool file="human_genome_variation/ctd.xml" />
365    <tool file="human_genome_variation/funDo.xml" />
366    <tool file="human_genome_variation/snpFreq.xml" />
367    <tool file="human_genome_variation/ldtools.xml" />
368    <tool file="human_genome_variation/pass.xml" />
369    <tool file="human_genome_variation/gpass.xml" />
370    <tool file="human_genome_variation/beam.xml" />
371    <tool file="human_genome_variation/lps.xml" />
372    <tool file="human_genome_variation/hilbertvis.xml" />
373  </section>
374<!--
375        add galaxy-unix tools from here
376-->
377  <section name="Unix Tools" id="unix_tools">
378    <tool file="unix_tools/awk_tool.xml" />
379    <tool file="unix_tools/sed_tool.xml" />
380    <tool file="unix_tools/grep_tool.xml" />
381    <tool file="unix_tools/sort_tool.xml" />
382    <tool file="unix_tools/uniq_tool.xml" />
383    <tool file="unix_tools/cut_tool.xml" />
384    <tool file="unix_tools/join_tool.xml" />
385  </section>
386<!--
387        add galaxy-unix tools end
388-->
389<!--
390  TODO: uncomment the following EMBOSS section whenever
391  moving to test, but comment it in .sample to eliminate
392  it from buildbot functional tests since these tools
393  rarely change.
394-->
395<!--
396  <section name="EMBOSS" id="EMBOSSLite">
397    <tool file="emboss_5/emboss_antigenic.xml" />
398    <tool file="emboss_5/emboss_backtranseq.xml" />
399    <tool file="emboss_5/emboss_banana.xml" />
400    <tool file="emboss_5/emboss_biosed.xml" />
401    <tool file="emboss_5/emboss_btwisted.xml" />
402    <tool file="emboss_5/emboss_cai_custom.xml" />
403    <tool file="emboss_5/emboss_cai.xml" />
404    <tool file="emboss_5/emboss_chaos.xml" />
405    <tool file="emboss_5/emboss_charge.xml" />
406    <tool file="emboss_5/emboss_checktrans.xml" />
407    <tool file="emboss_5/emboss_chips.xml" />
408    <tool file="emboss_5/emboss_cirdna.xml" />
409    <tool file="emboss_5/emboss_codcmp.xml" />
410    <tool file="emboss_5/emboss_coderet.xml" />
411    <tool file="emboss_5/emboss_compseq.xml" />
412    <tool file="emboss_5/emboss_cpgplot.xml" />
413    <tool file="emboss_5/emboss_cpgreport.xml" />
414    <tool file="emboss_5/emboss_cusp.xml" />
415    <tool file="emboss_5/emboss_cutseq.xml" />
416    <tool file="emboss_5/emboss_dan.xml" />
417    <tool file="emboss_5/emboss_degapseq.xml" />
418    <tool file="emboss_5/emboss_descseq.xml" />
419    <tool file="emboss_5/emboss_diffseq.xml" />
420    <tool file="emboss_5/emboss_digest.xml" />
421    <tool file="emboss_5/emboss_dotmatcher.xml" />
422    <tool file="emboss_5/emboss_dotpath.xml" />
423    <tool file="emboss_5/emboss_dottup.xml" />
424    <tool file="emboss_5/emboss_dreg.xml" />
425    <tool file="emboss_5/emboss_einverted.xml" />
426    <tool file="emboss_5/emboss_epestfind.xml" />
427    <tool file="emboss_5/emboss_equicktandem.xml" />
428    <tool file="emboss_5/emboss_est2genome.xml" />
429    <tool file="emboss_5/emboss_etandem.xml" />
430    <tool file="emboss_5/emboss_extractfeat.xml" />
431    <tool file="emboss_5/emboss_extractseq.xml" />
432    <tool file="emboss_5/emboss_freak.xml" />
433    <tool file="emboss_5/emboss_fuzznuc.xml" />
434    <tool file="emboss_5/emboss_fuzzpro.xml" />
435    <tool file="emboss_5/emboss_fuzztran.xml" />
436    <tool file="emboss_5/emboss_garnier.xml" />
437    <tool file="emboss_5/emboss_geecee.xml" />
438    <tool file="emboss_5/emboss_getorf.xml" />
439    <tool file="emboss_5/emboss_helixturnhelix.xml" />
440    <tool file="emboss_5/emboss_hmoment.xml" />
441    <tool file="emboss_5/emboss_iep.xml" />
442    <tool file="emboss_5/emboss_infoseq.xml" />
443    <tool file="emboss_5/emboss_isochore.xml" />
444    <tool file="emboss_5/emboss_lindna.xml" />
445    <tool file="emboss_5/emboss_marscan.xml" />
446    <tool file="emboss_5/emboss_maskfeat.xml" />
447    <tool file="emboss_5/emboss_maskseq.xml" />
448    <tool file="emboss_5/emboss_matcher.xml" />
449    <tool file="emboss_5/emboss_megamerger.xml" />
450    <tool file="emboss_5/emboss_merger.xml" />
451    <tool file="emboss_5/emboss_msbar.xml" />
452    <tool file="emboss_5/emboss_needle.xml" />
453    <tool file="emboss_5/emboss_newcpgreport.xml" />
454    <tool file="emboss_5/emboss_newcpgseek.xml" />
455    <tool file="emboss_5/emboss_newseq.xml" />
456    <tool file="emboss_5/emboss_noreturn.xml" />
457    <tool file="emboss_5/emboss_notseq.xml" />
458    <tool file="emboss_5/emboss_nthseq.xml" />
459    <tool file="emboss_5/emboss_octanol.xml" />
460    <tool file="emboss_5/emboss_oddcomp.xml" />
461    <tool file="emboss_5/emboss_palindrome.xml" />
462    <tool file="emboss_5/emboss_pasteseq.xml" />
463    <tool file="emboss_5/emboss_patmatdb.xml" />
464    <tool file="emboss_5/emboss_pepcoil.xml" />
465    <tool file="emboss_5/emboss_pepinfo.xml" />
466    <tool file="emboss_5/emboss_pepnet.xml" />
467    <tool file="emboss_5/emboss_pepstats.xml" />
468    <tool file="emboss_5/emboss_pepwheel.xml" />
469    <tool file="emboss_5/emboss_pepwindow.xml" />
470    <tool file="emboss_5/emboss_pepwindowall.xml" />
471    <tool file="emboss_5/emboss_plotcon.xml" />
472    <tool file="emboss_5/emboss_plotorf.xml" />
473    <tool file="emboss_5/emboss_polydot.xml" />
474    <tool file="emboss_5/emboss_preg.xml" />
475    <tool file="emboss_5/emboss_prettyplot.xml" />
476    <tool file="emboss_5/emboss_prettyseq.xml" />
477    <tool file="emboss_5/emboss_primersearch.xml" />
478    <tool file="emboss_5/emboss_revseq.xml" />
479    <tool file="emboss_5/emboss_seqmatchall.xml" />
480    <tool file="emboss_5/emboss_seqret.xml" />
481    <tool file="emboss_5/emboss_showfeat.xml" />
482    <tool file="emboss_5/emboss_shuffleseq.xml" />
483    <tool file="emboss_5/emboss_sigcleave.xml" />
484    <tool file="emboss_5/emboss_sirna.xml" />
485    <tool file="emboss_5/emboss_sixpack.xml" />
486    <tool file="emboss_5/emboss_skipseq.xml" />
487    <tool file="emboss_5/emboss_splitter.xml" />
488    <tool file="emboss_5/emboss_supermatcher.xml" />
489    <tool file="emboss_5/emboss_syco.xml" />
490    <tool file="emboss_5/emboss_tcode.xml" />
491    <tool file="emboss_5/emboss_textsearch.xml" />
492    <tool file="emboss_5/emboss_tmap.xml" />
493    <tool file="emboss_5/emboss_tranalign.xml" />
494    <tool file="emboss_5/emboss_transeq.xml" />
495    <tool file="emboss_5/emboss_trimest.xml" />
496    <tool file="emboss_5/emboss_trimseq.xml" />
497    <tool file="emboss_5/emboss_twofeat.xml" />
498    <tool file="emboss_5/emboss_union.xml" />
499    <tool file="emboss_5/emboss_vectorstrip.xml" />
500    <tool file="emboss_5/emboss_water.xml" />
501    <tool file="emboss_5/emboss_wobble.xml" />
502    <tool file="emboss_5/emboss_wordcount.xml" />
503    <tool file="emboss_5/emboss_wordmatch.xml" />
504  </section>
505-->
506</toolbox>
Note: リポジトリブラウザについてのヘルプは TracBrowser を参照してください。