-profile docker"
+ log.info logo + paramsHelp(command) + citation + NfcoreTemplate.dashedLine(params.monochrome_logs)
+ System.exit(0)
+ }
+
+ // Validate input parameters
+ if (params.validate_params) {
+ validateParameters()
+ }
+
+ WorkflowMain.initialise(workflow, params, log)
+
SHALLOWMAPPING ()
}
diff --git a/modules.json b/modules.json
index 8f634a3..4edfa34 100644
--- a/modules.json
+++ b/modules.json
@@ -21,6 +21,11 @@
"git_sha": "911696ea0b62df80e900ef244d7867d177971f73",
"installed_by": ["modules"]
},
+ "fastp": {
+ "branch": "master",
+ "git_sha": "666652151335353eef2fcd58880bcef5bc2928e1",
+ "installed_by": ["modules"]
+ },
"fastqc": {
"branch": "master",
"git_sha": "bd8092b67b5103bdd52e300f75889442275c3117",
diff --git a/modules/local/download_human_phix_bwamem2_index.nf b/modules/local/download_human_phix_bwamem2_index.nf
new file mode 100644
index 0000000..d57b977
--- /dev/null
+++ b/modules/local/download_human_phix_bwamem2_index.nf
@@ -0,0 +1,15 @@
+process DOWNLOAD_HUMAN_PHIX_BWAMEM2_INDEX {
+
+ container "${workflow.containerEngine in ['singularity', 'apptainer']
+ ? 'https://depot.galaxyproject.org/singularity/gnu-wget:1.18--h36e9172_9'
+ : 'biocontainers/gnu-wget:1.18--h36e9172_9'}"
+
+ output:
+ path ("human_phix.fa*"), emit: human_phix_index
+
+ script:
+ """
+ wget -q --continue ftp://ftp.ebi.ac.uk/pub/databases/metagenomics/pipelines/references/human_phiX/human_phix_ref_bwamem2.tar.gz
+ tar -xvf human_phix_ref_bwamem2.tar.gz
+ """
+}
diff --git a/modules/local/download_mgnify_genomes_reference_dbs.nf b/modules/local/download_mgnify_genomes_reference_dbs.nf
new file mode 100644
index 0000000..a711d46
--- /dev/null
+++ b/modules/local/download_mgnify_genomes_reference_dbs.nf
@@ -0,0 +1,65 @@
+process DOWNLOAD_MGNIFY_GENOMES_REFERENCE_DBS {
+
+ container "${workflow.containerEngine in ['singularity', 'apptainer']
+ ? 'https://depot.galaxyproject.org/singularity/gnu-wget:1.18--h36e9172_9'
+ : 'biocontainers/gnu-wget:1.18--h36e9172_9'}"
+
+ input:
+ val biome
+ val download_bwamem2
+
+ output:
+ tuple val(biome), path("genomes-all_metadata.tsv"), emit: genomes_metadata_tsv
+ tuple val(biome), path("functional_profiles_DB/"), emit: pangenome_functional_anns_db
+ tuple val(biome), path("kegg_completeness_DB/"), emit: kegg_completeness_db
+ tuple val(biome), path("sourmash_species_representatives_k21.sbt.zip"), emit: sourmash_db
+ tuple val(biome), path("bwamem2_index/") , emit: bwamem2_index, optional: true
+
+ script:
+ def matcher = biome =~ /(.+?)(-v[0-9.\.]+)?$/
+ def biome_name = matcher[0][1]
+ def biome_version = matcher[0][2] ? matcher[0][2].substring(1) : null
+ if (!biome_version) {
+ exit("Error the biome version of ${biome} can't be parsed.")
+ }
+ // MGnify genomes catalogue data //
+ // Example: https://ftp.ebi.ac.uk/pub/databases/metagenomics/mgnify_genomes/honeybee-gut/v1.0.1/
+ def biome_catalogue_ftp = "ftp://ftp.ebi.ac.uk/pub/databases/metagenomics/mgnify_genomes/${biome_name}/${biome_version}"
+
+ // Shallow mapping specific //
+ // This FTP path contains the MGnify Genomes catalogue processed annotations, ready to be used with this pipeline
+ def ftp_base = "ftp://ftp.ebi.ac.uk/pub/databases/metagenomics/pipelines/references/mgnify_genomes/${biome_name}_reps/${biome_version}/"
+
+ def functions_ftp = "${ftp_base}/pangenome_functional_profiles.tar.gz"
+ def kegg_ftp = "${ftp_base}/kegg_completeness.tar.gz"
+ def sourmash_ftp = "${ftp_base}/sourmash_species_representatives_k21.sbt.zip"
+ def reps_bwamem2_index_ftp = "${ftp_base}/reps_bwamem2.tar.gz"
+
+ """
+ if [[ "${download_bwamem2}" == 'True' ]];
+ then
+ # Downloading the host genome #
+ mkdir -p bwamem2_index/
+ echo " *** Downloading the biome reps mgnify genomes bwamem2 index ${reps_bwamem2_index_ftp}"
+ wget -nv --show-progress --progress=bar:force:noscroll --continue "${reps_bwamem2_index_ftp}"
+
+ echo " *** Extracting the bwamem index..."
+ tar -xvf reps_bwamem2.tar.gz -C bwamem2_index/
+ fi
+
+ # Downloading the catalogue-related files #
+ echo " *** Downloading catalogue related reference data"
+
+ # Downloading the catalogue metadata file
+ wget -nv --show-progress --progress=bar:force:noscroll --continue "${biome_catalogue_ftp}/genomes-all_metadata.tsv"
+
+ wget -nv --show-progress --progress=bar:force:noscroll --continue "${functions_ftp}"
+ tar -xvf pangenome_functional_profiles.tar.gz
+
+ wget -nv --show-progress --progress=bar:force:noscroll --continue "${kegg_ftp}"
+ tar -xvf kegg_completeness.tar.gz
+
+ # Downloading the representative genomes indexed for sourmash
+ wget -nv --show-progress --progress=bar:force:noscroll --continue "${sourmash_ftp}"
+ """
+}
diff --git a/modules/local/dram/distill.nf b/modules/local/dram/distill.nf
index 95d4378..3d92b6a 100644
--- a/modules/local/dram/distill.nf
+++ b/modules/local/dram/distill.nf
@@ -1,50 +1,63 @@
process DRAM_DISTILL {
- tag "$meta.id"
+ tag "${meta.id}"
label 'process_high'
- container "${ workflow.containerEngine == 'singularity' && !task.ext.singularity_pull_docker_container ?
- 'https://depot.galaxyproject.org/singularity/dram:1.3.5--pyhdfd78af_0':
- 'quay.io/biocontainers/dram:1.3.5--pyhdfd78af_0' }"
+ container "${workflow.containerEngine == 'singularity' && !task.ext.singularity_pull_docker_container
+ ? 'https://depot.galaxyproject.org/singularity/dram:1.3.5--pyhdfd78af_0'
+ : 'quay.io/biocontainers/dram:1.3.5--pyhdfd78af_0'}"
containerOptions {
- def arg = ""
- switch (workflow.containerEngine) {
- case 'singularity':
- arg = "--bind"
- break;
- case 'docker':
- arg = "--volume"
- break;
+ def arg = "--volume"
+ if (workflow.containerEngine == 'singularity' || workflow.containerEngine == 'apptainer') {
+ arg = "--bind"
}
- mounts = [
- "${params.shallow_dbs_path}/external_dbs/dram_distill_dbs/:/data/",
- "${params.shallow_dbs_path}/external_dbs/dram_distill_dbs/CONFIG:/usr/local/lib/python3.10/site-packages/mag_annotator/CONFIG"
+ def mounts = [
+ "${params.reference_dbs}/dram_dbs/:/data/",
+ "${params.reference_dbs}/dram_dbs/DRAM_CONFIG.json:/usr/local/lib/python3.10/site-packages/mag_annotator/CONFIG",
]
return "${arg} " + mounts.join(" ${arg} ")
}
input:
tuple val(meta), path(dram_summary)
- val(tool) //sm for sourmash or bwa for bwamem2
- val(in_type) //species or community
+ val tool
+ //sm for sourmash or bwa for bwamem2
+ val in_type
output:
tuple val(meta), path("*_dram*"), emit: destill_out, optional: true
- path "versions.yml" , emit: versions
+ path "versions.yml", emit: versions
when:
task.ext.when == null || task.ext.when
script:
- def args = task.ext.args ?: ''
def prefix = task.ext.prefix ?: "${meta.id}"
- def VERSION = '1.3.5' // WARN: dram has no option to print the tool version. This is the container version
+ // WARN: dram has no option to print the tool version. This is the container version
+ def VERSION = '1.3.5'
+ def header_columns = [
+ "fasta",
+ "scaffold",
+ "gene_position",
+ "start_position",
+ "end_position",
+ "strandedness",
+ "rank",
+ "kegg_id",
+ "kegg_hit",
+ "pfam_hits",
+ "cazy_hits",
+ "bin_taxonomy",
+ ]
+ header_columns = header_columns.join("\t")
"""
+ rm -rf dram_out/
+
if [[ "${in_type}" == "community" ]]; then
- echo ",fasta,scaffold,gene_position,start_position,end_position,strandedness,rank,kegg_id,kegg_hit,pfam_hits,cazy_hits,bin_taxonomy" | sed 's/,/\t/g' > dram_input.tsv
+ echo "${header_columns}" > dram_input.tsv
fi
- cat $dram_summary >> dram_input.tsv
+ cat ${dram_summary} >> dram_input.tsv
line_count=\$(wc -l dram_input.tsv | cut -d' ' -f1)
echo "Line count is "\$line_count
@@ -58,7 +71,7 @@ process DRAM_DISTILL {
counter=0
# Loop through each product_*.html files #
for productfile in dram_out/product*.html; do
- mv "\$productfile" "${prefix}_${tool}_${in_type}_\$counter_dram.html"
+ mv "\$productfile" "${prefix}_${tool}_${in_type}_\${counter}_dram.html"
counter=\$((counter + 1))
done
@@ -73,7 +86,7 @@ process DRAM_DISTILL {
cat <<-END_VERSIONS > versions.yml
"${task.process}":
- dram: $VERSION
+ dram: ${VERSION}
END_VERSIONS
"""
@@ -87,7 +100,7 @@ process DRAM_DISTILL {
cat <<-END_VERSIONS > versions.yml
"${task.process}":
- dram: $VERSION
+ dram: ${VERSION}
END_VERSIONS
"""
}
diff --git a/modules/local/dram/download_dram_db.nf b/modules/local/dram/download_dram_db.nf
new file mode 100644
index 0000000..55eb2b7
--- /dev/null
+++ b/modules/local/dram/download_dram_db.nf
@@ -0,0 +1,45 @@
+process DOWNLOAD_DRAM_DB {
+
+ container "${workflow.containerEngine in ['singularity', 'apptainer']
+ ? 'https://depot.galaxyproject.org/singularity/gnu-wget:1.18--h36e9172_9'
+ : 'biocontainers/gnu-wget:1.18--h36e9172_9'}"
+
+ output:
+ path("dram_dbs/"), emit: dram_db
+
+ script:
+ """
+ mkdir -p dram_dbs
+
+ wget -q --continue "https://raw.githubusercontent.com/WrightonLabCSU/DRAM/v1.5.0/data/amg_database.tsv" -O dram_dbs/amg_database.tsv
+ wget -q --continue "https://raw.githubusercontent.com/WrightonLabCSU/DRAM/v1.5.0/data/etc_module_database.tsv" -O dram_dbs/etc_module_database.tsv
+ wget -q --continue "https://raw.githubusercontent.com/WrightonLabCSU/DRAM/v1.5.0/data/function_heatmap_form.tsv" -O dram_dbs/function_heatmap_form.tsv
+ wget -q --continue "https://raw.githubusercontent.com/WrightonLabCSU/DRAM/v1.5.0/data/genome_summary_form.tsv" -O dram_dbs/genome_summary_form.tsv
+ wget -q --continue "https://raw.githubusercontent.com/WrightonLabCSU/DRAM/v1.5.0/data/module_step_form.tsv" -O dram_dbs/module_step_form.tsv
+ wget -q --continue "https://ftp.ebi.ac.uk/pub/databases/Pfam/current_release/Pfam-A.hmm.dat.gz" -O dram_dbs/Pfam-A.hmm.dat.gz
+
+ echo "Creating the CONFIG file for DRAM distill"
+ cat > dram_dbs/DRAM_CONFIG.json << EOF
+ {
+ "description_db": "None",
+ "kegg": null,
+ "kofam": null,
+ "kofam_ko_list": null,
+ "uniref": null,
+ "pfam": null,
+ "pfam_hmm_dat": null,
+ "dbcan": null,
+ "dbcan_fam_activities": null,
+ "viral": null,
+ "peptidase": null,
+ "vogdb": null,
+ "vog_annotations": null,
+ "genome_summary_form": "/data/genome_summary_form.tsv",
+ "module_step_form": "/data/module_step_form.tsv",
+ "etc_module_database": "/data/etc_module_database.tsv",
+ "function_heatmap_form": "/data/function_heatmap_form.tsv",
+ "amg_database": "/data/amg_database.tsv"
+ }
+ EOF
+ """
+}
diff --git a/modules/local/fastp/main.nf b/modules/local/fastp/main.nf
deleted file mode 100644
index fbf3f74..0000000
--- a/modules/local/fastp/main.nf
+++ /dev/null
@@ -1,82 +0,0 @@
-process FASTP {
- tag "$meta.id"
- label 'process_medium'
-
- conda "${moduleDir}/environment.yml"
- container "${ workflow.containerEngine == 'singularity' && !task.ext.singularity_pull_docker_container ?
- 'https://depot.galaxyproject.org/singularity/fastp:0.23.4--h5f740d0_0' :
- 'biocontainers/fastp:0.23.4--h5f740d0_0' }"
-
- input:
- tuple val(meta), path(reads)
-
- output:
- tuple val(meta), path('*.fastp.fastq.gz') , emit: reads
- tuple val(meta), path('*.json') , emit: json
- tuple val(meta), path('*.html') , emit: html
- tuple val(meta), path('*.log') , emit: log
- path "versions.yml" , emit: versions
-
- when:
- task.ext.when == null || task.ext.when
-
- script:
- def args = task.ext.args ?: ''
- def prefix = task.ext.prefix ?: "${meta.id}"
- // Added soft-links to original fastqs for consistent naming in MultiQC
- if (meta.single_end) {
- """
- [ ! -f ${prefix}.fastq.gz ] && ln -sf $reads ${prefix}.fastq.gz
- fastp \\
- --in1 ${prefix}.fastq.gz \\
- --out1 ${prefix}.fastp.fastq.gz \\
- --thread $task.cpus \\
- --json ${prefix}.fastp.json \\
- --html ${prefix}.fastp.html \\
- $args \\
- 2> >(tee ${prefix}.fastp.log >&2)
-
- cat <<-END_VERSIONS > versions.yml
- "${task.process}":
- fastp: \$(fastp --version 2>&1 | sed -e "s/fastp //g")
- END_VERSIONS
- """
- } else {
- """
- [ ! -f ${prefix}_1.fastq.gz ] && ln -sf ${reads[0]} ${prefix}_1.fastq.gz
- [ ! -f ${prefix}_2.fastq.gz ] && ln -sf ${reads[1]} ${prefix}_2.fastq.gz
- fastp \\
- --in1 ${prefix}_1.fastq.gz \\
- --in2 ${prefix}_2.fastq.gz \\
- --out1 ${prefix}_1.fastp.fastq.gz \\
- --out2 ${prefix}_2.fastp.fastq.gz \\
- --json ${prefix}.fastp.json \\
- --html ${prefix}.fastp.html \\
- --thread $task.cpus \\
- --detect_adapter_for_pe \\
- $args \\
- 2> >(tee ${prefix}.fastp.log >&2)
-
- cat <<-END_VERSIONS > versions.yml
- "${task.process}":
- fastp: \$(fastp --version 2>&1 | sed -e "s/fastp //g")
- END_VERSIONS
- """
- }
-
-
- stub:
- def prefix = task.ext.prefix ?: "${meta.id}"
- def touch_reads = meta.single_end ? "${prefix}.fastp.fastq.gz" : "${prefix}_1.fastp.fastq.gz ${prefix}_2.fastp.fastq.gz"
- """
- touch $touch_reads
- touch "${prefix}.fastp.json"
- touch "${prefix}.fastp.html"
- touch "${prefix}.fastp.log"
-
- cat <<-END_VERSIONS > versions.yml
- "${task.process}":
- fastp: \$(fastp --version 2>&1 | sed -e "s/fastp //g")
- END_VERSIONS
- """
-}
diff --git a/modules/local/fastp/meta.yml b/modules/local/fastp/meta.yml
deleted file mode 100644
index 63260e4..0000000
--- a/modules/local/fastp/meta.yml
+++ /dev/null
@@ -1,57 +0,0 @@
-name: fastp
-description: Perform adapter/quality trimming on sequencing reads
-keywords:
- - trimming
- - quality control
- - fastq
-tools:
- - fastp:
- description: |
- A tool designed to provide fast all-in-one preprocessing for FastQ files. This tool is developed in C++ with multithreading supported to afford high performance.
- documentation: https://github.com/OpenGene/fastp
- doi: 10.1093/bioinformatics/bty560
- licence: ["MIT"]
-input:
- - meta:
- type: map
- description: |
- Groovy Map containing sample information. Use 'single_end: true' to specify single ended or interleaved FASTQs. Use 'single_end: false' for paired-end reads.
- e.g. [ id:'test', single_end:false ]
- - reads:
- type: file
- description: |
- List of input FastQ files of size 1 and 2 for single-end and paired-end data,
- respectively. If you wish to run interleaved paired-end data, supply as single-end data
- but with `--interleaved_in` in your `modules.conf`'s `ext.args` for the module.
-output:
- - meta:
- type: map
- description: |
- Groovy Map containing sample information
- e.g. [ id:'test', single_end:false ]
- - reads:
- type: file
- description: The trimmed/modified/unmerged fastq reads
- pattern: "*fastp.fastq.gz"
- - json:
- type: file
- description: Results in JSON format
- pattern: "*.json"
- - html:
- type: file
- description: Results in HTML format
- pattern: "*.html"
- - log:
- type: file
- description: fastq log file
- pattern: "*.log"
- - versions:
- type: file
- description: File containing software versions
- pattern: "versions.yml"
-authors:
- - "@drpatelh"
- - "@kevinmenden"
-maintainers:
- - "@drpatelh"
- - "@kevinmenden"
diff --git a/modules/local/fastp/environment.yml b/modules/nf-core/fastp/environment.yml
similarity index 76%
rename from modules/local/fastp/environment.yml
rename to modules/nf-core/fastp/environment.yml
index 70389e6..26d4aca 100644
--- a/modules/local/fastp/environment.yml
+++ b/modules/nf-core/fastp/environment.yml
@@ -1,7 +1,5 @@
-name: fastp
channels:
- conda-forge
- bioconda
- - defaults
dependencies:
- bioconda::fastp=0.23.4
diff --git a/modules/nf-core/fastp/main.nf b/modules/nf-core/fastp/main.nf
new file mode 100644
index 0000000..e1b9f56
--- /dev/null
+++ b/modules/nf-core/fastp/main.nf
@@ -0,0 +1,125 @@
+process FASTP {
+ tag "$meta.id"
+ label 'process_medium'
+
+ conda "${moduleDir}/environment.yml"
+ container "${ workflow.containerEngine == 'singularity' && !task.ext.singularity_pull_docker_container ?
+ 'https://depot.galaxyproject.org/singularity/fastp:0.23.4--h5f740d0_0' :
+ 'biocontainers/fastp:0.23.4--h5f740d0_0' }"
+
+ input:
+ tuple val(meta), path(reads)
+ path adapter_fasta
+ val discard_trimmed_pass
+ val save_trimmed_fail
+ val save_merged
+
+ output:
+ tuple val(meta), path('*.fastp.fastq.gz') , optional:true, emit: reads
+ tuple val(meta), path('*.json') , emit: json
+ tuple val(meta), path('*.html') , emit: html
+ tuple val(meta), path('*.log') , emit: log
+ tuple val(meta), path('*.fail.fastq.gz') , optional:true, emit: reads_fail
+ tuple val(meta), path('*.merged.fastq.gz'), optional:true, emit: reads_merged
+ path "versions.yml" , emit: versions
+
+ when:
+ task.ext.when == null || task.ext.when
+
+ script:
+ def args = task.ext.args ?: ''
+ def prefix = task.ext.prefix ?: "${meta.id}"
+ def adapter_list = adapter_fasta ? "--adapter_fasta ${adapter_fasta}" : ""
+ def fail_fastq = save_trimmed_fail && meta.single_end ? "--failed_out ${prefix}.fail.fastq.gz" : save_trimmed_fail && !meta.single_end ? "--failed_out ${prefix}.paired.fail.fastq.gz --unpaired1 ${prefix}_1.fail.fastq.gz --unpaired2 ${prefix}_2.fail.fastq.gz" : ''
+ def out_fq1 = discard_trimmed_pass ?: ( meta.single_end ? "--out1 ${prefix}.fastp.fastq.gz" : "--out1 ${prefix}_1.fastp.fastq.gz" )
+ def out_fq2 = discard_trimmed_pass ?: "--out2 ${prefix}_2.fastp.fastq.gz"
+ // Added soft-links to original fastqs for consistent naming in MultiQC
+ // Use single ended for interleaved. Add --interleaved_in in config.
+ if ( task.ext.args?.contains('--interleaved_in') ) {
+ """
+ [ ! -f ${prefix}.fastq.gz ] && ln -sf $reads ${prefix}.fastq.gz
+
+ fastp \\
+ --stdout \\
+ --in1 ${prefix}.fastq.gz \\
+ --thread $task.cpus \\
+ --json ${prefix}.fastp.json \\
+ --html ${prefix}.fastp.html \\
+ $adapter_list \\
+ $fail_fastq \\
+ $args \\
+ 2> >(tee ${prefix}.fastp.log >&2) \\
+ | gzip -c > ${prefix}.fastp.fastq.gz
+
+ cat <<-END_VERSIONS > versions.yml
+ "${task.process}":
+ fastp: \$(fastp --version 2>&1 | sed -e "s/fastp //g")
+ END_VERSIONS
+ """
+ } else if (meta.single_end) {
+ """
+ [ ! -f ${prefix}.fastq.gz ] && ln -sf $reads ${prefix}.fastq.gz
+
+ fastp \\
+ --in1 ${prefix}.fastq.gz \\
+ $out_fq1 \\
+ --thread $task.cpus \\
+ --json ${prefix}.fastp.json \\
+ --html ${prefix}.fastp.html \\
+ $adapter_list \\
+ $fail_fastq \\
+ $args \\
+ 2> >(tee ${prefix}.fastp.log >&2)
+
+ cat <<-END_VERSIONS > versions.yml
+ "${task.process}":
+ fastp: \$(fastp --version 2>&1 | sed -e "s/fastp //g")
+ END_VERSIONS
+ """
+ } else {
+ def merge_fastq = save_merged ? "-m --merged_out ${prefix}.merged.fastq.gz" : ''
+ """
+ [ ! -f ${prefix}_1.fastq.gz ] && ln -sf ${reads[0]} ${prefix}_1.fastq.gz
+ [ ! -f ${prefix}_2.fastq.gz ] && ln -sf ${reads[1]} ${prefix}_2.fastq.gz
+ fastp \\
+ --in1 ${prefix}_1.fastq.gz \\
+ --in2 ${prefix}_2.fastq.gz \\
+ $out_fq1 \\
+ $out_fq2 \\
+ --json ${prefix}.fastp.json \\
+ --html ${prefix}.fastp.html \\
+ $adapter_list \\
+ $fail_fastq \\
+ $merge_fastq \\
+ --thread $task.cpus \\
+ --detect_adapter_for_pe \\
+ $args \\
+ 2> >(tee ${prefix}.fastp.log >&2)
+
+ cat <<-END_VERSIONS > versions.yml
+ "${task.process}":
+ fastp: \$(fastp --version 2>&1 | sed -e "s/fastp //g")
+ END_VERSIONS
+ """
+ }
+
+ stub:
+ def prefix = task.ext.prefix ?: "${meta.id}"
+ def is_single_output = task.ext.args?.contains('--interleaved_in') || meta.single_end
+ def touch_reads = (discard_trimmed_pass) ? "" : (is_single_output) ? "echo '' | gzip > ${prefix}.fastp.fastq.gz" : "echo '' | gzip > ${prefix}_1.fastp.fastq.gz ; echo '' | gzip > ${prefix}_2.fastp.fastq.gz"
+ def touch_merged = (!is_single_output && save_merged) ? "echo '' | gzip > ${prefix}.merged.fastq.gz" : ""
+ def touch_fail_fastq = (!save_trimmed_fail) ? "" : meta.single_end ? "echo '' | gzip > ${prefix}.fail.fastq.gz" : "echo '' | gzip > ${prefix}.paired.fail.fastq.gz ; echo '' | gzip > ${prefix}_1.fail.fastq.gz ; echo '' | gzip > ${prefix}_2.fail.fastq.gz"
+ """
+ $touch_reads
+ $touch_fail_fastq
+ $touch_merged
+ touch "${prefix}.fastp.json"
+ touch "${prefix}.fastp.html"
+ touch "${prefix}.fastp.log"
+
+ cat <<-END_VERSIONS > versions.yml
+ "${task.process}":
+ fastp: \$(fastp --version 2>&1 | sed -e "s/fastp //g")
+ END_VERSIONS
+ """
+}
diff --git a/modules/nf-core/fastp/meta.yml b/modules/nf-core/fastp/meta.yml
new file mode 100644
index 0000000..159404d
--- /dev/null
+++ b/modules/nf-core/fastp/meta.yml
@@ -0,0 +1,113 @@
+name: fastp
+description: Perform adapter/quality trimming on sequencing reads
+keywords:
+ - trimming
+ - quality control
+ - fastq
+tools:
+ - fastp:
+ description: |
+ A tool designed to provide fast all-in-one preprocessing for FastQ files. This tool is developed in C++ with multithreading supported to afford high performance.
+ documentation: https://github.com/OpenGene/fastp
+ doi: 10.1093/bioinformatics/bty560
+ licence: ["MIT"]
+ identifier: biotools:fastp
+input:
+ - - meta:
+ type: map
+ description: |
+ Groovy Map containing sample information. Use 'single_end: true' to specify single ended or interleaved FASTQs. Use 'single_end: false' for paired-end reads.
+ e.g. [ id:'test', single_end:false ]
+ - reads:
+ type: file
+ description: |
+ List of input FastQ files of size 1 and 2 for single-end and paired-end data,
+ respectively. If you wish to run interleaved paired-end data, supply as single-end data
+ but with `--interleaved_in` in your `modules.conf`'s `ext.args` for the module.
+ - - adapter_fasta:
+ type: file
+ description: File in FASTA format containing possible adapters to remove.
+ pattern: "*.{fasta,fna,fas,fa}"
+ - - discard_trimmed_pass:
+ type: boolean
+ description: Specify true to not write any reads that pass trimming thresholds.
+ | This can be used to use fastp for the output report only.
+ - - save_trimmed_fail:
+ type: boolean
+ description: Specify true to save files that failed to pass trimming thresholds
+ ending in `*.fail.fastq.gz`
+ - - save_merged:
+ type: boolean
+ description: Specify true to save all merged reads to a file ending in `*.merged.fastq.gz`
+output:
+ - reads:
+ - meta:
+ type: map
+ description: |
+ Groovy Map containing sample information
+ e.g. [ id:'test', single_end:false ]
+ - "*.fastp.fastq.gz":
+ type: file
+ description: The trimmed/modified/unmerged fastq reads
+ pattern: "*fastp.fastq.gz"
+ - json:
+ - meta:
+ type: map
+ description: |
+ Groovy Map containing sample information
+ e.g. [ id:'test', single_end:false ]
+ - "*.json":
+ type: file
+ description: Results in JSON format
+ pattern: "*.json"
+ - html:
+ - meta:
+ type: map
+ description: |
+ Groovy Map containing sample information
+ e.g. [ id:'test', single_end:false ]
+ - "*.html":
+ type: file
+ description: Results in HTML format
+ pattern: "*.html"
+ - log:
+ - meta:
+ type: map
+ description: |
+ Groovy Map containing sample information
+ e.g. [ id:'test', single_end:false ]
+ - "*.log":
+ type: file
+ description: fastq log file
+ pattern: "*.log"
+ - reads_fail:
+ - meta:
+ type: map
+ description: |
+ Groovy Map containing sample information
+ e.g. [ id:'test', single_end:false ]
+ - "*.fail.fastq.gz":
+ type: file
+ description: Reads the failed the preprocessing
+ pattern: "*fail.fastq.gz"
+ - reads_merged:
+ - meta:
+ type: map
+ description: |
+ Groovy Map containing sample information
+ e.g. [ id:'test', single_end:false ]
+ - "*.merged.fastq.gz":
+ type: file
+ description: Reads that were successfully merged
+ pattern: "*.{merged.fastq.gz}"
+ - versions:
+ - versions.yml:
+ type: file
+ description: File containing software versions
+ pattern: "versions.yml"
+authors:
+ - "@drpatelh"
+ - "@kevinmenden"
+maintainers:
+ - "@drpatelh"
+ - "@kevinmenden"
diff --git a/modules/nf-core/fastp/tests/main.nf.test b/modules/nf-core/fastp/tests/main.nf.test
new file mode 100644
index 0000000..30dbb8a
--- /dev/null
+++ b/modules/nf-core/fastp/tests/main.nf.test
@@ -0,0 +1,576 @@
+nextflow_process {
+
+ name "Test Process FASTP"
+ script "../main.nf"
+ process "FASTP"
+ tag "modules"
+ tag "modules_nfcore"
+ tag "fastp"
+
+ test("test_fastp_single_end") {
+
+ when {
+
+ process {
+ """
+ input[0] = Channel.of([
+ [ id:'test', single_end:true ],
+ [ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_1.fastq.gz', checkIfExists: true) ]
+ ])
+ input[1] = []
+ input[2] = false
+ input[3] = false
+ input[4] = false
+ """
+ }
+ }
+
+ then {
+ assertAll(
+ { assert process.success },
+ { assert path(process.out.html.get(0).get(1)).getText().contains("single end (151 cycles)") },
+ { assert path(process.out.log.get(0).get(1)).getText().contains("reads passed filter: 99") },
+ { assert snapshot(
+ process.out.json,
+ process.out.reads,
+ process.out.reads_fail,
+ process.out.reads_merged,
+ process.out.versions).match() }
+ )
+ }
+ }
+
+ test("test_fastp_paired_end") {
+
+ when {
+
+ process {
+ """
+ adapter_fasta = []
+ save_trimmed_pass = true
+ save_trimmed_fail = false
+ save_merged = false
+
+ input[0] = Channel.of([
+ [ id:'test', single_end:false ], // meta map
+ [ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_1.fastq.gz', checkIfExists: true),
+ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_2.fastq.gz', checkIfExists: true) ]
+ ])
+ input[1] = []
+ input[2] = false
+ input[3] = false
+ input[4] = false
+ """
+ }
+ }
+
+ then {
+ assertAll(
+ { assert process.success },
+ { assert path(process.out.html.get(0).get(1)).getText().contains("The input has little adapter percentage (~0.000000%), probably it's trimmed before.") },
+ { assert path(process.out.log.get(0).get(1)).getText().contains("Q30 bases: 12281(88.3716%)") },
+ { assert snapshot(
+ process.out.json,
+ process.out.reads,
+ process.out.reads_fail,
+ process.out.reads_merged,
+ process.out.versions).match() }
+ )
+ }
+ }
+
+ test("fastp test_fastp_interleaved") {
+
+ config './nextflow.interleaved.config'
+ when {
+ process {
+ """
+ input[0] = Channel.of([
+ [ id:'test', single_end:true ], // meta map
+ [ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_interleaved.fastq.gz', checkIfExists: true) ]
+ ])
+ input[1] = []
+ input[2] = false
+ input[3] = false
+ input[4] = false
+ """
+ }
+ }
+
+ then {
+ assertAll(
+ { assert process.success },
+ { assert path(process.out.html.get(0).get(1)).getText().contains("paired end (151 cycles + 151 cycles)") },
+ { assert path(process.out.log.get(0).get(1)).getText().contains("reads passed filter: 162") },
+ { assert process.out.reads_fail == [] },
+ { assert process.out.reads_merged == [] },
+ { assert snapshot(
+ process.out.reads,
+ process.out.json,
+ process.out.versions).match() }
+ )
+ }
+ }
+
+ test("test_fastp_single_end_trim_fail") {
+
+ when {
+
+ process {
+ """
+ input[0] = Channel.of([
+ [ id:'test', single_end:true ], // meta map
+ [ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_1.fastq.gz', checkIfExists: true) ]
+ ])
+ input[1] = []
+ input[2] = false
+ input[3] = true
+ input[4] = false
+ """
+ }
+ }
+
+ then {
+ assertAll(
+ { assert process.success },
+ { assert path(process.out.html.get(0).get(1)).getText().contains("single end (151 cycles)") },
+ { assert path(process.out.log.get(0).get(1)).getText().contains("reads passed filter: 99") },
+ { assert snapshot(
+ process.out.json,
+ process.out.reads,
+ process.out.reads_fail,
+ process.out.reads_merged,
+ process.out.versions).match() }
+ )
+ }
+ }
+
+ test("test_fastp_paired_end_trim_fail") {
+
+ config './nextflow.save_failed.config'
+ when {
+ process {
+ """
+ input[0] = Channel.of([
+ [ id:'test', single_end:false ], // meta map
+ [ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_1.fastq.gz', checkIfExists: true),
+ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_2.fastq.gz', checkIfExists: true)]
+ ])
+ input[1] = []
+ input[2] = false
+ input[3] = true
+ input[4] = false
+ """
+ }
+ }
+
+ then {
+ assertAll(
+ { assert process.success },
+ { assert path(process.out.html.get(0).get(1)).getText().contains("The input has little adapter percentage (~0.000000%), probably it's trimmed before.") },
+ { assert path(process.out.log.get(0).get(1)).getText().contains("reads passed filter: 162") },
+ { assert snapshot(
+ process.out.reads,
+ process.out.reads_fail,
+ process.out.reads_merged,
+ process.out.json,
+ process.out.versions).match() }
+ )
+ }
+ }
+
+ test("test_fastp_paired_end_merged") {
+
+ when {
+ process {
+ """
+ input[0] = Channel.of([
+ [ id:'test', single_end:false ], // meta map
+ [ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_1.fastq.gz', checkIfExists: true),
+ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_2.fastq.gz', checkIfExists: true) ]
+ ])
+ input[1] = []
+ input[2] = false
+ input[3] = false
+ input[4] = true
+ """
+ }
+ }
+
+ then {
+ assertAll(
+ { assert process.success },
+ { assert path(process.out.html.get(0).get(1)).getText().contains("The input has little adapter percentage (~0.000000%), probably it's trimmed before.") },
+ { assert path(process.out.log.get(0).get(1)).getText().contains("total reads: 75") },
+ { assert snapshot(
+ process.out.json,
+ process.out.reads,
+ process.out.reads_fail,
+ process.out.reads_merged,
+ process.out.versions).match() },
+ )
+ }
+ }
+
+ test("test_fastp_paired_end_merged_adapterlist") {
+
+ when {
+ process {
+ """
+ input[0] = Channel.of([
+ [ id:'test', single_end:false ], // meta map
+ [ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_1.fastq.gz', checkIfExists: true),
+ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_2.fastq.gz', checkIfExists: true) ]
+ ])
+ input[1] = Channel.of([ file(params.modules_testdata_base_path + 'delete_me/fastp/adapters.fasta', checkIfExists: true) ])
+ input[2] = false
+ input[3] = false
+ input[4] = true
+ """
+ }
+ }
+
+ then {
+ assertAll(
+ { assert process.success },
+ { assert path(process.out.html.get(0).get(1)).getText().contains("") },
+ { assert path(process.out.log.get(0).get(1)).getText().contains("total bases: 13683") },
+ { assert snapshot(
+ process.out.json,
+ process.out.reads,
+ process.out.reads_fail,
+ process.out.reads_merged,
+ process.out.versions).match() }
+ )
+ }
+ }
+
+ test("test_fastp_single_end_qc_only") {
+
+ when {
+ process {
+ """
+ input[0] = Channel.of([
+ [ id:'test', single_end:true ],
+ [ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_1.fastq.gz', checkIfExists: true) ]
+ ])
+ input[1] = []
+ input[2] = true
+ input[3] = false
+ input[4] = false
+ """
+ }
+ }
+
+ then {
+ assertAll(
+ { assert process.success },
+ { assert path(process.out.html.get(0).get(1)).getText().contains("single end (151 cycles)") },
+ { assert path(process.out.log.get(0).get(1)).getText().contains("reads passed filter: 99") },
+ { assert snapshot(
+ process.out.json,
+ process.out.reads,
+ process.out.reads,
+ process.out.reads_fail,
+ process.out.reads_fail,
+ process.out.reads_merged,
+ process.out.reads_merged,
+ process.out.versions).match() }
+ )
+ }
+ }
+
+ test("test_fastp_paired_end_qc_only") {
+
+ when {
+ process {
+ """
+ input[0] = Channel.of([
+ [ id:'test', single_end:false ], // meta map
+ [ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_1.fastq.gz', checkIfExists: true),
+ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_2.fastq.gz', checkIfExists: true) ]
+ ])
+ input[1] = []
+ input[2] = true
+ input[3] = false
+ input[4] = false
+ """
+ }
+ }
+
+ then {
+ assertAll(
+ { assert process.success },
+ { assert path(process.out.html.get(0).get(1)).getText().contains("The input has little adapter percentage (~0.000000%), probably it's trimmed before.") },
+ { assert path(process.out.log.get(0).get(1)).getText().contains("Q30 bases: 12281(88.3716%)") },
+ { assert snapshot(
+ process.out.json,
+ process.out.reads,
+ process.out.reads,
+ process.out.reads_fail,
+ process.out.reads_fail,
+ process.out.reads_merged,
+ process.out.reads_merged,
+ process.out.versions).match() }
+ )
+ }
+ }
+
+ test("test_fastp_single_end - stub") {
+
+ options "-stub"
+
+ when {
+
+ process {
+ """
+ input[0] = Channel.of([
+ [ id:'test', single_end:true ],
+ [ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_1.fastq.gz', checkIfExists: true) ]
+ ])
+ input[1] = []
+ input[2] = false
+ input[3] = false
+ input[4] = false
+ """
+ }
+ }
+
+ then {
+ assertAll(
+ { assert process.success },
+ { assert snapshot(process.out).match() }
+ )
+ }
+ }
+
+ test("test_fastp_paired_end - stub") {
+
+ options "-stub"
+
+ when {
+
+ process {
+ """
+ adapter_fasta = []
+ save_trimmed_pass = true
+ save_trimmed_fail = false
+ save_merged = false
+
+ input[0] = Channel.of([
+ [ id:'test', single_end:false ], // meta map
+ [ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_1.fastq.gz', checkIfExists: true),
+ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_2.fastq.gz', checkIfExists: true) ]
+ ])
+ input[1] = []
+ input[2] = false
+ input[3] = false
+ input[4] = false
+ """
+ }
+ }
+
+ then {
+ assertAll(
+ { assert process.success },
+ { assert snapshot(process.out).match() }
+ )
+ }
+ }
+
+ test("fastp - stub test_fastp_interleaved") {
+
+ options "-stub"
+
+ config './nextflow.interleaved.config'
+ when {
+ process {
+ """
+ input[0] = Channel.of([
+ [ id:'test', single_end:true ], // meta map
+ [ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_interleaved.fastq.gz', checkIfExists: true) ]
+ ])
+ input[1] = []
+ input[2] = false
+ input[3] = false
+ input[4] = false
+ """
+ }
+ }
+
+ then {
+ assertAll(
+ { assert process.success },
+ { assert snapshot(process.out).match() }
+ )
+ }
+ }
+
+ test("test_fastp_single_end_trim_fail - stub") {
+
+ options "-stub"
+
+ when {
+
+ process {
+ """
+ input[0] = Channel.of([
+ [ id:'test', single_end:true ], // meta map
+ [ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_1.fastq.gz', checkIfExists: true) ]
+ ])
+ input[1] = []
+ input[2] = false
+ input[3] = true
+ input[4] = false
+ """
+ }
+ }
+
+ then {
+ assertAll(
+ { assert process.success },
+ { assert snapshot(process.out).match() }
+ )
+ }
+ }
+
+ test("test_fastp_paired_end_trim_fail - stub") {
+
+ options "-stub"
+
+ config './nextflow.save_failed.config'
+ when {
+ process {
+ """
+ input[0] = Channel.of([
+ [ id:'test', single_end:false ], // meta map
+ [ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_1.fastq.gz', checkIfExists: true),
+ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_2.fastq.gz', checkIfExists: true)]
+ ])
+ input[1] = []
+ input[2] = false
+ input[3] = true
+ input[4] = false
+ """
+ }
+ }
+
+ then {
+ assertAll(
+ { assert process.success },
+ { assert snapshot(process.out).match() }
+ )
+ }
+ }
+
+ test("test_fastp_paired_end_merged - stub") {
+
+ options "-stub"
+
+ when {
+ process {
+ """
+ input[0] = Channel.of([
+ [ id:'test', single_end:false ], // meta map
+ [ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_1.fastq.gz', checkIfExists: true),
+ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_2.fastq.gz', checkIfExists: true) ]
+ ])
+ input[1] = []
+ input[2] = false
+ input[3] = false
+ input[4] = true
+ """
+ }
+ }
+
+ then {
+ assertAll(
+ { assert process.success },
+ { assert snapshot(process.out).match() }
+ )
+ }
+ }
+
+ test("test_fastp_paired_end_merged_adapterlist - stub") {
+
+ options "-stub"
+
+ when {
+ process {
+ """
+ input[0] = Channel.of([
+ [ id:'test', single_end:false ], // meta map
+ [ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_1.fastq.gz', checkIfExists: true),
+ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_2.fastq.gz', checkIfExists: true) ]
+ ])
+ input[1] = Channel.of([ file(params.modules_testdata_base_path + 'delete_me/fastp/adapters.fasta', checkIfExists: true) ])
+ input[2] = false
+ input[3] = false
+ input[4] = true
+ """
+ }
+ }
+
+ then {
+ assertAll(
+ { assert process.success },
+ { assert snapshot(process.out).match() }
+ )
+ }
+ }
+
+ test("test_fastp_single_end_qc_only - stub") {
+
+ options "-stub"
+
+ when {
+ process {
+ """
+ input[0] = Channel.of([
+ [ id:'test', single_end:true ],
+ [ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_1.fastq.gz', checkIfExists: true) ]
+ ])
+ input[1] = []
+ input[2] = true
+ input[3] = false
+ input[4] = false
+ """
+ }
+ }
+
+ then {
+ assertAll(
+ { assert process.success },
+ { assert snapshot(process.out).match() }
+ )
+ }
+ }
+
+ test("test_fastp_paired_end_qc_only - stub") {
+
+ options "-stub"
+
+ when {
+ process {
+ """
+ input[0] = Channel.of([
+ [ id:'test', single_end:false ], // meta map
+ [ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_1.fastq.gz', checkIfExists: true),
+ file(params.modules_testdata_base_path + 'genomics/sarscov2/illumina/fastq/test_2.fastq.gz', checkIfExists: true) ]
+ ])
+ input[1] = []
+ input[2] = true
+ input[3] = false
+ input[4] = false
+ """
+ }
+ }
+
+ then {
+ assertAll(
+ { assert process.success },
+ { assert snapshot(process.out).match() }
+ )
+ }
+ }
+}
\ No newline at end of file
diff --git a/modules/nf-core/fastp/tests/main.nf.test.snap b/modules/nf-core/fastp/tests/main.nf.test.snap
new file mode 100644
index 0000000..54be7e4
--- /dev/null
+++ b/modules/nf-core/fastp/tests/main.nf.test.snap
@@ -0,0 +1,1331 @@
+{
+ "test_fastp_single_end_qc_only - stub": {
+ "content": [
+ {
+ "0": [
+
+ ],
+ "1": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.json:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "2": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.html:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "3": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.log:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "4": [
+
+ ],
+ "5": [
+
+ ],
+ "6": [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ],
+ "html": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.html:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "json": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.json:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "log": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.log:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "reads": [
+
+ ],
+ "reads_fail": [
+
+ ],
+ "reads_merged": [
+
+ ],
+ "versions": [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ]
+ }
+ ],
+ "meta": {
+ "nf-test": "0.8.4",
+ "nextflow": "24.04.2"
+ },
+ "timestamp": "2024-07-05T14:31:10.841098"
+ },
+ "test_fastp_paired_end": {
+ "content": [
+ [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.json:md5,1e0f8e27e71728e2b63fc64086be95cd"
+ ]
+ ],
+ [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ [
+ "test_1.fastp.fastq.gz:md5,67b2bbae47f073e05a97a9c2edce23c7",
+ "test_2.fastp.fastq.gz:md5,25cbdca08e2083dbd4f0502de6b62f39"
+ ]
+ ]
+ ],
+ [
+
+ ],
+ [
+
+ ],
+ [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ]
+ ],
+ "meta": {
+ "nf-test": "0.8.4",
+ "nextflow": "24.04.2"
+ },
+ "timestamp": "2024-07-05T13:43:28.665779"
+ },
+ "test_fastp_paired_end_merged_adapterlist": {
+ "content": [
+ [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.json:md5,5914ca3f21ce162123a824e33e8564f6"
+ ]
+ ],
+ [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ [
+ "test_1.fastp.fastq.gz:md5,54b726a55e992a869fd3fa778afe1672",
+ "test_2.fastp.fastq.gz:md5,29d3b33b869f7b63417b8ff07bb128ba"
+ ]
+ ]
+ ],
+ [
+
+ ],
+ [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.merged.fastq.gz:md5,c873bb1ab3fa859dcc47306465e749d5"
+ ]
+ ],
+ [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ]
+ ],
+ "meta": {
+ "nf-test": "0.8.4",
+ "nextflow": "24.04.2"
+ },
+ "timestamp": "2024-07-05T13:44:18.210375"
+ },
+ "test_fastp_single_end_qc_only": {
+ "content": [
+ [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.json:md5,5cc5f01e449309e0e689ed6f51a2294a"
+ ]
+ ],
+ [
+
+ ],
+ [
+
+ ],
+ [
+
+ ],
+ [
+
+ ],
+ [
+
+ ],
+ [
+
+ ],
+ [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ]
+ ],
+ "meta": {
+ "nf-test": "0.8.4",
+ "nextflow": "24.04.2"
+ },
+ "timestamp": "2024-07-05T13:44:27.380974"
+ },
+ "test_fastp_paired_end_trim_fail": {
+ "content": [
+ [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ [
+ "test_1.fastp.fastq.gz:md5,6ff32a64c5188b9a9192be1398c262c7",
+ "test_2.fastp.fastq.gz:md5,db0cb7c9977e94ac2b4b446ebd017a8a"
+ ]
+ ]
+ ],
+ [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ [
+ "test.paired.fail.fastq.gz:md5,409b687c734cedd7a1fec14d316e1366",
+ "test_1.fail.fastq.gz:md5,4f273cf3159c13f79e8ffae12f5661f6",
+ "test_2.fail.fastq.gz:md5,f97b9edefb5649aab661fbc9e71fc995"
+ ]
+ ]
+ ],
+ [
+
+ ],
+ [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.json:md5,4c3268ddb50ea5b33125984776aa3519"
+ ]
+ ],
+ [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ]
+ ],
+ "meta": {
+ "nf-test": "0.8.4",
+ "nextflow": "24.04.2"
+ },
+ "timestamp": "2024-07-05T13:43:58.749589"
+ },
+ "fastp - stub test_fastp_interleaved": {
+ "content": [
+ {
+ "0": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ],
+ "1": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.json:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "2": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.html:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "3": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.log:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "4": [
+
+ ],
+ "5": [
+
+ ],
+ "6": [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ],
+ "html": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.html:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "json": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.json:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "log": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.log:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "reads": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ],
+ "reads_fail": [
+
+ ],
+ "reads_merged": [
+
+ ],
+ "versions": [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ]
+ }
+ ],
+ "meta": {
+ "nf-test": "0.8.4",
+ "nextflow": "24.04.2"
+ },
+ "timestamp": "2024-07-05T13:50:00.270029"
+ },
+ "test_fastp_single_end - stub": {
+ "content": [
+ {
+ "0": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ],
+ "1": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.json:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "2": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.html:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "3": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.log:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "4": [
+
+ ],
+ "5": [
+
+ ],
+ "6": [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ],
+ "html": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.html:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "json": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.json:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "log": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.log:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "reads": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ],
+ "reads_fail": [
+
+ ],
+ "reads_merged": [
+
+ ],
+ "versions": [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ]
+ }
+ ],
+ "meta": {
+ "nf-test": "0.8.4",
+ "nextflow": "24.04.2"
+ },
+ "timestamp": "2024-07-05T13:49:42.502789"
+ },
+ "test_fastp_paired_end_merged_adapterlist - stub": {
+ "content": [
+ {
+ "0": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ [
+ "test_1.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940",
+ "test_2.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ]
+ ],
+ "1": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.json:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "2": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.html:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "3": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.log:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "4": [
+
+ ],
+ "5": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.merged.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ],
+ "6": [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ],
+ "html": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.html:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "json": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.json:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "log": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.log:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "reads": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ [
+ "test_1.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940",
+ "test_2.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ]
+ ],
+ "reads_fail": [
+
+ ],
+ "reads_merged": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.merged.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ],
+ "versions": [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ]
+ }
+ ],
+ "meta": {
+ "nf-test": "0.8.4",
+ "nextflow": "24.04.2"
+ },
+ "timestamp": "2024-07-05T13:54:53.458252"
+ },
+ "test_fastp_paired_end_merged - stub": {
+ "content": [
+ {
+ "0": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ [
+ "test_1.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940",
+ "test_2.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ]
+ ],
+ "1": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.json:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "2": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.html:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "3": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.log:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "4": [
+
+ ],
+ "5": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.merged.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ],
+ "6": [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ],
+ "html": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.html:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "json": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.json:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "log": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.log:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "reads": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ [
+ "test_1.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940",
+ "test_2.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ]
+ ],
+ "reads_fail": [
+
+ ],
+ "reads_merged": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.merged.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ],
+ "versions": [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ]
+ }
+ ],
+ "meta": {
+ "nf-test": "0.8.4",
+ "nextflow": "24.04.2"
+ },
+ "timestamp": "2024-07-05T13:50:27.689379"
+ },
+ "test_fastp_paired_end_merged": {
+ "content": [
+ [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.json:md5,b712fd68ed0322f4bec49ff2a5237fcc"
+ ]
+ ],
+ [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ [
+ "test_1.fastp.fastq.gz:md5,54b726a55e992a869fd3fa778afe1672",
+ "test_2.fastp.fastq.gz:md5,29d3b33b869f7b63417b8ff07bb128ba"
+ ]
+ ]
+ ],
+ [
+
+ ],
+ [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.merged.fastq.gz:md5,c873bb1ab3fa859dcc47306465e749d5"
+ ]
+ ],
+ [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ]
+ ],
+ "meta": {
+ "nf-test": "0.8.4",
+ "nextflow": "24.04.2"
+ },
+ "timestamp": "2024-07-05T13:44:08.68476"
+ },
+ "test_fastp_paired_end - stub": {
+ "content": [
+ {
+ "0": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ [
+ "test_1.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940",
+ "test_2.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ]
+ ],
+ "1": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.json:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "2": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.html:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "3": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.log:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "4": [
+
+ ],
+ "5": [
+
+ ],
+ "6": [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ],
+ "html": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.html:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "json": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.json:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "log": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.log:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "reads": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ [
+ "test_1.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940",
+ "test_2.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ]
+ ],
+ "reads_fail": [
+
+ ],
+ "reads_merged": [
+
+ ],
+ "versions": [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ]
+ }
+ ],
+ "meta": {
+ "nf-test": "0.8.4",
+ "nextflow": "24.04.2"
+ },
+ "timestamp": "2024-07-05T13:49:51.679221"
+ },
+ "test_fastp_single_end": {
+ "content": [
+ [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.json:md5,c852d7a6dba5819e4ac8d9673bedcacc"
+ ]
+ ],
+ [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.fastq.gz:md5,67b2bbae47f073e05a97a9c2edce23c7"
+ ]
+ ],
+ [
+
+ ],
+ [
+
+ ],
+ [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ]
+ ],
+ "meta": {
+ "nf-test": "0.8.4",
+ "nextflow": "24.04.2"
+ },
+ "timestamp": "2024-07-05T13:43:18.834322"
+ },
+ "test_fastp_single_end_trim_fail - stub": {
+ "content": [
+ {
+ "0": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ],
+ "1": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.json:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "2": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.html:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "3": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.log:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "4": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fail.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ],
+ "5": [
+
+ ],
+ "6": [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ],
+ "html": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.html:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "json": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.json:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "log": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.log:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "reads": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ],
+ "reads_fail": [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fail.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ],
+ "reads_merged": [
+
+ ],
+ "versions": [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ]
+ }
+ ],
+ "meta": {
+ "nf-test": "0.8.4",
+ "nextflow": "24.04.2"
+ },
+ "timestamp": "2024-07-05T14:05:36.898142"
+ },
+ "test_fastp_paired_end_trim_fail - stub": {
+ "content": [
+ {
+ "0": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ [
+ "test_1.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940",
+ "test_2.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ]
+ ],
+ "1": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.json:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "2": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.html:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "3": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.log:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "4": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ [
+ "test.paired.fail.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940",
+ "test_1.fail.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940",
+ "test_2.fail.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ]
+ ],
+ "5": [
+
+ ],
+ "6": [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ],
+ "html": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.html:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "json": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.json:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "log": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.log:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "reads": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ [
+ "test_1.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940",
+ "test_2.fastp.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ]
+ ],
+ "reads_fail": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ [
+ "test.paired.fail.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940",
+ "test_1.fail.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940",
+ "test_2.fail.fastq.gz:md5,68b329da9893e34099c7d8ad5cb9c940"
+ ]
+ ]
+ ],
+ "reads_merged": [
+
+ ],
+ "versions": [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ]
+ }
+ ],
+ "meta": {
+ "nf-test": "0.8.4",
+ "nextflow": "24.04.2"
+ },
+ "timestamp": "2024-07-05T14:05:49.212847"
+ },
+ "fastp test_fastp_interleaved": {
+ "content": [
+ [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.fastq.gz:md5,217d62dc13a23e92513a1bd8e1bcea39"
+ ]
+ ],
+ [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.json:md5,b24e0624df5cc0b11cd5ba21b726fb22"
+ ]
+ ],
+ [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ]
+ ],
+ "meta": {
+ "nf-test": "0.8.4",
+ "nextflow": "24.04.2"
+ },
+ "timestamp": "2024-07-05T13:43:38.910832"
+ },
+ "test_fastp_single_end_trim_fail": {
+ "content": [
+ [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.json:md5,9a7ee180f000e8d00c7fb67f06293eb5"
+ ]
+ ],
+ [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fastp.fastq.gz:md5,67b2bbae47f073e05a97a9c2edce23c7"
+ ]
+ ],
+ [
+ [
+ {
+ "id": "test",
+ "single_end": true
+ },
+ "test.fail.fastq.gz:md5,3e4aaadb66a5b8fc9b881bf39c227abd"
+ ]
+ ],
+ [
+
+ ],
+ [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ]
+ ],
+ "meta": {
+ "nf-test": "0.8.4",
+ "nextflow": "24.04.2"
+ },
+ "timestamp": "2024-07-05T13:43:48.22378"
+ },
+ "test_fastp_paired_end_qc_only": {
+ "content": [
+ [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.json:md5,623064a45912dac6f2b64e3f2e9901df"
+ ]
+ ],
+ [
+
+ ],
+ [
+
+ ],
+ [
+
+ ],
+ [
+
+ ],
+ [
+
+ ],
+ [
+
+ ],
+ [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ]
+ ],
+ "meta": {
+ "nf-test": "0.8.4",
+ "nextflow": "24.04.2"
+ },
+ "timestamp": "2024-07-05T13:44:36.334938"
+ },
+ "test_fastp_paired_end_qc_only - stub": {
+ "content": [
+ {
+ "0": [
+
+ ],
+ "1": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.json:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "2": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.html:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "3": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.log:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "4": [
+
+ ],
+ "5": [
+
+ ],
+ "6": [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ],
+ "html": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.html:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "json": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.json:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "log": [
+ [
+ {
+ "id": "test",
+ "single_end": false
+ },
+ "test.fastp.log:md5,d41d8cd98f00b204e9800998ecf8427e"
+ ]
+ ],
+ "reads": [
+
+ ],
+ "reads_fail": [
+
+ ],
+ "reads_merged": [
+
+ ],
+ "versions": [
+ "versions.yml:md5,48ffc994212fb1fc9f83a74fa69c9f02"
+ ]
+ }
+ ],
+ "meta": {
+ "nf-test": "0.8.4",
+ "nextflow": "24.04.2"
+ },
+ "timestamp": "2024-07-05T14:31:27.096468"
+ }
+}
\ No newline at end of file
diff --git a/modules/nf-core/fastp/tests/nextflow.interleaved.config b/modules/nf-core/fastp/tests/nextflow.interleaved.config
new file mode 100644
index 0000000..4be8dbd
--- /dev/null
+++ b/modules/nf-core/fastp/tests/nextflow.interleaved.config
@@ -0,0 +1,5 @@
+process {
+ withName: FASTP {
+ ext.args = "--interleaved_in -e 30"
+ }
+}
diff --git a/modules/nf-core/fastp/tests/nextflow.save_failed.config b/modules/nf-core/fastp/tests/nextflow.save_failed.config
new file mode 100644
index 0000000..53b61b0
--- /dev/null
+++ b/modules/nf-core/fastp/tests/nextflow.save_failed.config
@@ -0,0 +1,5 @@
+process {
+ withName: FASTP {
+ ext.args = "-e 30"
+ }
+}
diff --git a/modules/nf-core/fastp/tests/tags.yml b/modules/nf-core/fastp/tests/tags.yml
new file mode 100644
index 0000000..c1afcce
--- /dev/null
+++ b/modules/nf-core/fastp/tests/tags.yml
@@ -0,0 +1,2 @@
+fastp:
+ - modules/nf-core/fastp/**
diff --git a/nextflow.config b/nextflow.config
index c2fc840..3f94af7 100644
--- a/nextflow.config
+++ b/nextflow.config
@@ -7,23 +7,30 @@
*/
manifest {
- nextflowVersion = '!>=23.04.0'
- mainScript = "main.nf"
+ name = 'ebi-metagenomics/shallowmapping'
+ author = """Microbiome Informatics team"""
+ homePage = 'https://github.com/ebi-metagenomics/shallowmapping'
+ description = """Shallow-shotgun mapping pipeline"""
+ mainScript = 'main.nf'
+ nextflowVersion = '!>=24.04.0'
+ version = '1.1.0'
+ doi = ''
}
+
plugins {
- id 'nf-validation'
+ id 'nf-validation@1.1.4'
}
params {
// Input options
input = ""
biome = ""
- outdir = 'results'
+ outdir = "results"
+ reference_dbs = "dbs"
+ decontamination_indexes = "decontamination_indexes"
run_bwa = false
core_mode = false
- shallow_dbs_path = ""
- decont_reference_paths = ""
/*
* Mapping tool options:
@@ -87,37 +94,89 @@ includeConfig 'conf/base.config'
includeConfig 'conf/modules.config'
profiles {
+ debug {
+ dumpHashes = true
+ process.beforeScript = 'echo $HOSTNAME'
+ cleanup = false
+ nextflow.enable.configProcessNamesValidation = true
+ }
+ docker {
+ docker.enabled = true
+ conda.enabled = false
+ singularity.enabled = false
+ podman.enabled = false
+ shifter.enabled = false
+ charliecloud.enabled = false
+ apptainer.enabled = false
+ docker.runOptions = '-u $(id -u):$(id -g)'
+ }
+ arm {
+ docker.runOptions = '-u $(id -u):$(id -g) --platform=linux/amd64'
+ }
singularity {
- enabled = true
- autoMounts = true
- cacheDir = params.singularity_cachedir
- registry = 'quay.io'
+ singularity.enabled = true
+ singularity.autoMounts = true
+ conda.enabled = false
+ docker.enabled = false
+ podman.enabled = false
+ shifter.enabled = false
+ charliecloud.enabled = false
+ apptainer.enabled = false
+ }
+ podman {
+ podman.enabled = true
+ conda.enabled = false
+ docker.enabled = false
+ singularity.enabled = false
+ shifter.enabled = false
+ charliecloud.enabled = false
+ apptainer.enabled = false
+ }
+ shifter {
+ shifter.enabled = true
+ conda.enabled = false
+ docker.enabled = false
+ singularity.enabled = false
+ podman.enabled = false
+ charliecloud.enabled = false
+ apptainer.enabled = false
+ }
+ charliecloud {
+ charliecloud.enabled = true
+ conda.enabled = false
+ docker.enabled = false
+ singularity.enabled = false
+ podman.enabled = false
+ shifter.enabled = false
+ apptainer.enabled = false
+ }
+ apptainer {
+ apptainer.enabled = true
+ apptainer.autoMounts = true
+ conda.enabled = false
+ docker.enabled = false
+ singularity.enabled = false
+ podman.enabled = false
+ shifter.enabled = false
+ charliecloud.enabled = false
}
-
local {
- docker {
- enabled = true
- autoMounts = true
- registry = 'quay.io'
- userEmulation = true
- runOptions = "--platform linux/x86_64"
+ process {
+ resourceLimits = [
+ cpus: 8,
+ memory: 12.GB,
+ time: 8.h,
+ ]
}
executor {
name = "local"
- cpus = 2
- memory = '1 GB'
}
}
ebi {
includeConfig 'conf/codon.config'
}
test {
- singularity {
- enabled = true
- autoMounts = true
- cacheDir = params.singularity_cachedir
- registry = 'quay.io'
- }
+ includeConfig 'conf/test.config'
}
}
@@ -129,11 +188,6 @@ docker.registry = 'quay.io'
podman.registry = 'quay.io'
singularity.registry = 'quay.io'
-// Nextflow plugins
-plugins {
- id 'nf-validation' // Validation of pipeline parameters and creation of an input channel from a sample sheet
-}
-
// Export these variables to prevent local Python/R libraries from conflicting with those in the container
// The JULIA depot path has been adjusted to a fixed path `/usr/local/share/julia` that needs to be used for packages in the container.
// See https://apeltzer.github.io/post/03-julia-lang-nextflow/ for details on that. Once we have a common agreement on where to keep Julia packages, this is adjustable.
@@ -165,48 +219,3 @@ dag {
enabled = true
file = "${params.outdir}/pipeline_info/pipeline_dag_${trace_timestamp}.html"
}
-
-manifest {
- name = 'ebi-metagenomics/shallowmapping'
- author = """Microbiome Informatics team"""
- homePage = 'https://github.com/ebi-metagenomics/shallowmapping'
- description = """Shallow-shotgun mapping pipeline"""
- mainScript = 'main.nf'
- nextflowVersion = '!>=23.04.0'
- version = '1.1.0'
- doi = ''
-}
-
-
-// Function to ensure that resource requirements don't go beyond
-// a maximum limit
-def check_max(obj, type) {
- if (type == 'memory') {
- try {
- if (obj.compareTo(params.max_memory as nextflow.util.MemoryUnit) == 1)
- return params.max_memory as nextflow.util.MemoryUnit
- else
- return obj
- } catch (all) {
- println " ### ERROR ### Max memory '${params.max_memory}' is not valid! Using default value: $obj"
- return obj
- }
- } else if (type == 'time') {
- try {
- if (obj.compareTo(params.max_time as nextflow.util.Duration) == 1)
- return params.max_time as nextflow.util.Duration
- else
- return obj
- } catch (all) {
- println " ### ERROR ### Max time '${params.max_time}' is not valid! Using default value: $obj"
- return obj
- }
- } else if (type == 'cpus') {
- try {
- return Math.min( obj, params.max_cpus as int )
- } catch (all) {
- println " ### ERROR ### Max cpus '${params.max_cpus}' is not valid! Using default value: $obj"
- return obj
- }
- }
-}
diff --git a/nextflow_schema.json b/nextflow_schema.json
index 6c7dd93..06eb0cf 100644
--- a/nextflow_schema.json
+++ b/nextflow_schema.json
@@ -1,5 +1,5 @@
{
- "$schema": "http://json-schema.org/draft-07/schema",
+ "$schema": "https://json-schema.org/draft-07/schema",
"$id": "https://raw.githubusercontent.com/ebi-metagenomics/shallowmapping/master/nextflow_schema.json",
"title": "ebi-metagenomics/shallowmapping pipeline parameters",
"description": "Shallow-shotgun mapping pipeline",
@@ -26,7 +26,20 @@
"biome": {
"type": "string",
"description": "This can be any of the MGnify catalogues for which shallow-mapping databases are currently available",
- "enum": ["chicken-gut-v1-0-1", "mouse-gut-v1-0", "human-gut-v2-0-2"]
+ "enum": [
+ "chicken-gut-v1.0.1",
+ "cow-rumen-v1.0.1",
+ "human-gut-v2.0.2",
+ "human-oral-v1.0.1",
+ "human-vaginal-v1.0",
+ "honeybee-gut-v1.0.1",
+ "marine-v2.0",
+ "mouse-gut-v1.0",
+ "non-model-fish-gut-v2.0",
+ "pig-gut-v1.0",
+ "sheep-rumen-v1.0",
+ "zebrafish-fecal-v1.0"
+ ]
},
"run_bwa": {
"type": "boolean",
@@ -60,23 +73,23 @@
}
},
"reference_databases": {
- "title": "Reference databases indexed",
+ "title": "Reference databases",
"type": "object",
"fa_icon": "fas fa-database",
"description": "The first time you run the pipeline you need to put available indexed databases for the decontamination step, MGnify genomes catalogue tables, and some external tables for DRAM visuals generation. MGnify host most of the databases and setting up can be done in a single step by providing the location for decontamination and MGnify databases where the new files will be added. The directories have to already exists. Please provide full paths.",
- "required": ["shallow_dbs_path", "decont_reference_paths"],
+ "required": ["reference_dbs", "decontamination_indexes"],
"properties": {
- "shallow_dbs_path": {
+ "reference_dbs": {
"type": "string",
"format": "directory-path",
"fa_icon": "fas fa-folder",
- "description": "Central location for the MGnify Genomes catalogue reference."
+ "description": "Path to the folder containing the pre-processed MGnify genomes databases and the DRAM Distill database. If the folder is empty or does not exist, the pipeline will automatically download the required databases and cache them for future use. Example: /path/to/reference_dbs."
},
- "decont_reference_paths": {
+ "decontamination_indexes": {
"type": "string",
- "fa_icon": "fas fa-folder",
"format": "directory-path",
- "description": "Central location of reference genomes for decontamination. Other bwamem2 databases can exist here."
+ "fa_icon": "fas fa-folder",
+ "description": "Path to the folder containing the BWAMEM2 indexes used for cleaning and decontaminating the reads. Ensure that the indexes are properly formatted. Example: /path/to/decontamination_indexes."
}
}
},
diff --git a/nf-test.config b/nf-test.config
index 870799d..0567df1 100644
--- a/nf-test.config
+++ b/nf-test.config
@@ -3,6 +3,6 @@ config {
testsDir "tests"
workDir ".nf-test"
configFile "tests/nextflow.config"
- profile ""
+ profile "test"
}
diff --git a/subworkflows/download_references.nf b/subworkflows/download_references.nf
new file mode 100644
index 0000000..462c297
--- /dev/null
+++ b/subworkflows/download_references.nf
@@ -0,0 +1,71 @@
+include { DOWNLOAD_DRAM_DB } from "../modules/local/dram/download_dram_db"
+include { DOWNLOAD_HUMAN_PHIX_BWAMEM2_INDEX } from '../modules/local/download_human_phix_bwamem2_index'
+include { DOWNLOAD_MGNIFY_GENOMES_REFERENCE_DBS } from "../modules/local/download_mgnify_genomes_reference_dbs"
+
+workflow DOWNLOAD_REFERENCES {
+ take:
+ biome
+ bwamem2_mode
+
+ main:
+ dram_dbs = Channel.empty()
+ biome_sourmash_db = Channel.empty()
+ biome_genomes_metadata = Channel.empty()
+ biome_bwa_db = Channel.empty()
+ biome_pangenome_functional_anns_db = Channel.empty()
+ biome_kegg_completeness_db = Channel.empty()
+ human_phix_index = Channel.empty()
+
+ dram_dbs_dir = file("${params.reference_dbs}/dram_dbs")
+
+ biome_folder = file("${params.reference_dbs}/${biome}")
+
+ biome_sourmash_db_file = file("${params.reference_dbs}/${biome}/sourmash_species_representatives_k21.sbt.zip")
+ biome_genomes_metadata_file = file("${params.reference_dbs}/${biome}/genomes-all_metadata.tsv")
+ biome_bwa_db_files = file("${params.reference_dbs}/${biome}/bwa_reps.*")
+ biome_pangenome_functional_anns_db_dir = file("${params.reference_dbs}/${biome}/functional_profiles_DB/")
+ biome_kegg_completeness_db_dir = file("${params.reference_dbs}/${biome}/kegg_completeness_DB/")
+
+ // DRAM databases
+ dram_dbs = dram_dbs_dir.exists()
+ ? dram_dbs_dir
+ : DOWNLOAD_DRAM_DB().dram_db.first()
+
+ // Human PhiX genome used to decontaminate the reads
+ human_phix_index_dir = file("${params.decontamination_indexes}/human_phix*")
+ human_phix_index = human_phix_index_dir.size() > 0
+ ? human_phix_index_dir
+ : DOWNLOAD_HUMAN_PHIX_BWAMEM2_INDEX().out.human_phix_index.first()
+
+ // Check if all required files exist for the biome
+ if ( biome_folder.exists() && biome_sourmash_db_file.exists() && biome_genomes_metadata_file.exists() && biome_pangenome_functional_anns_db_dir.exists() && biome_kegg_completeness_db_dir.exists() && (!bwamem2_mode || biome_bwa_db_files.size() == 0)) {
+ biome_sourmash_db = biome_sourmash_db_file
+ biome_genomes_metadata = biome_genomes_metadata_file
+ biome_pangenome_functional_anns_db = biome_pangenome_functional_anns_db_dir
+ biome_kegg_completeness_db = biome_kegg_completeness_db_dir
+ biome_bwa_db = bwamem2_mode ? biome_bwa_db_files.collect() : Channel.empty()
+ }
+ else {
+ DOWNLOAD_MGNIFY_GENOMES_REFERENCE_DBS(biome, bwamem2_mode)
+
+ biome_sourmash_db = DOWNLOAD_MGNIFY_GENOMES_REFERENCE_DBS.out.sourmash_db.first()
+ biome_genomes_metadata = DOWNLOAD_MGNIFY_GENOMES_REFERENCE_DBS.out.genomes_metadata_tsv.first()
+ biome_pangenome_functional_anns_db = DOWNLOAD_MGNIFY_GENOMES_REFERENCE_DBS.out.pangenome_functional_anns_db.first()
+ biome_kegg_completeness_db = DOWNLOAD_MGNIFY_GENOMES_REFERENCE_DBS.out.kegg_completeness_db.first()
+ biome_bwa_db = bwamem2_mode ? DOWNLOAD_MGNIFY_GENOMES_REFERENCE_DBS.out.bwamem2_index.collect() : Channel.empty()
+ }
+
+ human_phix_index_ch = channel.from( human_phix_index ).collect()
+ .map { db_files ->
+ [[id: "human_phix"], db_files]
+ }
+
+ emit:
+ dram_dbs
+ biome_sourmash_db
+ biome_genomes_metadata
+ biome_bwa_db
+ biome_pangenome_functional_anns_db
+ biome_kegg_completeness_db
+ human_phix_index_ch
+}
diff --git a/tests/README.md b/tests/README.md
new file mode 100644
index 0000000..bc1462d
--- /dev/null
+++ b/tests/README.md
@@ -0,0 +1,5 @@
+# Test dataset
+
+This test dataset consists of several components that have been manually curated for testing purposes, aggressively trimmed down (with the exception of the DRAM Distill db).
+
+The dataset includes a trimmed version of the human-vaginal-v1.0 dataset alongside a reduced human_phiX BWAMem2 index. For the sourmash sketch index, we created a custom for the genome [MGYG000303700](https://www.ebi.ac.uk/metagenomics/api/v1/genomes/MGYG000303700/downloads/MGYG000303700.fna). Additionally, we generated simulated reads using [samtools wgsim](https://sarahpenir.github.io/bioinformatics/Simulating-Sequence-Reads-with-wgsim/).
diff --git a/tests/bwa2mem/human_phix.fasta.0123 b/tests/bwa2mem/human_phix.fasta.0123
new file mode 100644
index 0000000..735b97d
Binary files /dev/null and b/tests/bwa2mem/human_phix.fasta.0123 differ
diff --git a/tests/bwa2mem/human_phix.fasta.amb b/tests/bwa2mem/human_phix.fasta.amb
new file mode 100644
index 0000000..86163d7
--- /dev/null
+++ b/tests/bwa2mem/human_phix.fasta.amb
@@ -0,0 +1 @@
+5386 1 0
diff --git a/tests/bwa2mem/human_phix.fasta.ann b/tests/bwa2mem/human_phix.fasta.ann
new file mode 100644
index 0000000..0609f48
--- /dev/null
+++ b/tests/bwa2mem/human_phix.fasta.ann
@@ -0,0 +1,3 @@
+5386 1 11
+0 NC_001422.1 Escherichia phage phiX174, complete genome
+0 5386 0
diff --git a/tests/bwa2mem/human_phix.fasta.bwt.2bit.64 b/tests/bwa2mem/human_phix.fasta.bwt.2bit.64
new file mode 100644
index 0000000..f670129
Binary files /dev/null and b/tests/bwa2mem/human_phix.fasta.bwt.2bit.64 differ
diff --git a/tests/bwa2mem/human_phix.fasta.pac b/tests/bwa2mem/human_phix.fasta.pac
new file mode 100644
index 0000000..37d823d
Binary files /dev/null and b/tests/bwa2mem/human_phix.fasta.pac differ
diff --git a/tests/data/reads_MGYG000303700_1.fastq.gz b/tests/data/reads_MGYG000303700_1.fastq.gz
new file mode 100644
index 0000000..d3ce007
Binary files /dev/null and b/tests/data/reads_MGYG000303700_1.fastq.gz differ
diff --git a/tests/data/reads_MGYG000303700_2.fastq.gz b/tests/data/reads_MGYG000303700_2.fastq.gz
new file mode 100644
index 0000000..9a38de4
Binary files /dev/null and b/tests/data/reads_MGYG000303700_2.fastq.gz differ
diff --git a/tests/data/test2_R1.fastq.gz b/tests/data/test2_R1.fastq.gz
deleted file mode 100644
index 378078d..0000000
Binary files a/tests/data/test2_R1.fastq.gz and /dev/null differ
diff --git a/tests/data/test2_R2.fastq.gz b/tests/data/test2_R2.fastq.gz
deleted file mode 100644
index 2ce4d1c..0000000
Binary files a/tests/data/test2_R2.fastq.gz and /dev/null differ
diff --git a/tests/nextflow.config b/tests/nextflow.config
index c1761e5..b714956 100644
--- a/tests/nextflow.config
+++ b/tests/nextflow.config
@@ -8,11 +8,3 @@
Config to store CODON DB paths and names
~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
*/
-
-params {
- shallow_dbs_path = "/hps/nobackup/rdf/metagenomics/service-team/ref-dbs/shallow-mapping/"
- decont_reference_paths = "/hps/nobackup/rdf/metagenomics/service-team/ref-dbs/bwa-mem2/"
-}
-
-singularity.enabled = true
-singularity.cacheDir = "/hps/nobackup/rdf/metagenomics/service-team/singularity-cache/"
diff --git a/tests/reference_dbs/dram_dbs/DRAM_CONFIG.json b/tests/reference_dbs/dram_dbs/DRAM_CONFIG.json
new file mode 100644
index 0000000..088a724
--- /dev/null
+++ b/tests/reference_dbs/dram_dbs/DRAM_CONFIG.json
@@ -0,0 +1,20 @@
+{
+ "description_db": "None",
+ "kegg": null,
+ "kofam": null,
+ "kofam_ko_list": null,
+ "uniref": null,
+ "pfam": null,
+ "pfam_hmm_dat": null,
+ "dbcan": null,
+ "dbcan_fam_activities": null,
+ "viral": null,
+ "peptidase": null,
+ "vogdb": null,
+ "vog_annotations": null,
+ "genome_summary_form": "/data/genome_summary_form.tsv",
+ "module_step_form": "/data/module_step_form.tsv",
+ "etc_module_database": "/data/etc_module_database.tsv",
+ "function_heatmap_form": "/data/function_heatmap_form.tsv",
+ "amg_database": "/data/amg_database.tsv"
+}
diff --git a/tests/reference_dbs/dram_dbs/Pfam-A.hmm.dat.gz b/tests/reference_dbs/dram_dbs/Pfam-A.hmm.dat.gz
new file mode 100644
index 0000000..f317abc
Binary files /dev/null and b/tests/reference_dbs/dram_dbs/Pfam-A.hmm.dat.gz differ
diff --git a/tests/reference_dbs/dram_dbs/amg_database.tsv b/tests/reference_dbs/dram_dbs/amg_database.tsv
new file mode 100644
index 0000000..42b93ea
--- /dev/null
+++ b/tests/reference_dbs/dram_dbs/amg_database.tsv
@@ -0,0 +1,280 @@
+KO EC PFAM gene module metabolism reference verified
+K00616 EC:2.2.1.2 talC; transaldolase M00007 M Thompson et al. 2011 TRUE
+K00036 EC:1.1.1.49; EC:1.1.1.363; EC:1.1.1.388 zwf; glucose-6-phosphate 1-dehydrogenase M00006 M Thompson et al. 2011 TRUE
+K19243 EC:1.1.1.49; EC:1.1.1.363; EC:1.1.1.388 zwf; glucose-6-phosphate 1-dehydrogenase M00006 M Thompson et al. 2011 TRUE
+K00033 EC:1.1.1.44; EC:1.1.1.343 gnd; 6-phosphogluconate dehydrogenase M00004 M Thompson et al. 2011 TRUE
+K02703 EC:1.10.3.9 psbA; photosystem II reaction center D1 protein M00161 M Clokie et al. 2006; Sullivan et al. 2005; Lindell et al. 2004; Lindell et al. 2005; Mann et al. 2003 TRUE
+K02706 EC:1.10.3.9 psbD; photosystem II reaction center D2 protein M00161 M Clokie et al. 2006; Sullivan et al. 2005; Lindell et al. 2004; Mann et al. 2003 TRUE
+ PF00504 hlip; high-light inducible protein M00161 Lindell et al. 2004; Lindell et al. 2005; Sullivan et al. 2005 TRUE
+K02040 PF01384; PF10032 pstS; phosphate transport system substrate-binding protein M Zeng et al. 2012; Sullivan et al. 2005 TRUE
+ PF02672 cp12, calvin cycle protein inhibitor M00006 Thompson et al. 2011 TRUE
+K00525 EC:1.17.4.1 PF00317; PF02867; PF03477 nrdA/nrdB; ribonucleotide reductase (RNR) M00053 Thompson et al. 2011; Sullivan et al. 2005 TRUE
+K06217 PF02562 phoH; phosphate starvation-inducible protein Zeng et al. 2012; Sullivan et al. 2005 FALSE
+K01077 EC:3.1.3.1 phoA; alkaline phosphatase M00126 Zeng et al. 2012 TRUE
+K05383 PF06206 cpeT; phycoerythrin biosynthesis gene M00161 Doron et al. 2016; Gasper et al. 2017 TRUE
+K02639 petE; ferredoxin M00161 M Sullivan et al. 2005; Doron et al. 2016 TRUE
+K02639 petF; ferredoxin M00161 M Sullivan et al. 2005 FALSE
+K10946 EC:1.14.18.3 amoC; ammonia monooxygenase c M00174 M Roux et al. 2016; Ahlgren et al. 2018 FALSE
+K00058 PF00389 D-isomer specific 2-hydroxyacid dehydrogenase, catalytic domain M Roux et al. 2016 FALSE
+K00058 PF02826 D-isomer specific 2-hydroxyacid dehydrogenase, NAD binding domain M Roux et al. 2016 FALSE
+ PF10014 2OG-Fe dioxygenase M Roux et al. 2016 FALSE
+ PF03171 2OG-Fe(II) oxygenase superfamily M Roux et al. 2016 FALSE
+ PF13532 2OG-Fe(II) oxygenase superfamily M Roux et al. 2016 FALSE
+ PF13640 2OG-Fe(II) oxygenase superfamily M Roux et al. 2016 FALSE
+ PF13661 2OG-Fe(II) oxygenase superfamily M Roux et al. 2016 FALSE
+ PF13759 Putative 2OG-Fe(II) oxygenase M Roux et al. 2016 FALSE
+K23558 EC:1.1.1.418 PF01073 3-beta hydroxysteroid dehydrogenase/isomerase family M Roux et al. 2016 FALSE
+K00022 EC:1.1.1.35 PF02737 3-hydroxyacyl-CoA dehydrogenase, NAD binding domain M Roux et al. 2016 FALSE
+K00033 EC:1.1.1.44; EC:1.1.1.343 PF00393 6-phosphogluconate dehydrogenase, C-terminal domain M Roux et al. 2016 FALSE
+K00132 EC:1.2.1.10 PF09290 Prokaryotic acetaldehyde dehydrogenase, dimerisation M Roux et al. 2016 FALSE
+K01681 EC:4.2.1.3 PF00330 Aconitase family (aconitate hydratase) M Roux et al. 2016 FALSE
+ PF08545 3-Oxoacyl-[acyl-carrier-protein (ACP)] synthase III M Roux et al. 2016 FALSE
+ PF08541 3-Oxoacyl-[acyl-carrier-protein (ACP)] synthase III C terminal M Roux et al. 2016 FALSE
+ PF00441 Acyl-CoA dehydrogenase, C-terminal domain M Roux et al. 2016 FALSE
+ PF02771 Acyl-CoA dehydrogenase, N-terminal domain M Roux et al. 2016 FALSE
+ PF00106 short chain dehydrogenase M Roux et al. 2016 FALSE
+ PF13561 Enoyl-(Acyl carrier protein) reductase M Roux et al. 2016 FALSE
+ PF00171 Aldehyde dehydrogenase family M Roux et al. 2016 FALSE
+ PF00248 Aldo/keto reductase family M Roux et al. 2016 FALSE
+K08964 EC:4.2.1.109 PF00596 Class II Aldolase and Adducin N-terminal domain M Roux et al. 2016 FALSE
+ PF02274 Amidinotransferase M Roux et al. 2016 FALSE
+ PF04909 Amidohydrolase M Roux et al. 2016 FALSE
+ PF07969 Amidohydrolase family M Roux et al. 2016 FALSE
+ PF13594 Amidohydrolase M Roux et al. 2016 FALSE
+ PF00155 Aminotransferase class I and II M Roux et al. 2016 FALSE
+ PF00266 Aminotransferase class-V M Roux et al. 2016 FALSE
+ PF04896 Ammonia monooxygenase/methane monooxygenase, subunit C M Roux et al. 2016 FALSE
+ PF01637 Archaeal ATPase M Roux et al. 2016 FALSE
+ PF00491 Arginase family M Roux et al. 2016 FALSE
+ PF00733 Asparagine synthase M Roux et al. 2016 FALSE
+ PF00119 ATP synthase A chain M Roux et al. 2016 FALSE
+ PF00116 Cytochrome C oxidase subunit II, periplasmic domain M Roux et al. 2016 FALSE
+ PF02633 Creatinine amidohydrolase M Roux et al. 2016 FALSE
+ PF01053 Cys/Met metabolism PLP-dependent enzyme M Roux et al. 2016 FALSE
+ PF00032 Cytochrome b(C-terminal)/b6/petD M Roux et al. 2016 FALSE
+ PF13631 Cytochrome b(N-terminal)/b6/petB M Roux et al. 2016 FALSE
+ PF00034 Cytochrome c M Roux et al. 2016 FALSE
+ PF03264 NapC/NirT cytochrome c family, N-terminal region M Roux et al. 2016 FALSE
+ PF13442 Cytochrome C oxidase, cbb3-type, subunit III M Roux et al. 2016 FALSE
+ PF01474 Class-II DAHP synthetase family M Roux et al. 2016 FALSE
+ PF00926 3,4-dihydroxy-2-butanone 4-phosphate synthase M Roux et al. 2016 FALSE
+ PF04358 DsrC like protein M Roux et al. 2016; Anantharaman et al. 2014 FALSE
+ PF00378 Enoyl-CoA hydratase/isomerase family M Roux et al. 2016 FALSE
+ PF00208 Glutamate/Leucine/Phenylalanine/Valine dehydrogenase M Roux et al. 2016 FALSE
+ PF02812 Glu/Leu/Phe/Val dehydrogenase, dimerisation domain M Roux et al. 2016 FALSE
+ PF00113 Enolase, C-terminal TIM barrel domain M Roux et al. 2016 FALSE
+ PF01116 Fructose-bisphosphate aldolase class-II M Roux et al. 2016 FALSE
+ PF00487 Fatty acid desaturase M Roux et al. 2016 FALSE
+ PF07977 FabA-like domain M Roux et al. 2016 FALSE
+ PF03320 Bacterial fructose-1,6-bisphosphatase, glpX-encoded M Roux et al. 2016 FALSE
+ PF02911 Formyl transferase, C-terminal domain M Roux et al. 2016 FALSE
+ PF00551 Formyl transferase M Roux et al. 2016 FALSE
+ PF02781 Glucose-6-phosphate dehydrogenase, C-terminal domain M Roux et al. 2016 FALSE
+ PF00479 Glucose-6-phosphate dehydrogenase, NAD binding domain M Roux et al. 2016 FALSE
+ PF00310 Glutamine amidotransferases class-II M Roux et al. 2016 FALSE
+ PF02649 Type I GTP cyclohydrolase folE2 M Roux et al. 2016 FALSE
+ PF01597 Glycine cleavage H-protein M Roux et al. 2016 FALSE
+ PF02347 Glycine cleavage system P-protein M Roux et al. 2016 FALSE
+ PF00120 Glutamine synthetase, catalytic domain M Roux et al. 2016 FALSE
+ PF03951 Glutamine synthetase, beta-Grasp domain M Roux et al. 2016 FALSE
+ PF01182 Glucosamine-6-phosphate isomerases/6-phosphogluconolactonase M Roux et al. 2016 FALSE
+ PF00274 Fructose-bisphosphate aldolase class-I M Roux et al. 2016 FALSE
+ PF02800 Glyceraldehyde 3-phosphate dehydrogenase, C-terminal domain M Roux et al. 2016 FALSE
+ PF00044 Glyceraldehyde 3-phosphate dehydrogenase, NAD binding domain M Roux et al. 2016 FALSE
+ PF00977 Histidine biosynthesis protein M Roux et al. 2016 FALSE
+ PF00742 Homoserine dehydrogenase M Roux et al. 2016 FALSE
+ PF00463 Isocitrate lyase family M Roux et al. 2016 FALSE
+ PF02502 Ribose/Galactose Isomerase M Roux et al. 2016 FALSE
+K01809 EC:5.3.1.8 PF01050 manA; mannose-6-phosphate isomerase M Roux et al. 2016; Hurwitz et al. 2015 FALSE
+ PF13714 Phosphoenolpyruvate phosphomutase M Roux et al. 2016 FALSE
+ PF00391 PEP-utilising enzyme, mobile domain M Roux et al. 2016 FALSE
+ PF01293 Phosphoenolpyruvate carboxykinase M Roux et al. 2016 FALSE
+ PF00162 Phosphoglycerate kinase M Roux et al. 2016 FALSE
+ PF00408 Phosphoglucomutase/phosphomannomutase, C-terminal domain M Roux et al. 2016 FALSE
+ PF00343 Carbohydrate phosphorylase M Roux et al. 2016 FALSE
+ PF00124 Photosynthetic reaction centre protein M Roux et al. 2016 FALSE
+ PF03332 Eukaryotic phosphomannomutase M Roux et al. 2016 FALSE
+ PF14100 Methane oxygenase PmoA M Roux et al. 2016 FALSE
+ PF01048 Phosphorylase superfamily M Roux et al. 2016 FALSE
+ PF01619 Proline dehydrogenase M Roux et al. 2016 FALSE
+ PF02666 Phosphatidylserine decarboxylase M Roux et al. 2016 FALSE
+ PF14765 Polyketide synthase dehydratase M Roux et al. 2016 FALSE
+ PF00223 Photosystem I psaA/psaB protein M Roux et al. 2016; Sharon et al. 2011 FALSE
+ PF02531 PsaD M Roux et al. 2016; Sharon et al. 2011 FALSE
+ PF02468 Photosystem II reaction centre N protein (psbN) M Roux et al. 2016; Sharon et al. 2011 FALSE
+ PF02507 Photosystem I reaction centre subunit III M Roux et al. 2016 FALSE
+ PF01701 Photosystem I reaction centre subunit IX / PsaJ M Roux et al. 2016; Sharon et al. 2011 FALSE
+ PF00834 Ribulose-phosphate 3 epimerase family M Roux et al. 2016 FALSE
+ PF00016 Ribulose bisphosphate carboxylase large chain, catalytic domain M Roux et al. 2016 FALSE
+ PF00101 Ribulose bisphosphate carboxylase, small chain M Roux et al. 2016 FALSE
+ PF01118 Semialdehyde dehydrogenase, NAD binding domain M Roux et al. 2016 FALSE
+ PF00464 Serine hydroxymethyltransferase M Roux et al. 2016 FALSE
+ PF13501 Sulfur oxidation protein SoxY M Roux et al. 2016 FALSE
+ PF08770 Sulphur oxidation protein SoxZ M Roux et al. 2016 FALSE
+ PF00108 Thiolase, N-terminal domain M Roux et al. 2016 FALSE
+ PF00923 Transaldolase M Roux et al. 2016 FALSE
+ PF02779 Transketolase, pyrimidine binding domain M Roux et al. 2016 FALSE
+ PF02780 Transketolase, C-terminal domain M Roux et al. 2016 FALSE
+ PF00456 Transketolase, thiamine diphosphate binding domain M Roux et al. 2016 FALSE
+ PF01654 Bacterial Cytochrome Ubiquinol Oxidase M Roux et al. 2016 FALSE
+ PF01817 Chorismate mutase type II M Roux et al. 2016 FALSE
+ PF00135 Carboxylesterase family M Roux et al. 2016 FALSE
+ PF00701 Dihydrodipicolinate synthetase family M Roux et al. 2016 FALSE
+ PF01761 3-dehydroquinate synthase M Roux et al. 2016 FALSE
+ PF00676 Dehydrogenase E1 component M Roux et al. 2016 FALSE
+ PF06339 Ectoine synthase M Roux et al. 2016 FALSE
+ PF13950 galE; UDP-glucose 4-epimerase C-term subunit M Roux et al. 2016; Hurwitz et al. 2015 FALSE
+ PF04800 ETC complex I subunit conserved region M Roux et al. 2016 FALSE
+ PF01557 Fumarylacetoacetate (FAA) hydrolase family M Roux et al. 2016 FALSE
+ PF05013 N-formylglutamate amidohydrolase M Roux et al. 2016 FALSE
+ PF01070 FMN-dependent dehydrogenase M Roux et al. 2016 FALSE
+ PF03328 HpcH/HpaI aldolase/citrate lyase family M Roux et al. 2016 FALSE
+ PF00109 Beta-ketoacyl synthase, N-terminal domain M Roux et al. 2016 FALSE
+ PF02801 Beta-ketoacyl synthase, C-terminal domain M Roux et al. 2016 FALSE
+ PF01451 Low molecular weight phosphotyrosine protein phosphatase M Roux et al. 2016 FALSE
+ PF03331 UDP-3-O-acyl N-acetylglycosamine deacetylase M Roux et al. 2016 FALSE
+ PF02401 LytB protein M Roux et al. 2016 FALSE
+ PF06967 Mo-dependent nitrogenase C-terminus M Roux et al. 2016 FALSE
+ PF01188 Mandelate racemase / muconate lactonizing enzyme, C-terminal domain M Roux et al. 2016 FALSE
+ PF03446 NAD binding domain of 6-phosphogluconate dehydrogenase M Roux et al. 2016 FALSE
+ PF02423 Ornithine cyclodeaminase/mu-crystallin family M Roux et al. 2016 FALSE
+ PF02729 Aspartate/ornithine carbamoyltransferase, carbamoyl-P binding domain M Roux et al. 2016 FALSE
+ PF00361 NADH-Ubiquinone/plastoquinone (complex I), various chains M Roux et al. 2016 FALSE
+ PF05138 Phenylacetic acid catabolic protein M Roux et al. 2016 FALSE
+ PF00291 Pyridoxal-phosphate dependent enzyme M Roux et al. 2016 FALSE
+ PF01503 Phosphoribosyl-ATP pyrophosphohydrolase M Roux et al. 2016 FALSE
+ PF14819 Nitrile reductase, 7-cyano-7-deazaguanine-reductase N-term M Roux et al. 2016 FALSE
+ PF00301 Rubredoxin M Roux et al. 2016 FALSE
+ PF03435 Saccharopine dehydrogenase M Roux et al. 2016 FALSE
+K02233 EC:2.7.8.26 cobS; cobalamin-5-phosphate synthase M00122 Lopez-Perez et al. 2018; Ignacio?Espinoza et al. 2012; Sullivan et al. 2005 FALSE
+K05369 EC:1.3.7.2 pebA; Phycoerythrobilin biosynthesis Sullivan et al. 2005 FALSE
+ ho1; heme biosynthesis Sullivan et al. 2005 FALSE
+K05371 EC:1.3.7.6 pebS; phycoerythrobilin synthase Dammeyer et al. 2008; Ignacio?Espinoza et al. 2012 TRUE
+ EC:1.3.7.5 pcyA; Phycocyanobilin biosynthesis Sullivan et al. 2005 FALSE
+K00762 EC:2.4.2.10 pyrE; Orootate phosphoribosyltransferase Sullivan et al. 2005 FALSE
+K00602 EC:2.1.2.33.5.4.10 purH; phosphoribosyl formyl glycinamide synthase Sullivan et al. 2005 FALSE
+K01952 EC:6.3.5.3 purL; phosphoribosyl formyl glycinamide cyclo-ligase Sullivan et al. 2005 FALSE
+K01933 EC:6.3.3.1 purM;AICARFT/IMPCHase bienzyme Sullivan et al. 2005 FALSE
+K01492 EC:2.1.2.2; EC:2.1.2.3 purN; phophoribosyl glycinamide formyltransferase Sullivan et al. 2005 FALSE
+K04765 EC:3.6.1.9 mazG; pyrophosphohydrolase/pyrophosphatase Rihtman et al. 2019; Sullivan et al. 2005; Ignacio?Espinoza et al. 2012; BorbÈly et al. 1980 TRUE
+K00568 PF06983 3-demethylubiquinone-9 3-methyltransferase Roux et al. 2016 FALSE
+K06133 EC:2.7.8.- PF01648 4'-phosphopantetheinyl transferase superfamily Roux et al. 2016 FALSE
+ EC:2.7.4.3 PF00406 Adenylate kinase Roux et al. 2016 FALSE
+ EC:2.7.4.3 PF05191 Adenylate kinase, active site lid Roux et al. 2016 FALSE
+ PF05221 S-adenosyl-L-homocysteine hydrolase Roux et al. 2016 FALSE
+ PF02675 speD; S-adenosylmethionine decarboxylase Sullivan et al. 2005; Ignacio?Espinoza et al. 2012; Hurwitz et al. 2015; Roux et al. 2016 FALSE
+ EC:4.2.1.24 PF00490 Delta-aminolevulinic acid dehydratase Roux et al. 2016 FALSE
+K00324 EC:1.6.1.27.1.1.1 PF05222 Alanine dehydrogenase/PNT, N-terminal domain Roux et al. 2016 FALSE
+ PF02522 Aminoglycoside 3-N-acetyltransferase Roux et al. 2016 FALSE
+ PF12139 Adenosine-5'-phosphosulfate reductase beta subunit Roux et al. 2016 FALSE
+ PF09206 Alpha-L-arabinofuranosidase B, catalytic Roux et al. 2016 FALSE
+ PF02397 Bacterial sugar transferase Roux et al. 2016 FALSE
+ PF01144 Coenzyme A transferase Roux et al. 2016 FALSE
+ PF01923 Cobalamin adenosyltransferase Roux et al. 2016 FALSE
+ PF06213 Cobalamin biosynthesis protein CobT Roux et al. 2016 FALSE
+ PF11775 Cobalamin biosynthesis protein CobT VWA domain Roux et al. 2016 FALSE
+ PF01218 Coproporphyrinogen III oxidase Roux et al. 2016 FALSE
+ PF01148 Cytidylyltransferase family Roux et al. 2016 FALSE
+ PF01467 Cytidylyltransferase Roux et al. 2016 FALSE
+ PF02348 Cytidylyltransferase Roux et al. 2016 FALSE
+ PF07732 Multicopper oxidase Roux et al. 2016 FALSE
+ PF02224 Cytidylate kinase Roux et al. 2016 FALSE
+ PF06442 R67 dihydrofolate reductase Roux et al. 2016 FALSE
+ PF01762 Galactosyltransferase Roux et al. 2016 FALSE
+ PF04107 Glutamate-cysteine ligase family 2(GCS2) Roux et al. 2016 FALSE
+ PF01408 Oxidoreductase family, NAD-binding Rossmann fold Roux et al. 2016 FALSE
+ PF00288 GHMP kinases N terminal domain Roux et al. 2016 FALSE
+ PF01832 Mannosyl-glycoprotein endo-beta-N-acetylglucosaminidase Roux et al. 2016 FALSE
+ PF04488 Glycosyltransferase sugar-binding region containing DXD motif Roux et al. 2016 FALSE
+ PF00723 Glycosyl hydrolases family 15 Roux et al. 2016 FALSE
+ PF00933 Glycosyl hydrolase family 3 N terminal domain Roux et al. 2016 FALSE
+ PF04724 Glycosyltransferase family 17 Roux et al. 2016 FALSE
+ PF00534 Glycosyl transferases group 1 Roux et al. 2016 FALSE
+ PF00255 Glutathione peroxidase Roux et al. 2016 FALSE
+ PF13417 Glutathione S-transferase, N-terminal domain Roux et al. 2016 FALSE
+ PF01227 GTP cyclohydrolase I Roux et al. 2016 FALSE
+ PF09778 Guanylylate cyclase Roux et al. 2016 FALSE
+ PF00625 Guanylate kinase Roux et al. 2016 FALSE
+ PF01126 Heme oxygenase Roux et al. 2016 FALSE
+ PF00132 Bacterial transferase hexapeptide (six repeats) Roux et al. 2016 FALSE
+ PF01717 Cobalamin-independent synthase, Catalytic domain Roux et al. 2016 FALSE
+ PF00141 Peroxidase Roux et al. 2016 FALSE
+ PF01663 Type I phosphodiesterase / nucleotide pyrophosphatase Roux et al. 2016 FALSE
+ PF02585 GlcNAc-PI de-N-acetylase Roux et al. 2016 FALSE
+ PF05045 Rhamnan synthesis protein F Roux et al. 2016 FALSE
+ PF08501 Shikimate dehydrogenase substrate binding domain Roux et al. 2016 FALSE
+ PF00494 Squalene/phytoene synthase Roux et al. 2016 FALSE
+ PF00685 Sulfotransferase domain Roux et al. 2016 FALSE
+ PF03567 Sulfotransferase family Roux et al. 2016 FALSE
+ PF13469 Sulfotransferase family Roux et al. 2016 FALSE
+ PF09037 Stf0 sulphotransferase Roux et al. 2016 FALSE
+ PF02668 Taurine catabolism dioxygenase TauD, TfdA family Roux et al. 2016 FALSE
+ PF02882 Tetrahydrofolate dehydrogenase/cyclohydrolase, NAD(P)-binding domain Roux et al. 2016 FALSE
+ PF10396 GTP-binding protein TrmE N-terminus Roux et al. 2016 FALSE
+ PF00749 tRNA synthetases class I (E and Q), catalytic domain Roux et al. 2016 FALSE
+ PF00984 UDP-glucose/GDP-mannose dehydrogenase family, central domain Roux et al. 2016 FALSE
+ EC:1.1.1.22 PF03721 UDP-glucose/GDP-mannose dehydrogenase family, NAD binding domain Roux et al. 2016 FALSE
+K01599 EC:4.1.1.37 PF01208 Uroporphyrinogen decarboxylase (URO-D) Roux et al. 2016 FALSE
+ PF05090 Vitamin K-dependent gamma-carboxylase Roux et al. 2016 FALSE
+ PF07884 Vitamin K epoxide reductase family Roux et al. 2016 FALSE
+ PF05935 Arylsulfotransferase (ASST) Roux et al. 2016 FALSE
+ PF01145 SPFH domain / Band 7 family Roux et al. 2016 FALSE
+ PF04940 Sensors of blue-light using FAD Roux et al. 2016 FALSE
+ PF03703 Bacterial PH domain Roux et al. 2016 FALSE
+ PF00262 Calreticulin family Roux et al. 2016 FALSE
+ PF09489 Probable cobalt transporter subunit (CbtB) Roux et al. 2016 FALSE
+ PF01066 CDP-alcohol phosphatidyltransferase Roux et al. 2016 FALSE
+ PF02543 Carbamoyltransferase Roux et al. 2016 FALSE
+ PF00289 Carbamoyl-phosphate synthase L chain, N-terminal domain Roux et al. 2016 FALSE
+ PF02787 Carbamoyl-phosphate synthetase large chain, oligomerisation domain Roux et al. 2016 FALSE
+ PF01791 DeoC/LacD family aldolase Roux et al. 2016 FALSE
+ PF00122 E1-E2 ATPase Roux et al. 2016 FALSE
+ PF01370 NAD dependent epimerase/dehydratase family Roux et al. 2016 FALSE
+ EC:5.1.3.14 PF02350 UDP-N-acetylglucosamine 2-epimerase Roux et al. 2016 FALSE
+ PF03016 Exostosin family Roux et al. 2016 FALSE
+ PF00941 FAD binding domain in molybdopterin dehydrogenase Roux et al. 2016 FALSE
+ PF02913 FAD linked oxidases, C-terminal domain Roux et al. 2016 FALSE
+ PF05996 Ferredoxin-dependent bilin reductase Roux et al. 2016 FALSE
+ PF02152 Dihydroneopterin aldolase Roux et al. 2016 FALSE
+ PF00682 HMGL-like Roux et al. 2016 FALSE
+ PF07700 Heme NO binding Roux et al. 2016 FALSE
+ PF01288 7,8-dihydro-6-hydroxymethylpterin-pyrophosphokinase (HPPK) Roux et al. 2016 FALSE
+ PF00920 Dehydratase family Roux et al. 2016 FALSE
+ PF04362 Bacterial Fe(2+) trafficking Roux et al. 2016 FALSE
+ PF00206 Lyase Roux et al. 2016 FALSE
+ PF01596 O-methyltransferase Roux et al. 2016 FALSE
+ PF06463 Molybdenum Cofactor Synthesis C Roux et al. 2016 FALSE
+ PF00384 Molybdopterin oxidoreductase Roux et al. 2016 FALSE
+ PF02445 Quinolinate synthetase A protein Roux et al. 2016 FALSE
+ PF04131 Putative N-acetylmannosamine-6-phosphate epimerase Roux et al. 2016 FALSE
+ PF04095 Nicotinate phosphoribosyltransferase (NAPRTase) family Roux et al. 2016 FALSE
+ PF03824 High-affinity nickel-transport protein Roux et al. 2016 FALSE
+ PF00543 Nitrogen regulatory protein P-II Roux et al. 2016 FALSE
+ PF02548 Ketopantoate hydroxymethyltransferase Roux et al. 2016 FALSE
+ PF01734 Patatin-like phospholipase Roux et al. 2016 FALSE
+ PF13091 PLD-like domain Roux et al. 2016 FALSE
+ PF00348 Polyprenyl synthetase Roux et al. 2016 FALSE
+ PF02541 Ppx/GppA phosphatase family Roux et al. 2016 FALSE
+ PF00485 Phosphoribulokinase / Uridine kinase family Roux et al. 2016 FALSE
+ PF01242 6-pyruvoyl tetrahydropterin synthase Roux et al. 2016 FALSE
+ PF02700 Phosphoribosylformylglycinamidine (FGAM) synthase Roux et al. 2016 FALSE
+ PF06508 Queuosine biosynthesis protein QueC Roux et al. 2016 FALSE
+ PF14489 QueF-like protein Roux et al. 2016 FALSE
+ PF04321 RmlD substrate binding domain Roux et al. 2016 FALSE
+ PF02915 Rubrerythrin Roux et al. 2016 FALSE
+ PF01259 SAICAR synthetase Roux et al. 2016 FALSE
+ PF00550 Phosphopantetheine attachment site Roux et al. 2016 FALSE
+ PF00719 Inorganic pyrophosphatase Roux et al. 2016 FALSE
+ PF00722 Glycosyl hydrolases family 16; beta-1,3-glucanase Sun et al. 2000; Emerson et al. 2018 TRUE
+ PF00150 Cellulase; endo-beta-1,4-mannosidase Emerson et al. 2018 TRUE
+ PF0232 Glycosyl hydrolase family 70; alpha amylase Emerson et al. 2018 FALSE
+ PF07971 Alpha-1,2-mannosidase Emerson et al. 2018 FALSE
+ EC:3.2.1.51 PF01120 Alpha-L-fucosidase Emerson et al. 2018 FALSE
+ PF04616 Glycosyl hydrolases family 43; beta-1,4-xylosidase Emerson et al. 2018 FALSE
+ PF00703 Glycosyl hydrolases family 2; beta-galactosidase Emerson et al. 2018 FALSE
+ PF01373 Glycosyl hydrolase family 14; beta-galactosidase Emerson et al. 2018 FALSE
+ PF03659 Glycosyl hydrolase family 71; endo-alpha-mannosidase Emerson et al. 2018 FALSE
+ PF13385 Concanavalin A-like lectin; extracellular arabinase Emerson et al. 2018 FALSE
+K01779 EC:5.1.1.13 racD; aspartate Racmase Trubl et al. 2018 FALSE
+ PF01786 Plastoquinol terminal oxidase (PTOX) Sullivan et al. 2010; Ignacio?Espinoza et al. 2012; Roux et al. 2016 FALSE
+ PF01077; PF03460 rdsrA; reverse-acting dissimilatory sulfite reductase (alpha subunit) Anantharaman et al. 2014 FALSE
\ No newline at end of file
diff --git a/tests/reference_dbs/dram_dbs/etc_module_database.tsv b/tests/reference_dbs/dram_dbs/etc_module_database.tsv
new file mode 100644
index 0000000..c7bf13b
--- /dev/null
+++ b/tests/reference_dbs/dram_dbs/etc_module_database.tsv
@@ -0,0 +1,20 @@
+module_id module_name complex definition
+M00144 NADH:quinone oxidoreductase, prokaryotes Complex I K00330+(K00331+K00332+K00333,K00331+K13378,K13380)+K00334+K00335+K00336+K00337+K00338+K00339+K00340+(K00341+K00342,K15863)+K00343
+M00145 NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria Complex I K05574+K05582+K05581+K05579+K05572+K05580+K05578+K05576+K05577+K05575+K05573-K05583-K05584-K05585
+M00146 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex Complex I K03945+K03946+K03947+K03948+K03949+K03950+K03951+K03952+K03953+K03954+K03955+K03956+K11352+K11353
+M00148 Succinate dehydrogenase (ubiquinone) Complex II K00236+K00237+K00234+K00235
+M00149 Succinate dehydrogenase, prokaryotes Complex II K00241+K00242+K00239+K00240
+M00150 Fumarate reductase, prokaryotes Complex II K00244+K00245+K00246+K00247
+M00151 Cytochrome bc1 complex respiratory unit Complex III ((K00412+K00413,K00410)+K00411),K03886+K03887+K03888,K03890+K03891+K03889
+M00152 Cytochrome bc1 complex Complex III (K00412+K00413,K00410)+K00411+K00414+K00415+K00416+K00417+K00418+K00419+K00420
+M00153 Cytochrome bd ubiquinol oxidase Complex III K00425+K00426+(K00424,K22501)
+M00153 Cytochrome bd ubiquinol oxidase Complex IV High affinity K00425+K00426+(K00424,K22501)
+M00156 Cytochrome c oxidase, cbb3-type Complex IV High affinity ((K00404+K00405,K15862)+K00407+K00406)
+M00154 Cytochrome c oxidase Complex IV Low affinity (K02257+K02262+K02256+K02261+K02263+K02264+K02265+K02266+K02267+K02268+(K02269,K02270-K02271)+K02272-K02273+K02258+K02259+K02260)
+M00155 Cytochrome c oxidase, prokaryotes Complex IV Low affinity K02275+(K02274+K02276,K15408)-K02277
+M00416 Cytochrome aa3-600 menaquinol oxidase Complex IV Low affinity K02827+K02826+K02828+K02829
+M00417 Cytochrome o ubiquinol oxidase Complex IV Low affinity K02297+K02298+K02299+K02300
+M00157 F-type ATPase, prokaryotes and chloroplasts Complex V K02111+K02112+K02113+K02114+K02115+K02108+K02109+K02110
+M00158 F-type ATPase, eukaryotes Complex V K02132+K02133+K02136+K02134+K02135+K02137+K02126+K02127+K02128+K02138+(K02129,K01549)+(K02130,K02139)+K02140+(K02141,K02131)-K02142-K02143+K02125
+M00159 V/A-type ATPase, prokaryotes Complex V K02117+K02118+K02119+K02120+K02121+K02122+K02107+K02123+K02124
+M00160 V-type ATPase, eukaryotes Complex V K02145+K02147+K02148+K02149+K02150+K02151+K02152+K02144+K02154+(K03661,K02155)+K02146+K02153+K03662
diff --git a/tests/reference_dbs/dram_dbs/function_heatmap_form.tsv b/tests/reference_dbs/dram_dbs/function_heatmap_form.tsv
new file mode 100644
index 0000000..429ff81
--- /dev/null
+++ b/tests/reference_dbs/dram_dbs/function_heatmap_form.tsv
@@ -0,0 +1,81 @@
+category subcategory function_name function_ids long_function_name gene_symbol
+CAZy CAZy Polyphenolics "K05909, AA1, AA2, K00422" Polyphenolics Cleavage
+CAZy CAZy Crystalline Cellulose "GH7, GH48, AA10, AA15, AA16, AA9, AA10, AA11, AA13" Crystalline Cellulose Backbone Cleavage
+CAZy CAZy Amorphous Cellulose "GH5, GH6, GH7, GH8, GH9, GH10, GH124, GH12, GH44, GH45" Amorphous Cellulose Backbone Cleavage
+CAZy CAZy Amorphous Cellulose "GH94, GH1, GH2, GH3, GH5, GH9, GH16, GH116" Amorphous Cellulose Oligo Cleavage
+CAZy CAZy Mucin GH101 Mucin Backbone Cleavage
+CAZy CAZy Mucin "GH27, GH129, GH112, GH109, GH31, GH36" Mucin Oligo Cleavage
+CAZy CAZy Sulf-Polysachharides "GH111, GH16, GH82, GH150, GH79, PL29, PL30, PL33, PL8, PL12, PL13, PL15, PL21, PL6, PL37, GH56, GH86" Sulf-Polysachharides Backbone Cleavage
+CAZy CAZy Sulf-Polysachharides "PL21, PL37, PL23, PL24, PL25, GH88, PL15, PL6, GH117" Sulf-Polysachharides Oligo Cleavage
+CAZy CAZy Xyloglucan "GH5, GH9, GH12, GH16, GH44, GH45, GH48, GH74, AA9" Xyloglucan Backbone Cleavage (Hemicellulose)
+CAZy CAZy Xyloglucan "GH31, GH43, GH10, GH2" Xyloglucan Oligo Cleavage (Hemicellulose)
+CAZy CAZy Starch "AA13, GH13, GH14, GH57, GH119, GH126" Starch Backbone Cleavage
+CAZy CAZy Starch "GH133, GH15, GH97" Starch Oligo Cleavage
+CAZy CAZy Chitin "GH18, GH19, GH23, GH73" Chitin Backbone Cleavage
+CAZy CAZy Chitin "GH20, GH3, GH5, GH84, GH116, AA10, AA11, AA15, CE4" Chitin Oligo Cleavage
+CAZy CAZy Pectin "GH28, PL1, PL2, PL9, PL10, PL11, PL22, PL26, PL3, PL4" Pectin Backbone Cleavage
+CAZy CAZy Pectin "GH78, GH106, GH138, GH139, GH143, CE8, GH105, GH4, CE12, GH2" Pectin Oligo Cleavage
+CAZy CAZy Alpha-galactans GH166 Alpha-galactans Backbone Cleavage
+CAZy CAZy Alpha-galactans "GH27, GH110, GH4, GH31, GH36, GH97" Alpha-galactans Oligo Cleavage
+CAZy CAZy Beta-galactan (pectic galactan) GH53 Beta-galactan (pectic galactan) Backbone Cleavage
+CAZy CAZy Beta-galactan (pectic galactan) "GH2, GH35, GH42, GH1, GH59, GH147, GH165" Beta-galactan (pectic galactan) Oligo Cleavage
+CAZy CAZy Mixed-Linkage glucans "GH16, GH30, GH17, GH7, GH8, GH9, GH5, GH55, GH64, GH81, GH128, GH152, GH157, GH158" Mixed-Linkage glucans Backbone Cleavage (Hemicellulose)
+CAZy CAZy Mixed-Linkage glucans "GH3, GH16, GH17, GH55, GH1" Mixed-Linkage glucans Oligo Cleavage (Hemicellulose)
+CAZy CAZy Xylans "GH10, GH26, GH8, GH5, GH11, GH30, GH98, GH141" Xylan Backbone Cleavage (Hemicellulose)
+CAZy CAZy Xylans "GH39, GH3, GH31, GH52, GH120, GH115, GH67" Xylan Oligo Cleavage (Hemicellulose)
+CAZy CAZy Beta-mannan "GH113, GH134, GH26, GH5" Beta-mannan Backbone Cleavage (Hemicellulose)
+CAZy CAZy Beta-mannan "GH26,GH130, GH113, CE2, CE17, GH2" Beta-mannan Oligo Cleavage (Hemicellulose)
+CAZy CAZy Alpha-mannan "GH99, GH76" Alpha-mannan Backbone Cleavage (Hemicellulose)
+CAZy CAZy Alpha-mannan "GH76, GH92, GH38, GH63, GH47, GH125, GH130" Alpha-mannan Oligo Cleavage (Hemicellulose)
+CAZy CAZy Arabinan "GH43, GH49" Arabinan Backbone Cleavage
+CAZy CAZy Arabinan "GH93, GH43, GH51, GH3, GH54, GH62" Arabinan Oligo Cleavage
+CAZy CAZy Rhamnose cleavage "GH78, GH106, GH145, PL24, PL25, PL27, PL28, GH28" Rhamnose Oligo cleavage
+CAZy CAZy Fucose Cleavage "GH107, GH139, GH141, GH151, GH29, GH95" Fucose Oligo Cleavage
+CAZy CAZy Arabinose cleavage "GH121, GH127, GH137, GH142, GH146, GH54, GH62, GH2" Arabinose Oligo cleavage
+Nitrogen metabolism Nitrification ammonia => nitrite EC:1.14.99.39 ammonia monooxygenase [EC:1.14.99.39] [RN:R00148]
+Nitrogen metabolism Nitrification Bacterial/Archaeal ammonia oxidation "K10944, K10945, K10946" amoA; Methane/ammonia monooxygenase subunit A (aka: particulate ammonia monooxygenase) [EC:1.14.99.39] [RN:R00148] amoA
+Nitrogen metabolism Nitrification Bacterial (aerobic-specific) ammonia oxidation K10535 hao: Hydroxylamine dehydrogenase [EC:1.7.2.6] [RN:R10164] hao
+Nitrogen metabolism Nitrification Bacterial (anaerobic-specific) ammonia oxidation "K20932, K20933, K20934, K20935" hzs; Hydrazine synthase subunit (aka: hzsC) [EC:1.7.2.7] [RN:R09799] hzs
+Nitrogen metabolism Nitrification nitrite=> nitrate "K00370, K00371" "nxrA; Nitrite oxidoreductase, alpha subunit [EC:1.7.99.-] [RN:R00978]; nxrB; Nitrite oxidoreductase, beta subunit [EC:1.7.99.-] [RN:R00978]"
+Nitrogen metabolism Denitrification nitrate => nitrite "K02567, K00370, K00371, K02568" periplasmic nitrate reductase NapA [EC:1.7.99.-] [RN:R00798] or nitrate reductase 1 NarG [EC:1.7.99.-] [RN:R00798]
+Nitrogen metabolism Denitrification nitrite => nitric oxide "K00362, K00368, K15864" respiratory nitrite reductase [EC:1.7.1.15] [RN:R00787]
+Nitrogen metabolism Denitrification Dissimilatory nitrite reduction to ammonia (DNRA) "K03385, K15876" nrfA; Nitrite reductase (cytochrome c-552) [EC:1.7.2.2] [RN:R05712]; nrfH; cytochrome c nitrite reductase small subunit [EC:1.7.2.2] [RN:R05712] nrfA
+Nitrogen metabolism Denitrification nitric oxide => nitrous oxide "K04561, K15877" nitric oxide reductase [EC:1.7.2.5] [RN:R00294]
+Nitrogen metabolism Denitrification nitrous oxide => nitrogen K00376 nitrous-oxide reductase [EC:1.7.2.4] [RN:R02804]
+Nitrogen metabolism Nitrogen fixation nitrogen => ammonia "K02588, K02586" nitrogenase iron protein [RN:R05185]
+Nitrogen metabolism Nitrogen fixation Nitrogen fixation altennative K22896 vnfD; Vanadium-dependent nitrogenase alpha chain [EC:1.18.6.2] [RN:R12084] vnfH
+Sulfur metabolism Sulfur metabolism dissimilatory sulfate reduction (and oxidation) sulfate => sulfide "K11180, K11181" dissimilatory sulfite reductase alpha subunit [EC:1.8.99.5] dsrA or dsrB
+Sulfur metabolism Sulfur metabolism thiosulfate => sulfite K08352 thiosulfate reductase / polysulfide reductase chain A [EC:1.8.5.5] "phsA, psrA"
+Sulfur metabolism Sulfur metabolism "Thiosulfate oxidation by SOX complex, thiosulfate => sulfate" "K17222, K17223, K17224, K17225, K22622, K17226, K17227"
+Sulfur metabolism Sulfur metabolism tetrathionate => thiosulfate K08357 ttrA
+Other Reductases Reductases and Electron transport chain components selenate/Chlorate reduction K17050 selenate/chlorate reductase subunit alpha
+Other Reductases Reductases and Electron transport chain components TMAO reductase K07811 trimethylamine-N-oxide reductase (cytochrome c) [EC:1.7.2.3]
+Other Reductases Reductases and Electron transport chain components mercury reduction EC:1.16.1.1 mercury(II) reductase
+Other Reductases Reductases and Electron transport chain components "arsenate reduction, pt 1" EC:1.20.4.1 arsenate reductase (glutaredoxin); ArsC (ambiguous)
+Other Reductases Reductases and Electron transport chain components "arsenate reduction, pt 2" EC:1.20.99.1 arsenate reductase (donor); arsenate:(acceptor) oxidoreductase
+Photosynthesis Photosynthesis Photosystem I "K02689, K02690, K02691, K02692, K02693, K02694, K08940, K08941, K08942, K08943" psaA-F; photosystem I P700 chlorophyll a apoprotein A1
+Photosynthesis Photosynthesis Photosystem II "K02703, K02704, K02705, K02706, K02707, K02708, K08928, K08929" "psbA, psbD photosystem II reaction center D1 protein [EC:1.10.3.9]" fhs (formyltetrahydrofolate (THF) synthetase)
+Methanogenesis and methanotrophy Methanogenesis and methanotrophy Key functional gene "K00399, K00401, K00402" methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] mcrA
+Methanogenesis and methanotrophy Methanogenesis and methanotrophy "acetate => methane, pt 1" K01895 acetyl-CoA synthetase [EC:6.2.1.1] [RN:R00235]
+Methanogenesis and methanotrophy Methanogenesis and methanotrophy "acetate => methane, pt 2" K00925 acetate kinase [EC:2.7.2.1] [RN:R00315] ack
+Methanogenesis and methanotrophy Methanogenesis and methanotrophy "acetate => methane, pt 3" K00625 phosphate acetyltransferase [EC:2.3.1.8] [RN:R00230]
+Methanogenesis and methanotrophy Methanogenesis and methanotrophy methanol => methane K04480 mtaB; 5-hydroxybenzimidazolylcobamide Co-methyltransferase mtaB
+Methanogenesis and methanotrophy Methanogenesis and methanotrophy trimethylamine => dimethylamine K14083 mttB; trimethylamine corrinoid protein Co-methyltransferase mttB
+Methanogenesis and methanotrophy Methanogenesis and methanotrophy dimethylamine => monomethylamine K16178 mtbB; dimethylamine corrinoid protein Co-methyltransferase mtbB
+Methanogenesis and methanotrophy Methanogenesis and methanotrophy monomethylamine => ammonia K16176 mtmB; methylamine corrinoid protein Co-methyltransferase mtmB
+Methanogenesis and methanotrophy Methanogenesis and methanotrophy putative but not defining CO2 => methane K00200 formylmethanofuran dehydrogenase [EC:1.2.99.5] [RN:R03015]
+Methanogenesis and methanotrophy Methanogenesis and methanotrophy "methane => methanol, with oxygen (pmo)" "K10944, K10945, K10946" "pmoA; Methane/ammonia monooxygenase subunit A (aka: Particulate methane monoxygenase, or subunit Beta) [EC:1.14.18.3] [RN:R09518]" pmoA
+Methanogenesis and methanotrophy Methanogenesis and methanotrophy "methane => methanol, with oxygen (mmo)" "K16157, K16158, K16159, K16160, K16161, K16162" "mmoX; Methane monooxygenase component A alpha chain (aka: Soluble methane monooxygenase, or methane hydroxylase) [EC1.14.13.25] [RN:R01142]"
+SCFA and alcohol conversions SCFA and alcohol conversions pyruvate => acetyl CoA v1 K00163 pyruvate dehydrogenase E1 component [EC:1.2.4.1]
+SCFA and alcohol conversions SCFA and alcohol conversions pyruvate => acetyl CoA v2 K00174 "2-oxoglutarate/2-oxoacid ferredoxin oxidoreductase subunit alpha [EC:1.2.7.3, 1.2.7.11]"
+SCFA and alcohol conversions SCFA and alcohol conversions pyruvate => acetylCoA f+ formate v3 K00656 formate C-acetyltransferase [EC:2.3.1.54]
+SCFA and alcohol conversions SCFA and alcohol conversions "acetate, pt 1" "K00625,K00925" "phosphate acetyltransferase [EC:2.3.1.8] [RN:R00230], acetate kinase [EC:2.7.2.1] [RN:R00315]"
+SCFA and alcohol conversions SCFA and alcohol conversions "acetate, pt 2" K01905 acetate---CoA ligase (ADP-forming) subunit alpha
+SCFA and alcohol conversions SCFA and alcohol conversions "acetate, pt 3" K01067 acetyl-CoA hydrolase [EC:3.1.2.1]
+SCFA and alcohol conversions SCFA and alcohol conversions lactate L "K00016, K00101" L-lactate dehydrogenase [EC:1.1.1.27]; L-lactate dehydrogenase (cytochrome) [EC:1.1.2.3]
+SCFA and alcohol conversions SCFA and alcohol conversions lactate D "K03778, K03777" "D-lactate dehydrogenase [EC:1.1.1.28]; D-lactate dehydrogenase (quinone) [EC:1.1.5.12], D-lactate dehydrogenase (cytochrome) [EC:1.1.2.4], D-lactate dehydrogenase (cytochrome c-553)"
+SCFA and alcohol conversions SCFA and alcohol conversions "Butyrate, pt 1" K00634 phosphate butyryltransferase [EC:2.3.1.19]
+SCFA and alcohol conversions SCFA and alcohol conversions "Butyrate, pt 2" "K00929, K01896" "butyrate kinase [EC:2.7.2.7], medium-chain acyl-CoA synthetase [EC:6.2.1.2]"
+SCFA and alcohol conversions SCFA and alcohol conversions "Propionate, pt 1" K19697 propionate kinase [EC:2.7.2.15]
+SCFA and alcohol conversions SCFA and alcohol conversions "Propionate, pt 2" K01026 propionate CoA-transferase [EC:2.8.3.1]
+SCFA and alcohol conversions SCFA and alcohol conversions Alcohol production "K00001, K00121, K04072, K13951, K13952, K13953, K13954, K13980, K18857" alcohol dehydrogenase [EC:1.1.1.1]
diff --git a/tests/reference_dbs/dram_dbs/genome_summary_form.tsv b/tests/reference_dbs/dram_dbs/genome_summary_form.tsv
new file mode 100644
index 0000000..a53fade
--- /dev/null
+++ b/tests/reference_dbs/dram_dbs/genome_summary_form.tsv
@@ -0,0 +1,3715 @@
+gene_id gene_description module sheet header subheader potential_amg
+K02981 small subunit ribosomal protein S2e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02985 small subunit ribosomal protein S3e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02984 small subunit ribosomal protein S3Ae "Ribosome, eukaryotes" MISC Information systems TRUE
+K02987 small subunit ribosomal protein S4e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02989 small subunit ribosomal protein S5e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02991 small subunit ribosomal protein S6e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02993 small subunit ribosomal protein S7e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02995 small subunit ribosomal protein S8e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02997 small subunit ribosomal protein S9e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02947 small subunit ribosomal protein S10e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02949 small subunit ribosomal protein S11e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02951 small subunit ribosomal protein S12e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02953 small subunit ribosomal protein S13e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02955 small subunit ribosomal protein S14e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02958 small subunit ribosomal protein S15e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02957 small subunit ribosomal protein S15Ae "Ribosome, eukaryotes" MISC Information systems TRUE
+K02960 small subunit ribosomal protein S16e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02962 small subunit ribosomal protein S17e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02964 small subunit ribosomal protein S18e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02966 small subunit ribosomal protein S19e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02969 small subunit ribosomal protein S20e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02971 small subunit ribosomal protein S21e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02973 small subunit ribosomal protein S23e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02974 small subunit ribosomal protein S24e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02975 small subunit ribosomal protein S25e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02976 small subunit ribosomal protein S26e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02978 small subunit ribosomal protein S27e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02977 small subunit ribosomal protein S27Ae "Ribosome, eukaryotes" MISC Information systems TRUE
+K02979 small subunit ribosomal protein S28e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02980 small subunit ribosomal protein S29e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02983 small subunit ribosomal protein S30e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02998 small subunit ribosomal protein SAe "Ribosome, eukaryotes" MISC Information systems TRUE
+K02925 large subunit ribosomal protein L3e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02930 large subunit ribosomal protein L4e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02932 large subunit ribosomal protein L5e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02934 large subunit ribosomal protein L6e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02937 large subunit ribosomal protein L7e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02936 large subunit ribosomal protein L7Ae "Ribosome, eukaryotes" MISC Information systems TRUE
+K02938 large subunit ribosomal protein L8e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02940 large subunit ribosomal protein L9e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02866 large subunit ribosomal protein L10e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02865 large subunit ribosomal protein L10Ae "Ribosome, eukaryotes" MISC Information systems TRUE
+K02868 large subunit ribosomal protein L11e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02870 large subunit ribosomal protein L12e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02873 large subunit ribosomal protein L13e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02872 large subunit ribosomal protein L13Ae "Ribosome, eukaryotes" MISC Information systems TRUE
+K02875 large subunit ribosomal protein L14e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02877 large subunit ribosomal protein L15e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02880 large subunit ribosomal protein L17e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02883 large subunit ribosomal protein L18e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02882 large subunit ribosomal protein L18Ae "Ribosome, eukaryotes" MISC Information systems TRUE
+K02885 large subunit ribosomal protein L19e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02889 large subunit ribosomal protein L21e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02891 large subunit ribosomal protein L22e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02894 large subunit ribosomal protein L23e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02893 large subunit ribosomal protein L23Ae "Ribosome, eukaryotes" MISC Information systems TRUE
+K02896 large subunit ribosomal protein L24e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02898 large subunit ribosomal protein L26e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02901 large subunit ribosomal protein L27e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02900 large subunit ribosomal protein L27Ae "Ribosome, eukaryotes" MISC Information systems TRUE
+K02903 large subunit ribosomal protein L28e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02905 large subunit ribosomal protein L29e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02908 large subunit ribosomal protein L30e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02910 large subunit ribosomal protein L31e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02912 large subunit ribosomal protein L32e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02915 large subunit ribosomal protein L34e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02918 large subunit ribosomal protein L35e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02917 large subunit ribosomal protein L35Ae "Ribosome, eukaryotes" MISC Information systems TRUE
+K02920 large subunit ribosomal protein L36e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02922 large subunit ribosomal protein L37e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02921 large subunit ribosomal protein L37Ae "Ribosome, eukaryotes" MISC Information systems TRUE
+K02923 large subunit ribosomal protein L38e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02924 large subunit ribosomal protein L39e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02927 large subunit ribosomal protein L40e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02928 large subunit ribosomal protein L41e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02929 large subunit ribosomal protein L44e "Ribosome, eukaryotes" MISC Information systems TRUE
+K02941 large subunit ribosomal protein LP0 "Ribosome, eukaryotes" MISC Information systems TRUE
+K02942 large subunit ribosomal protein LP1 "Ribosome, eukaryotes" MISC Information systems TRUE
+K02943 large subunit ribosomal protein LP2 "Ribosome, eukaryotes" MISC Information systems TRUE
+K02946 small subunit ribosomal protein S10 "Ribosome, bacteria" MISC Information systems TRUE
+K02906 large subunit ribosomal protein L3 "Ribosome, bacteria" MISC Information systems TRUE
+K02926 large subunit ribosomal protein L4 "Ribosome, bacteria" MISC Information systems TRUE
+K02892 large subunit ribosomal protein L23 "Ribosome, bacteria" MISC Information systems TRUE
+K02886 large subunit ribosomal protein L2 "Ribosome, bacteria" MISC Information systems TRUE
+K02965 small subunit ribosomal protein S19 "Ribosome, bacteria" MISC Information systems TRUE
+K02890 large subunit ribosomal protein L22 "Ribosome, bacteria" MISC Information systems TRUE
+K02982 small subunit ribosomal protein S3 "Ribosome, bacteria" MISC Information systems TRUE
+K02878 large subunit ribosomal protein L16 "Ribosome, bacteria" MISC Information systems TRUE
+K02904 large subunit ribosomal protein L29 "Ribosome, bacteria" MISC Information systems TRUE
+K02961 small subunit ribosomal protein S17 "Ribosome, bacteria" MISC Information systems TRUE
+K02874 large subunit ribosomal protein L14 "Ribosome, bacteria" MISC Information systems TRUE
+K02895 large subunit ribosomal protein L24 "Ribosome, bacteria" MISC Information systems TRUE
+K02931 large subunit ribosomal protein L5 "Ribosome, bacteria" MISC Information systems TRUE
+K02954 small subunit ribosomal protein S14 "Ribosome, bacteria" MISC Information systems TRUE
+K02994 small subunit ribosomal protein S8 "Ribosome, bacteria" MISC Information systems TRUE
+K02933 large subunit ribosomal protein L6 "Ribosome, bacteria" MISC Information systems TRUE
+K02881 large subunit ribosomal protein L18 "Ribosome, bacteria" MISC Information systems TRUE
+K02988 small subunit ribosomal protein S5 "Ribosome, bacteria" MISC Information systems TRUE
+K02907 large subunit ribosomal protein L30 "Ribosome, bacteria" MISC Information systems TRUE
+K02876 large subunit ribosomal protein L15 "Ribosome, bacteria" MISC Information systems TRUE
+K02919 large subunit ribosomal protein L36 "Ribosome, bacteria" MISC Information systems TRUE
+K02952 small subunit ribosomal protein S13 "Ribosome, bacteria" MISC Information systems TRUE
+K02948 small subunit ribosomal protein S11 "Ribosome, bacteria" MISC Information systems TRUE
+K02986 small subunit ribosomal protein S4 "Ribosome, bacteria" MISC Information systems TRUE
+K02879 large subunit ribosomal protein L17 "Ribosome, bacteria" MISC Information systems TRUE
+K02871 large subunit ribosomal protein L13 "Ribosome, bacteria" MISC Information systems TRUE
+K02996 small subunit ribosomal protein S9 "Ribosome, bacteria" MISC Information systems TRUE
+K02992 small subunit ribosomal protein S7 "Ribosome, bacteria" MISC Information systems TRUE
+K02950 small subunit ribosomal protein S12 "Ribosome, bacteria" MISC Information systems TRUE
+K07590 large subunit ribosomal protein L7A "Ribosome, bacteria" MISC Information systems TRUE
+K02935 large subunit ribosomal protein L7/L12 "Ribosome, bacteria" MISC Information systems TRUE
+K02864 large subunit ribosomal protein L10 "Ribosome, bacteria" MISC Information systems TRUE
+K02863 large subunit ribosomal protein L1 "Ribosome, bacteria" MISC Information systems TRUE
+K02867 large subunit ribosomal protein L11 "Ribosome, bacteria" MISC Information systems TRUE
+K02967 small subunit ribosomal protein S2 "Ribosome, bacteria" MISC Information systems TRUE
+K02956 small subunit ribosomal protein S15 "Ribosome, bacteria" MISC Information systems TRUE
+K02916 large subunit ribosomal protein L35 "Ribosome, bacteria" MISC Information systems TRUE
+K02887 large subunit ribosomal protein L20 "Ribosome, bacteria" MISC Information systems TRUE
+K02914 large subunit ribosomal protein L34 "Ribosome, bacteria" MISC Information systems TRUE
+K02939 large subunit ribosomal protein L9 "Ribosome, bacteria" MISC Information systems TRUE
+K02963 small subunit ribosomal protein S18 "Ribosome, bacteria" MISC Information systems TRUE
+K02990 small subunit ribosomal protein S6 "Ribosome, bacteria" MISC Information systems TRUE
+K02888 large subunit ribosomal protein L21 "Ribosome, bacteria" MISC Information systems TRUE
+K02899 large subunit ribosomal protein L27 "Ribosome, bacteria" MISC Information systems TRUE
+K02902 large subunit ribosomal protein L28 "Ribosome, bacteria" MISC Information systems TRUE
+K02913 large subunit ribosomal protein L33 "Ribosome, bacteria" MISC Information systems TRUE
+K02911 large subunit ribosomal protein L32 "Ribosome, bacteria" MISC Information systems TRUE
+K02909 large subunit ribosomal protein L31 "Ribosome, bacteria" MISC Information systems TRUE
+K02897 large subunit ribosomal protein L25 "Ribosome, bacteria" MISC Information systems TRUE
+K02959 small subunit ribosomal protein S16 "Ribosome, bacteria" MISC Information systems TRUE
+K02884 large subunit ribosomal protein L19 "Ribosome, bacteria" MISC Information systems TRUE
+K02968 small subunit ribosomal protein S20 "Ribosome, bacteria" MISC Information systems TRUE
+K02945 small subunit ribosomal protein S1 "Ribosome, bacteria" MISC Information systems TRUE
+K02970 small subunit ribosomal protein S21 "Ribosome, bacteria" MISC Information systems TRUE
+K02946 small subunit ribosomal protein S10 "Ribosome, archaea" MISC Information systems TRUE
+K02906 large subunit ribosomal protein L3 "Ribosome, archaea" MISC Information systems TRUE
+K02930 large subunit ribosomal protein L4e "Ribosome, archaea" MISC Information systems TRUE
+K02892 large subunit ribosomal protein L23 "Ribosome, archaea" MISC Information systems TRUE
+K02886 large subunit ribosomal protein L2 "Ribosome, archaea" MISC Information systems TRUE
+K02965 small subunit ribosomal protein S19 "Ribosome, archaea" MISC Information systems TRUE
+K02890 large subunit ribosomal protein L22 "Ribosome, archaea" MISC Information systems TRUE
+K02982 small subunit ribosomal protein S3 "Ribosome, archaea" MISC Information systems TRUE
+K02904 large subunit ribosomal protein L29 "Ribosome, archaea" MISC Information systems TRUE
+K02961 small subunit ribosomal protein S17 "Ribosome, archaea" MISC Information systems TRUE
+K02874 large subunit ribosomal protein L14 "Ribosome, archaea" MISC Information systems TRUE
+K02895 large subunit ribosomal protein L24 "Ribosome, archaea" MISC Information systems TRUE
+K02987 small subunit ribosomal protein S4e "Ribosome, archaea" MISC Information systems TRUE
+K02931 large subunit ribosomal protein L5 "Ribosome, archaea" MISC Information systems TRUE
+K02954 small subunit ribosomal protein S14 "Ribosome, archaea" MISC Information systems TRUE
+K02994 small subunit ribosomal protein S8 "Ribosome, archaea" MISC Information systems TRUE
+K02933 large subunit ribosomal protein L6 "Ribosome, archaea" MISC Information systems TRUE
+K02912 large subunit ribosomal protein L32e "Ribosome, archaea" MISC Information systems TRUE
+K02885 large subunit ribosomal protein L19e "Ribosome, archaea" MISC Information systems TRUE
+K02881 large subunit ribosomal protein L18 "Ribosome, archaea" MISC Information systems TRUE
+K02988 small subunit ribosomal protein S5 "Ribosome, archaea" MISC Information systems TRUE
+K02907 large subunit ribosomal protein L30 "Ribosome, archaea" MISC Information systems TRUE
+K02876 large subunit ribosomal protein L15 "Ribosome, archaea" MISC Information systems TRUE
+K02952 small subunit ribosomal protein S13 "Ribosome, archaea" MISC Information systems TRUE
+K02948 small subunit ribosomal protein S11 "Ribosome, archaea" MISC Information systems TRUE
+K02986 small subunit ribosomal protein S4 "Ribosome, archaea" MISC Information systems TRUE
+K02883 large subunit ribosomal protein L18e "Ribosome, archaea" MISC Information systems TRUE
+K02871 large subunit ribosomal protein L13 "Ribosome, archaea" MISC Information systems TRUE
+K02996 small subunit ribosomal protein S9 "Ribosome, archaea" MISC Information systems TRUE
+K02992 small subunit ribosomal protein S7 "Ribosome, archaea" MISC Information systems TRUE
+K02950 small subunit ribosomal protein S12 "Ribosome, archaea" MISC Information systems TRUE
+K02936 large subunit ribosomal protein L7Ae "Ribosome, archaea" MISC Information systems TRUE
+K02979 small subunit ribosomal protein S28e "Ribosome, archaea" MISC Information systems TRUE
+K02896 large subunit ribosomal protein L24e "Ribosome, archaea" MISC Information systems TRUE
+K02869 large subunit ribosomal protein L12 "Ribosome, archaea" MISC Information systems TRUE
+K02864 large subunit ribosomal protein L10 "Ribosome, archaea" MISC Information systems TRUE
+K02863 large subunit ribosomal protein L1 "Ribosome, archaea" MISC Information systems TRUE
+K02867 large subunit ribosomal protein L11 "Ribosome, archaea" MISC Information systems TRUE
+K02967 small subunit ribosomal protein S2 "Ribosome, archaea" MISC Information systems TRUE
+K02956 small subunit ribosomal protein S15 "Ribosome, archaea" MISC Information systems TRUE
+K02978 small subunit ribosomal protein S27e "Ribosome, archaea" MISC Information systems TRUE
+K02929 large subunit ribosomal protein L44e "Ribosome, archaea" MISC Information systems TRUE
+K02877 large subunit ribosomal protein L15e "Ribosome, archaea" MISC Information systems TRUE
+K02984 small subunit ribosomal protein S3Ae "Ribosome, archaea" MISC Information systems TRUE
+K02991 small subunit ribosomal protein S6e "Ribosome, archaea" MISC Information systems TRUE
+K02974 small subunit ribosomal protein S24e "Ribosome, archaea" MISC Information systems TRUE
+K02977 small subunit ribosomal protein S27Ae "Ribosome, archaea" MISC Information systems TRUE
+K02962 small subunit ribosomal protein S17e "Ribosome, archaea" MISC Information systems TRUE
+K02910 large subunit ribosomal protein L31e "Ribosome, archaea" MISC Information systems TRUE
+K02924 large subunit ribosomal protein L39e "Ribosome, archaea" MISC Information systems TRUE
+K02866 large subunit ribosomal protein L10e "Ribosome, archaea" MISC Information systems TRUE
+K02889 large subunit ribosomal protein L21e "Ribosome, archaea" MISC Information systems TRUE
+K02922 large subunit ribosomal protein L37e "Ribosome, archaea" MISC Information systems TRUE
+K02921 large subunit ribosomal protein L37Ae "Ribosome, archaea" MISC Information systems TRUE
+K02995 small subunit ribosomal protein S8e "Ribosome, archaea" MISC Information systems TRUE
+K02966 small subunit ribosomal protein S19e "Ribosome, archaea" MISC Information systems TRUE
+K02927 large subunit ribosomal protein L40e "Ribosome, archaea" MISC Information systems TRUE
+K02944 large subunit ribosomal protein LX "Ribosome, archaea" MISC Information systems TRUE
+K02976 small subunit ribosomal protein S26e "Ribosome, archaea" MISC Information systems TRUE
+K02975 small subunit ribosomal protein S25e "Ribosome, archaea" MISC Information systems TRUE
+K02983 small subunit ribosomal protein S30e "Ribosome, archaea" MISC Information systems TRUE
+K02873 large subunit ribosomal protein L13e "Ribosome, archaea" MISC Information systems TRUE
+K02917 large subunit ribosomal protein L35Ae "Ribosome, archaea" MISC Information systems TRUE
+K02928 large subunit ribosomal protein L41e "Ribosome, archaea" MISC Information systems TRUE
+K02915 large subunit ribosomal protein L34e "Ribosome, archaea" MISC Information systems TRUE
+K02875 large subunit ribosomal protein L14e "Ribosome, archaea" MISC Information systems TRUE
+K02908 large subunit ribosomal protein L30e "Ribosome, archaea" MISC Information systems TRUE
+K01647 citrate synthase [EC:2.3.3.1] [RN:R00351] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K05942 citrate (Re)-synthase [EC:2.3.3.3] [RN:R00351] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K01681 aconitate hydratase [EC:4.2.1.3] [RN:R01325 R01900 R01324] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K01682 aconitate hydratase [EC:4.2.1.3] [RN:R01325 R01900 R01324] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00031 isocitrate dehydrogenase [EC:1.1.1.42 1.1.1.41] [RN:R01899 R00268 R00267 R00709] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00030 isocitrate dehydrogenase [EC:1.1.1.42 1.1.1.41] [RN:R01899 R00268 R00267 R00709] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00164 2-oxoglutarate dehydrogenase complex [EC:1.2.4.2 2.3.1.61 1.8.1.4] [RN:R00621 R03316 R02570 R07618] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00658 2-oxoglutarate dehydrogenase complex [EC:1.2.4.2 2.3.1.61 1.8.1.4] [RN:R00621 R03316 R02570 R07618] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00382 2-oxoglutarate dehydrogenase complex [EC:1.2.4.2 2.3.1.61 1.8.1.4] [RN:R00621 R03316 R02570 R07618] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00174 2-oxoglutarate/2-oxoacid ferredoxin oxidoreductase subunit alpha [EC:1.2.7.3 1.2.7.11] [RN:R01197] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00175 2-oxoglutarate/2-oxoacid ferredoxin oxidoreductase subunit beta [EC:1.2.7.3 1.2.7.11] [RN:R01197] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00177 2-oxoglutarate ferredoxin oxidoreductase subunit gamma [EC:1.2.7.3] [RN:R01197] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00176 2-oxoglutarate ferredoxin oxidoreductase subunit delta [EC:1.2.7.3] [RN:R01197] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K01902 succinyl-CoA synthetase [EC:6.2.1.5] [RN:R00405] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K01903 succinyl-CoA synthetase [EC:6.2.1.5] [RN:R00405] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K01899 succinyl-CoA synthetase [EC:6.2.1.4 6.2.1.5] [RN:R00405 R00432 R00727] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K01900 succinyl-CoA synthetase [EC:6.2.1.4 6.2.1.5] [RN:R00405 R00432 R00727] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K18118 succinyl-CoA:acetate CoA-transferase [EC:2.8.3.18] [RN:R10343] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00234 succinate dehydrogenase [EC:1.3.5.1] [RN:R02164] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00235 succinate dehydrogenase [EC:1.3.5.1] [RN:R02164] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00236 succinate dehydrogenase [EC:1.3.5.1] [RN:R02164] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00237 succinate dehydrogenase [EC:1.3.5.1] [RN:R02164] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00239 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00240 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00241 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00242 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K18859 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K18860 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00244 fumarate reductase [EC:1.3.5.4] [RN:R02164] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00245 fumarate reductase [EC:1.3.5.4] [RN:R02164] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00246 fumarate reductase [EC:1.3.5.4] [RN:R02164] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00247 fumarate reductase [EC:1.3.5.4] [RN:R02164] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K01676 fumarate hydratase [EC:4.2.1.2] [RN:R01082] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K01679 fumarate hydratase [EC:4.2.1.2] [RN:R01082] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K01677 fumarate hydratase [EC:4.2.1.2] [RN:R01082] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K01678 fumarate hydratase [EC:4.2.1.2] [RN:R01082] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00026 malate dehydrogenase [EC:1.1.1.37] [RN:R00342] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00025 malate dehydrogenase [EC:1.1.1.37] [RN:R00342] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00024 malate dehydrogenase [EC:1.1.1.37] [RN:R00342] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K00116 malate dehydrogenase (quinone) [EC:1.1.5.4] [RN:R00361] "Citrate cycle (TCA cycle, Krebs cycle)" carbon utilization central carbon TCA TRUE
+K01647 citrate synthase [EC:2.3.3.1] [RN:R00351] "Citrate cycle, first carbon oxidation, oxaloacetate => 2-oxoglutarate" carbon utilization central carbon TCA TRUE
+K05942 citrate (Re)-synthase [EC:2.3.3.3] [RN:R00351] "Citrate cycle, first carbon oxidation, oxaloacetate => 2-oxoglutarate" carbon utilization central carbon TCA TRUE
+K01681 aconitate hydratase [EC:4.2.1.3] [RN:R01325 R01900 R01324] "Citrate cycle, first carbon oxidation, oxaloacetate => 2-oxoglutarate" carbon utilization central carbon TCA TRUE
+K01682 aconitate hydratase [EC:4.2.1.3] [RN:R01325 R01900 R01324] "Citrate cycle, first carbon oxidation, oxaloacetate => 2-oxoglutarate" carbon utilization central carbon TCA TRUE
+K00031 isocitrate dehydrogenase [EC:1.1.1.42 1.1.1.41] [RN:R01899 R00268 R00267 R00709] "Citrate cycle, first carbon oxidation, oxaloacetate => 2-oxoglutarate" carbon utilization central carbon TCA TRUE
+K00030 isocitrate dehydrogenase [EC:1.1.1.42 1.1.1.41] [RN:R01899 R00268 R00267 R00709] "Citrate cycle, first carbon oxidation, oxaloacetate => 2-oxoglutarate" carbon utilization central carbon TCA TRUE
+K00164 2-oxoglutarate dehydrogenase [EC:1.2.4.2 2.3.1.61 1.8.1.4] [RN:R00621 R03316 R02570 R07618] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00658 2-oxoglutarate dehydrogenase [EC:1.2.4.2 2.3.1.61 1.8.1.4] [RN:R00621 R03316 R02570 R07618] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00382 2-oxoglutarate dehydrogenase [EC:1.2.4.2 2.3.1.61 1.8.1.4] [RN:R00621 R03316 R02570 R07618] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00174 2-oxoglutarate/2-oxoacid ferredoxin oxidoreductase subunit alpha [EC:1.2.7.3 1.2.7.11] [RN:R01197] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00175 2-oxoglutarate/2-oxoacid ferredoxin oxidoreductase subunit beta [EC:1.2.7.3 1.2.7.11] [RN:R01197] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00177 2-oxoglutarate ferredoxin oxidoreductase subunit gamma [EC:1.2.7.3] [RN:R01197] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00176 2-oxoglutarate ferredoxin oxidoreductase subunit delta [EC:1.2.7.3] [RN:R01197] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K01902 succinyl-CoA synthetase [EC:6.2.1.5] [RN:R00405] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K01903 succinyl-CoA synthetase [EC:6.2.1.5] [RN:R00405] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K01899 succinyl-CoA synthetase [EC:6.2.1.4 6.2.1.5] [RN:R00405 R00432 R00727] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K01900 succinyl-CoA synthetase [EC:6.2.1.4 6.2.1.5] [RN:R00405 R00432 R00727] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K18118 succinyl-CoA:acetate CoA-transferase [EC:2.8.3.18] [RN:R10343] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00234 succinate dehydrogenase [EC:1.3.5.1] [RN:R02164] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00235 succinate dehydrogenase [EC:1.3.5.1] [RN:R02164] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00236 succinate dehydrogenase [EC:1.3.5.1] [RN:R02164] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00237 succinate dehydrogenase [EC:1.3.5.1] [RN:R02164] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00239 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00240 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00241 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00242 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K18859 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K18860 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00244 fumarate reductase [EC:1.3.5.4] [RN:R02164] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00245 fumarate reductase [EC:1.3.5.4] [RN:R02164] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00246 fumarate reductase [EC:1.3.5.4] [RN:R02164] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00247 fumarate reductase [EC:1.3.5.4] [RN:R02164] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K01676 fumarate hydratase [EC:4.2.1.2] [RN:R01082] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K01679 fumarate hydratase [EC:4.2.1.2] [RN:R01082] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K01677 fumarate hydratase [EC:4.2.1.2] [RN:R01082] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K01678 fumarate hydratase [EC:4.2.1.2] [RN:R01082] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00026 malate dehydrogenase [EC:1.1.1.37] [RN:R00342] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00025 malate dehydrogenase [EC:1.1.1.37] [RN:R00342] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00024 malate dehydrogenase [EC:1.1.1.37] [RN:R00342] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00116 malate dehydrogenase (quinone) [EC:1.1.5.4] [RN:R00361] "Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate" carbon utilization central carbon TCA TRUE
+K00169 pyruvate ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] "Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate" carbon utilization central carbon TCA TRUE
+K00170 pyruvate ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] "Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate" carbon utilization central carbon TCA TRUE
+K00171 pyruvate ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] "Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate" carbon utilization central carbon TCA TRUE
+K00172 pyruvate ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] "Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate" carbon utilization central carbon TCA TRUE
+K01959 pyruvate carboxylase [EC:6.4.1.1] [RN:R00344] "Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate" carbon utilization central carbon TCA TRUE
+K01960 pyruvate carboxylase [EC:6.4.1.1] [RN:R00344] "Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate" carbon utilization central carbon TCA TRUE
+K00024 malate dehydrogenase [EC:1.1.1.37] [RN:R00342] "Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate" carbon utilization central carbon TCA TRUE
+K01677 fumarate hydratase [EC:4.2.1.2] [RN:R01082] "Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate" carbon utilization central carbon TCA TRUE
+K01678 fumarate hydratase [EC:4.2.1.2] [RN:R01082] "Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate" carbon utilization central carbon TCA TRUE
+K18209 fumarate reductase (CoM/CoB) [EC:1.3.4.1] [RN:R10660] "Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate" carbon utilization central carbon TCA TRUE
+K18210 fumarate reductase (CoM/CoB) [EC:1.3.4.1] [RN:R10660] "Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate" carbon utilization central carbon TCA TRUE
+K01902 succinyl-CoA synthetase [EC:6.2.1.5] [RN:R00405] "Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate" carbon utilization central carbon TCA TRUE
+K01903 succinyl-CoA synthetase [EC:6.2.1.5] [RN:R00405] "Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate" carbon utilization central carbon TCA TRUE
+K00174 2-oxoglutarate ferredoxin oxidoreductase [EC:1.2.7.3] [RN:R01197] "Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate" carbon utilization central carbon TCA TRUE
+K00175 2-oxoglutarate ferredoxin oxidoreductase [EC:1.2.7.3] [RN:R01197] "Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate" carbon utilization central carbon TCA TRUE
+K00176 2-oxoglutarate ferredoxin oxidoreductase [EC:1.2.7.3] [RN:R01197] "Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate" carbon utilization central carbon TCA TRUE
+K00177 2-oxoglutarate ferredoxin oxidoreductase [EC:1.2.7.3] [RN:R01197] "Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate" carbon utilization central carbon TCA TRUE
+K00027 malate dehydrogenase (oxaloacetate-decarboxylating) TCA /Reductive TCA carbon utilization central carbon TCA TRUE
+K13937 hexose-6-phosphate dehydrogenase [EC:1.1.1.47 3.1.1.31] [RN:R02736 R02035] Pentose phosphate pathway (Pentose phosphate cycle) carbon utilization central carbon pentose pathway TRUE
+K00036 glucose-6-phosphate 1-dehydrogenase [EC:1.1.1.49 1.1.1.363 1.1.1.388] [RN:R02736 R10907] Pentose phosphate pathway (Pentose phosphate cycle) carbon utilization central carbon pentose pathway TRUE
+K19243 glucose-6-phosphate 1-dehydrogenase [EC:1.1.1.49 1.1.1.363 1.1.1.388] [RN:R02736 R10907] Pentose phosphate pathway (Pentose phosphate cycle) carbon utilization central carbon pentose pathway TRUE
+K01057 6-phosphogluconolactonase [EC:3.1.1.31] [RN:R02035] Pentose phosphate pathway (Pentose phosphate cycle) carbon utilization central carbon pentose pathway TRUE
+K07404 6-phosphogluconolactonase [EC:3.1.1.31] [RN:R02035] Pentose phosphate pathway (Pentose phosphate cycle) carbon utilization central carbon pentose pathway TRUE
+K00033 6-phosphogluconate dehydrogenase [EC:1.1.1.44 1.1.1.343] [RN:R01528 R10221] Pentose phosphate pathway (Pentose phosphate cycle) carbon utilization central carbon pentose pathway TRUE
+K01783 ribulose-phosphate 3-epimerase [EC:5.1.3.1] [RN:R01529] Pentose phosphate pathway (Pentose phosphate cycle) carbon utilization central carbon pentose pathway TRUE
+K01807 ribose 5-phosphate isomerase [EC:5.3.1.6] [RN:R01056] Pentose phosphate pathway (Pentose phosphate cycle) carbon utilization central carbon pentose pathway TRUE
+K01808 ribose 5-phosphate isomerase [EC:5.3.1.6] [RN:R01056] Pentose phosphate pathway (Pentose phosphate cycle) carbon utilization central carbon pentose pathway TRUE
+K00615 transketolase [EC:2.2.1.1] [RN:R01641] Pentose phosphate pathway (Pentose phosphate cycle) carbon utilization central carbon pentose pathway TRUE
+K00616 transaldolase [EC:2.2.1.2] [RN:R01827] Pentose phosphate pathway (Pentose phosphate cycle) carbon utilization central carbon pentose pathway TRUE
+K01810 glucose-6-phosphate isomerase [EC:5.3.1.9] [RN:R02740 R02739] Pentose phosphate pathway (Pentose phosphate cycle) carbon utilization central carbon pentose pathway TRUE
+K06859 glucose-6-phosphate isomerase [EC:5.3.1.9] [RN:R02740 R02739] Pentose phosphate pathway (Pentose phosphate cycle) carbon utilization central carbon pentose pathway TRUE
+K13810 glucose-6-phosphate isomerase [EC:5.3.1.9] [RN:R02740 R02739] Pentose phosphate pathway (Pentose phosphate cycle) carbon utilization central carbon pentose pathway TRUE
+K15916 glucose-6-phosphate isomerase [EC:5.3.1.9] [RN:R02740 R02739] Pentose phosphate pathway (Pentose phosphate cycle) carbon utilization central carbon pentose pathway TRUE
+K00948 ribose-phosphate pyrophosphokinase [EC:2.7.6.1] [RN:R01049] "PRPP biosynthesis, ribose 5P => PRPP" carbon utilization central carbon pentose pathway TRUE
+K13937 hexose-6-phosphate dehydrogenase [EC:1.1.1.47 3.1.1.31] [RN:R02736 R02035] "Pentose phosphate pathway, oxidative phase, glucose 6P => ribulose 5P" carbon utilization central carbon pentose pathway TRUE
+K00036 glucose-6-phosphate 1-dehydrogenase [EC:1.1.1.49 1.1.1.363 1.1.1.388] [RN:R02736 R10907] "Pentose phosphate pathway, oxidative phase, glucose 6P => ribulose 5P" carbon utilization central carbon pentose pathway TRUE
+K19243 glucose-6-phosphate 1-dehydrogenase [EC:1.1.1.49 1.1.1.363 1.1.1.388] [RN:R02736 R10907] "Pentose phosphate pathway, oxidative phase, glucose 6P => ribulose 5P" carbon utilization central carbon pentose pathway TRUE
+K01057 6-phosphogluconolactonase [EC:3.1.1.31] [RN:R02035] "Pentose phosphate pathway, oxidative phase, glucose 6P => ribulose 5P" carbon utilization central carbon pentose pathway TRUE
+K07404 6-phosphogluconolactonase [EC:3.1.1.31] [RN:R02035] "Pentose phosphate pathway, oxidative phase, glucose 6P => ribulose 5P" carbon utilization central carbon pentose pathway TRUE
+K00033 6-phosphogluconate dehydrogenase [EC:1.1.1.44 1.1.1.343] [RN:R01528 R10221] "Pentose phosphate pathway, oxidative phase, glucose 6P => ribulose 5P" carbon utilization central carbon pentose pathway TRUE
+K00615 transketolase [EC:2.2.1.1] [RN:R01830 R01641] "Pentose phosphate pathway, non-oxidative phase, fructose 6P => ribose 5P" carbon utilization central carbon pentose pathway TRUE
+K00616 transaldolase [EC:2.2.1.2] [RN:R01827] "Pentose phosphate pathway, non-oxidative phase, fructose 6P => ribose 5P" carbon utilization central carbon pentose pathway TRUE
+K13810 transaldolase [EC:2.2.1.2] [RN:R01827] "Pentose phosphate pathway, non-oxidative phase, fructose 6P => ribose 5P" carbon utilization central carbon pentose pathway TRUE
+K01783 ribulose-phosphate 3-epimerase [EC:5.1.3.1] [RN:R01529] "Pentose phosphate pathway, non-oxidative phase, fructose 6P => ribose 5P" carbon utilization central carbon pentose pathway TRUE
+K01807 ribose 5-phosphate isomerase [EC:5.3.1.6] [RN:R01056] "Pentose phosphate pathway, non-oxidative phase, fructose 6P => ribose 5P" carbon utilization central carbon pentose pathway TRUE
+K01808 ribose 5-phosphate isomerase [EC:5.3.1.6] [RN:R01056] "Pentose phosphate pathway, non-oxidative phase, fructose 6P => ribose 5P" carbon utilization central carbon pentose pathway TRUE
+K08094 6-phospho-3-hexuloisomerase [EC:5.3.1.27] [RN:R09780] "Pentose phosphate pathway, archaea, fructose 6P => ribose 5P" carbon utilization central carbon pentose pathway TRUE
+K08093 3-hexulose-6-phosphate synthase [EC:4.1.2.43] [RN:R05338] "Pentose phosphate pathway, archaea, fructose 6P => ribose 5P" carbon utilization central carbon pentose pathway TRUE
+K13812 3-hexulose-6-phosphate synthase [EC:4.1.2.43] [RN:R05338] "Pentose phosphate pathway, archaea, fructose 6P => ribose 5P" carbon utilization central carbon pentose pathway TRUE
+K13831 6-phospho-3-hexuloisomerase [EC:5.3.1.27] [RN:R09780] "Pentose phosphate pathway, archaea, fructose 6P => ribose 5P" carbon utilization central carbon pentose pathway TRUE
+K01807 ribose 5-phosphate isomerase A [EC:5.3.1.6] [RN:R01056] "Pentose phosphate pathway, archaea, fructose 6P => ribose 5P" carbon utilization central carbon pentose pathway TRUE
+K01053 gluconolactonase Pentose phosphate pathway carbon utilization central carbon pentose pathway TRUE
+K00764 amidophosphoribosyltransferase [EC:2.4.2.14] [RN:R01072] "Inosine monophosphate biosynthesis, PRPP + glutamine => IMP" MISC Information systems Nucleotide TRUE
+K01945 phosphoribosylamine--glycine ligase [EC:6.3.4.13] [RN:R04144] "Inosine monophosphate biosynthesis, PRPP + glutamine => IMP" MISC Information systems Nucleotide TRUE
+K11787 phosphoribosylamine--glycine ligase [EC:6.3.4.13] [RN:R04144] "Inosine monophosphate biosynthesis, PRPP + glutamine => IMP" MISC Information systems Nucleotide TRUE
+K11788 phosphoribosylamine--glycine ligase [EC:6.3.4.13] [RN:R04144] "Inosine monophosphate biosynthesis, PRPP + glutamine => IMP" MISC Information systems Nucleotide TRUE
+K13713 fusion protein PurCD [EC:6.3.2.6 6.3.4.13] [RN:R04144 R04591] "Inosine monophosphate biosynthesis, PRPP + glutamine => IMP" MISC Information systems Nucleotide TRUE
+K00601 phosphoribosylglycinamide formyltransferase [EC:2.1.2.2] [RN:R04325] "Inosine monophosphate biosynthesis, PRPP + glutamine => IMP" MISC Information systems Nucleotide TRUE
+K11175 phosphoribosylglycinamide formyltransferase [EC:2.1.2.2] [RN:R04325] "Inosine monophosphate biosynthesis, PRPP + glutamine => IMP" MISC Information systems Nucleotide TRUE
+K08289 phosphoribosylglycinamide formyltransferase [EC:2.1.2.2] [RN:R04325] "Inosine monophosphate biosynthesis, PRPP + glutamine => IMP" MISC Information systems Nucleotide TRUE
+K01492 phosphoribosylglycinamide formyltransferase [EC:2.1.2.2] [RN:R04325] "Inosine monophosphate biosynthesis, PRPP + glutamine => IMP" MISC Information systems Nucleotide TRUE
+K01952 phosphoribosylformylglycinamidine synthase [EC:6.3.5.3] [RN:R04463] "Inosine monophosphate biosynthesis, PRPP + glutamine => IMP" MISC Information systems Nucleotide TRUE
+K01933 phosphoribosylformylglycinamidine cyclo-ligase [EC:6.3.3.1] [RN:R04208] "Inosine monophosphate biosynthesis, PRPP + glutamine => IMP" MISC Information systems Nucleotide TRUE
+K01587 phosphoribosylaminoimidazole carboxylase [EC:4.1.1.21] [RN:R04209] "Inosine monophosphate biosynthesis, PRPP + glutamine => IMP" MISC Information systems Nucleotide TRUE
+K11808 phosphoribosylaminoimidazole carboxylase [EC:4.1.1.21] [RN:R04209] "Inosine monophosphate biosynthesis, PRPP + glutamine => IMP" MISC Information systems Nucleotide TRUE
+K01589 5-(carboxyamino)imidazole ribonucleotide synthase [EC:6.3.4.18] [RN:R07405] "Inosine monophosphate biosynthesis, PRPP + glutamine => IMP" MISC Information systems Nucleotide TRUE
+K01588 5-(carboxyamino)imidazole ribonucleotide mutase [EC:5.4.99.18] [RN:R07404] "Inosine monophosphate biosynthesis, PRPP + glutamine => IMP" MISC Information systems Nucleotide TRUE
+K01923 phosphoribosylaminoimidazole-succinocarboxamide synthase [EC:6.3.2.6] [RN:R04591] "Inosine monophosphate biosynthesis, PRPP + glutamine => IMP" MISC Information systems Nucleotide TRUE
+K01756 adenylosuccinate lyase [EC:4.3.2.2] [RN:R04559] "Inosine monophosphate biosynthesis, PRPP + glutamine => IMP" MISC Information systems Nucleotide TRUE
+K00602 phosphoribosylaminoimidazolecarboxamide formyltransferase / IMP cyclohydrolase [EC:2.1.2.3 3.5.4.10] [RN:R04560 R01127] "Inosine monophosphate biosynthesis, PRPP + glutamine => IMP" MISC Information systems Nucleotide TRUE
+K06863 5-formaminoimidazole-4-carboxamide-1-(beta)-D-ribofuranosyl 5'-monophosphate synthetase [EC:6.3.4.23] [RN:R06975] "Inosine monophosphate biosynthesis, PRPP + glutamine => IMP" MISC Information systems Nucleotide TRUE
+K11176 IMP cyclohydrolase [EC:3.5.4.10] [RN:R01127] "Inosine monophosphate biosynthesis, PRPP + glutamine => IMP" MISC Information systems Nucleotide TRUE
+K00088 IMP dehydrogenase [EC:1.1.1.205] [RN:R01130] "Guanine ribonucleotide biosynthesis IMP => GDP,GTP" MISC Information systems Nucleotide TRUE
+K01951 GMP synthase [EC:6.3.5.2] [RN:R01230 R01231] "Guanine ribonucleotide biosynthesis IMP => GDP,GTP" MISC Information systems Nucleotide TRUE
+K00942 guanylate kinase [EC:2.7.4.8] [RN:R00332] "Guanine ribonucleotide biosynthesis IMP => GDP,GTP" MISC Information systems Nucleotide TRUE
+K00940 nucleoside-diphosphate kinase [EC:2.7.4.6] [RN:R00330] "Guanine ribonucleotide biosynthesis IMP => GDP,GTP" MISC Information systems Nucleotide TRUE
+K00873 pyruvate kinase [EC:2.7.1.40] [RN:R00430] "Guanine ribonucleotide biosynthesis IMP => GDP,GTP" MISC Information systems Nucleotide TRUE
+K12406 pyruvate kinase [EC:2.7.1.40] [RN:R00430] "Guanine ribonucleotide biosynthesis IMP => GDP,GTP" MISC Information systems Nucleotide TRUE
+K00844 hexokinase [EC:2.7.1.1] [RN:R01786] "Nucleotide sugar biosynthesis, glucose => UDP-glucose" MISC Information systems Nucleotide TRUE
+K00845 glucokinase [EC:2.7.1.2] [RN:R01786] "Nucleotide sugar biosynthesis, glucose => UDP-glucose" MISC Information systems Nucleotide TRUE
+K12407 glucokinase [EC:2.7.1.2] [RN:R01786] "Nucleotide sugar biosynthesis, glucose => UDP-glucose" MISC Information systems Nucleotide TRUE
+K00886 polyphosphate glucokinase [EC:2.7.1.63] [RN:R02189] "Nucleotide sugar biosynthesis, glucose => UDP-glucose" MISC Information systems Nucleotide TRUE
+K01835 phosphoglucomutase [EC:5.4.2.2] [RN:R00959] "Nucleotide sugar biosynthesis, glucose => UDP-glucose" MISC Information systems Nucleotide TRUE
+K00963 UTP--glucose-1-phosphate uridylyltransferase [EC:2.7.7.9] [RN:R00289] "Nucleotide sugar biosynthesis, glucose => UDP-glucose" MISC Information systems Nucleotide TRUE
+K00849 galactokinase [EC:2.7.1.6] [RN:R01092] "Nucleotide sugar biosynthesis, galactose => UDP-galactose" MISC Information systems Nucleotide TRUE
+K00965 UDPglucose--hexose-1-phosphate uridylyltransferase [EC:2.7.7.12] [RN:R00955] "Nucleotide sugar biosynthesis, galactose => UDP-galactose" MISC Information systems Nucleotide TRUE
+K01939 adenylosuccinate synthase [EC:6.3.4.4] [RN:R01135] "Adenine ribonucleotide biosynthesis, IMP => ADP,ATP" MISC Information systems Nucleotide TRUE
+K01756 adenylosuccinate lyase [EC:4.3.2.2] [RN:R01083] "Adenine ribonucleotide biosynthesis, IMP => ADP,ATP" MISC Information systems Nucleotide TRUE
+K00939 adenylate kinase [EC:2.7.4.3] [RN:R00127] "Adenine ribonucleotide biosynthesis, IMP => ADP,ATP" MISC Information systems Nucleotide TRUE
+K18532 adenylate kinase [EC:2.7.4.3] [RN:R00127] "Adenine ribonucleotide biosynthesis, IMP => ADP,ATP" MISC Information systems Nucleotide TRUE
+K18533 adenylate kinase [EC:2.7.4.3] [RN:R00127] "Adenine ribonucleotide biosynthesis, IMP => ADP,ATP" MISC Information systems Nucleotide TRUE
+K00944 nucleoside-triphosphate--adenylate kinase [EC:2.7.4.10] [RN:R00333] "Adenine ribonucleotide biosynthesis, IMP => ADP,ATP" MISC Information systems Nucleotide TRUE
+K00940 nucleoside-diphosphate kinase [EC:2.7.4.6] [RN:R00124] "Adenine ribonucleotide biosynthesis, IMP => ADP,ATP" MISC Information systems Nucleotide TRUE
+K00873 pyruvate kinase [EC:2.7.1.40] [RN:R00200] "Adenine ribonucleotide biosynthesis, IMP => ADP,ATP" MISC Information systems Nucleotide TRUE
+K12406 pyruvate kinase [EC:2.7.1.40] [RN:R00200] "Adenine ribonucleotide biosynthesis, IMP => ADP,ATP" MISC Information systems Nucleotide TRUE
+K11540 carbamoyl-phosphate synthase [EC:6.3.5.5] [RN:R00575] "Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP" MISC Information systems Nucleotide TRUE
+K11541 carbamoyl-phosphate synthase [EC:6.3.5.5] [RN:R00575] "Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP" MISC Information systems Nucleotide TRUE
+K01465 dihydroorotase [EC:3.5.2.3] [RN:R01993] "Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP" MISC Information systems Nucleotide TRUE
+K01954 carbamoyl-phosphate synthase [EC:6.3.5.5] [RN:R00575] "Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP" MISC Information systems Nucleotide TRUE
+K01955 carbamoyl-phosphate synthase [EC:6.3.5.5] [RN:R00575] "Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP" MISC Information systems Nucleotide TRUE
+K01956 carbamoyl-phosphate synthase [EC:6.3.5.5] [RN:R00575] "Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP" MISC Information systems Nucleotide TRUE
+K00609 aspartate carbamoyltransferase [EC:2.1.3.2] [RN:R01397] "Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP" MISC Information systems Nucleotide TRUE
+K00610 aspartate carbamoyltransferase [EC:2.1.3.2] [RN:R01397] "Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP" MISC Information systems Nucleotide TRUE
+K00608 aspartate carbamoyltransferase [EC:2.1.3.2] [RN:R01397] "Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP" MISC Information systems Nucleotide TRUE
+K00226 dihydroorotate dehydrogenase [EC:1.3.98.1] [RN:R01867] "Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP" MISC Information systems Nucleotide TRUE
+K00254 dihydroorotate dehydrogenase [EC:1.3.5.2] [RN:R01868] "Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP" MISC Information systems Nucleotide TRUE
+K17828 dihydroorotate dehydrogenase [EC:1.3.1.14] [RN:R01869] "Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP" MISC Information systems Nucleotide TRUE
+K13421 orotate phosphoribosyltransferase [EC:2.4.2.10] [RN:R01870] "Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP" MISC Information systems Nucleotide TRUE
+K00762 orotate phosphoribosyltransferase [EC:2.4.2.10] [RN:R01870] "Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP" MISC Information systems Nucleotide TRUE
+K01591 orotidine-5'-phosphate decarboxylase [EC:4.1.1.23] [RN:R00965] "Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP" MISC Information systems Nucleotide TRUE
+K13800 cytidylate kinase [EC:2.7.4.14] [RN:R00158] "Pyrimidine ribonucleotide biosynthesis, UMP => UDP/UTP,CDP/CTP" MISC Information systems Nucleotide TRUE
+K13809 cytidylate kinase [EC:2.7.4.14] [RN:R00158] "Pyrimidine ribonucleotide biosynthesis, UMP => UDP/UTP,CDP/CTP" MISC Information systems Nucleotide TRUE
+K00945 cytidylate kinase [EC:2.7.4.14] [RN:R00158] "Pyrimidine ribonucleotide biosynthesis, UMP => UDP/UTP,CDP/CTP" MISC Information systems Nucleotide TRUE
+K13799 cytidylate kinase [EC:2.7.4.14] [RN:R00158] "Pyrimidine ribonucleotide biosynthesis, UMP => UDP/UTP,CDP/CTP" MISC Information systems Nucleotide TRUE
+K00940 nucleoside-diphosphate kinase [EC:2.7.4.6] [RN:R00156] "Pyrimidine ribonucleotide biosynthesis, UMP => UDP/UTP,CDP/CTP" MISC Information systems Nucleotide TRUE
+K18533 nucleoside-diphosphate kinase [EC:2.7.4.6] [RN:R00156] "Pyrimidine ribonucleotide biosynthesis, UMP => UDP/UTP,CDP/CTP" MISC Information systems Nucleotide TRUE
+K01937 CTP synthase [EC:6.3.4.2] [RN:R00571 R00573] "Pyrimidine ribonucleotide biosynthesis, UMP => UDP/UTP,CDP/CTP" MISC Information systems Nucleotide TRUE
+K00524 ribonucleoside-diphosphate reductase [EC:1.17.4.1] [RN:R02024] "Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP" MISC Information systems Nucleotide TRUE
+K00525 ribonucleoside-diphosphate reductase [EC:1.17.4.1] [RN:R02024] "Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP" MISC Information systems Nucleotide TRUE
+K00526 ribonucleoside-diphosphate reductase [EC:1.17.4.1] [RN:R02024] "Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP" MISC Information systems Nucleotide TRUE
+K10807 ribonucleoside-diphosphate reductase [EC:1.17.4.1] [RN:R02024] "Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP" MISC Information systems Nucleotide TRUE
+K10808 ribonucleoside-diphosphate reductase [EC:1.17.4.1] [RN:R02024] "Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP" MISC Information systems Nucleotide TRUE
+K00940 nucleoside-diphosphate kinase [EC:2.7.4.6] [RN:R02326 R02093] "Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP" MISC Information systems Nucleotide TRUE
+K18533 nucleoside-diphosphate kinase [EC:2.7.4.6] [RN:R02326 R02093] "Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP" MISC Information systems Nucleotide TRUE
+K00527 ribonucleoside-triphosphate reductase [EC:1.17.4.2 1.1.98.6] [RN:R02022 R11636] "Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP" MISC Information systems Nucleotide TRUE
+K21636 ribonucleoside-triphosphate reductase [EC:1.17.4.2 1.1.98.6] [RN:R02022 R11636] "Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP" MISC Information systems Nucleotide TRUE
+K01494 dCTP deaminase [EC:3.5.4.13] [RN:R02325] "Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP" MISC Information systems Nucleotide TRUE
+K01520 dUTP pyrophosphatase [EC:3.6.1.23] [RN:R02100] "Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP" MISC Information systems Nucleotide TRUE
+K00560 thymidylate synthase [EC:2.1.1.45] [RN:R02101] "Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP" MISC Information systems Nucleotide TRUE
+K13998 thymidylate synthase [EC:2.1.1.45] [RN:R02101] "Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP" MISC Information systems Nucleotide TRUE
+K00943 dTMP kinase [EC:2.7.4.9] [RN:R02094] "Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP" MISC Information systems Nucleotide TRUE
+K00963 UGP2; Glc-1P -> UDP-Glc [EC:2.7.7.9] "Nucleotide sugar biosynthesis, eukaryotes" MISC Information systems Nucleotide TRUE
+K01784 GALE; UDP-Glc -> UDP-Gal [EC:5.1.3.2] "Nucleotide sugar biosynthesis, eukaryotes" MISC Information systems Nucleotide TRUE
+K00972 UAP1; GlcNAc-1P -> UDP-GlcNAc [EC:2.7.7.23] "Nucleotide sugar biosynthesis, eukaryotes" MISC Information systems Nucleotide TRUE
+K00012 UGDH; UDP-Glc -> UDP-GlcA [EC:1.1.1.22] "Nucleotide sugar biosynthesis, eukaryotes" MISC Information systems Nucleotide TRUE
+K08678 UXS1; UDP-GlcA -> UDP-Xyl [EC:4.1.1.35] "Nucleotide sugar biosynthesis, eukaryotes" MISC Information systems Nucleotide TRUE
+K00966 GMPP; Man-1P -> GDP-Man [EC:2.7.7.13] "Nucleotide sugar biosynthesis, eukaryotes" MISC Information systems Nucleotide TRUE
+K00971 GMPP; Man-1P -> GDP-Man [EC:2.7.7.13] "Nucleotide sugar biosynthesis, eukaryotes" MISC Information systems Nucleotide TRUE
+K00844 hexokinase/glucokinase [EC:2.7.1.1 2.7.1.2] [RN:R01786] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K12407 hexokinase/glucokinase [EC:2.7.1.1 2.7.1.2] [RN:R01786] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K00845 hexokinase/glucokinase [EC:2.7.1.1 2.7.1.2] [RN:R01786] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K00886 polyphosphate glucokinase [EC:2.7.1.63] [RN:R02189] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K08074 K00918 ADP-dependent glucokinase [EC:2.7.1.147] [RN:R09085] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K00918 ADP-dependent phosphofructokinase [EC:2.7.1.146] [RN:R09084] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K01810 glucose-6-phosphate isomerase [EC:5.3.1.9] [RN:R02740] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K06859 glucose-6-phosphate isomerase [EC:5.3.1.9] [RN:R02740] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K13810 glucose-6-phosphate isomerase [EC:5.3.1.9] [RN:R02740] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K15916 glucose-6-phosphate isomerase [EC:5.3.1.9] [RN:R02740] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K00850 6-phosphofructokinase [EC:2.7.1.11] [RN:R04779] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K16370 6-phosphofructokinase [EC:2.7.1.11] [RN:R04779] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K01623 fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01070] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K01624 fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01070] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K11645 fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01070] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K16305 fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01070] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K16306 fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01070] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K01803 triosephosphate isomerase [EC:5.3.1.1] [RN:R01015] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K00134 glyceraldehyde 3-phosphate dehydrogenase [EC:1.2.1.12 1.2.1.59] [RN:R01061 R01063] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K00150 glyceraldehyde 3-phosphate dehydrogenase [EC:1.2.1.12 1.2.1.59] [RN:R01061 R01063] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K00927 phosphoglycerate kinase [EC:2.7.2.3] [RN:R01512] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K11389 glyceraldehyde-3-phosphate dehydrogenase (ferredoxin) [EC:1.2.7.6] [RN:R07159] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K01834 phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K15633 phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K15634 phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K15635 phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K01689 enolase [EC:4.2.1.11] [RN:R00658] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K00873 pyruvate kinase [EC:2.7.1.40] [RN:R00200] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K12406 pyruvate kinase [EC:2.7.1.40] [RN:R00200] "Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate" carbon utilization central carbon glycolysis TRUE
+K01803 triosephosphate isomerase [EC:5.3.1.1] [RN:R01015] "Glycolysis, core module involving three-carbon compounds" carbon utilization central carbon glycolysis TRUE
+K00134 glyceraldehyde 3-phosphate dehydrogenase [EC:1.2.1.12 1.2.1.59] [RN:R01061 R01063] "Glycolysis, core module involving three-carbon compounds" carbon utilization central carbon glycolysis TRUE
+K00150 glyceraldehyde 3-phosphate dehydrogenase [EC:1.2.1.12 1.2.1.59] [RN:R01061 R01063] "Glycolysis, core module involving three-carbon compounds" carbon utilization central carbon glycolysis TRUE
+K00927 phosphoglycerate kinase [EC:2.7.2.3] [RN:R01512] "Glycolysis, core module involving three-carbon compounds" carbon utilization central carbon glycolysis TRUE
+K11389 glyceraldehyde-3-phosphate dehydrogenase (ferredoxin) [EC:1.2.7.6] [RN:R07159] "Glycolysis, core module involving three-carbon compounds" carbon utilization central carbon glycolysis TRUE
+K01834 phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] "Glycolysis, core module involving three-carbon compounds" carbon utilization central carbon glycolysis TRUE
+K15633 phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] "Glycolysis, core module involving three-carbon compounds" carbon utilization central carbon glycolysis TRUE
+K15634 phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] "Glycolysis, core module involving three-carbon compounds" carbon utilization central carbon glycolysis TRUE
+K15635 phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] "Glycolysis, core module involving three-carbon compounds" carbon utilization central carbon glycolysis TRUE
+K01689 enolase [EC:4.2.1.11] [RN:R00658] "Glycolysis, core module involving three-carbon compounds" carbon utilization central carbon glycolysis TRUE
+K00873 pyruvate kinase [EC:2.7.1.40] [RN:R00200] "Glycolysis, core module involving three-carbon compounds" carbon utilization central carbon glycolysis TRUE
+K12406 pyruvate kinase [EC:2.7.1.40] [RN:R00200] "Glycolysis, core module involving three-carbon compounds" carbon utilization central carbon glycolysis TRUE
+K01596 phosphoenolpyruvate carboxykinase [EC:4.1.1.32 4.1.1.49] [RN:R00431 R00726 R00341] "Gluconeogenesis, oxaloacetate => fructose-6P" carbon utilization central carbon glycolysis TRUE
+K01610 phosphoenolpyruvate carboxykinase [EC:4.1.1.32 4.1.1.49] [RN:R00431 R00726 R00341] "Gluconeogenesis, oxaloacetate => fructose-6P" carbon utilization central carbon glycolysis TRUE
+K01689 enolase [EC:4.2.1.11] [RN:R00658] "Gluconeogenesis, oxaloacetate => fructose-6P" carbon utilization central carbon glycolysis TRUE
+K01834 phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] "Gluconeogenesis, oxaloacetate => fructose-6P" carbon utilization central carbon glycolysis TRUE
+K15633 phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] "Gluconeogenesis, oxaloacetate => fructose-6P" carbon utilization central carbon glycolysis TRUE
+K15634 phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] "Gluconeogenesis, oxaloacetate => fructose-6P" carbon utilization central carbon glycolysis TRUE
+K15635 phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] "Gluconeogenesis, oxaloacetate => fructose-6P" carbon utilization central carbon glycolysis TRUE
+K00927 phosphoglycerate kinase [EC:2.7.2.3] [RN:R01512] "Gluconeogenesis, oxaloacetate => fructose-6P" carbon utilization central carbon glycolysis TRUE
+K00134 glyceraldehyde 3-phosphate dehydrogenase [EC:1.2.1.12 1.2.1.59] [RN:R01061 R01063] "Gluconeogenesis, oxaloacetate => fructose-6P" carbon utilization central carbon glycolysis TRUE
+K00150 glyceraldehyde 3-phosphate dehydrogenase [EC:1.2.1.12 1.2.1.59] [RN:R01061 R01063] "Gluconeogenesis, oxaloacetate => fructose-6P" carbon utilization central carbon glycolysis TRUE
+K01803 triosephosphate isomerase (TIM) [EC:5.3.1.1] [RN:R01015] "Gluconeogenesis, oxaloacetate => fructose-6P" carbon utilization central carbon glycolysis TRUE
+K01623 fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01070] "Gluconeogenesis, oxaloacetate => fructose-6P" carbon utilization central carbon glycolysis TRUE
+K01624 fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01070] "Gluconeogenesis, oxaloacetate => fructose-6P" carbon utilization central carbon glycolysis TRUE
+K11645 fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01070] "Gluconeogenesis, oxaloacetate => fructose-6P" carbon utilization central carbon glycolysis TRUE
+K03841 "fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R04780]" "Gluconeogenesis, oxaloacetate => fructose-6P" carbon utilization central carbon glycolysis TRUE
+K02446 "fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R04780]" "Gluconeogenesis, oxaloacetate => fructose-6P" carbon utilization central carbon glycolysis TRUE
+K11532 "fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R04780]" "Gluconeogenesis, oxaloacetate => fructose-6P" carbon utilization central carbon glycolysis TRUE
+K01086 "fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R04780]" "Gluconeogenesis, oxaloacetate => fructose-6P" carbon utilization central carbon glycolysis TRUE
+K04041 "fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R04780]" "Gluconeogenesis, oxaloacetate => fructose-6P" carbon utilization central carbon glycolysis TRUE
+K01622 "fructose 1,6-bisphosphate aldolase/phosphatase [EC:4.1.2.13 3.1.3.11] [RN:R01070 R04780]" "Gluconeogenesis, oxaloacetate => fructose-6P" carbon utilization central carbon glycolysis TRUE
+K00036 glucose-6-phosphate 1-dehydrogenase [EC:1.1.1.49 1.1.1.363] [RN:R02736 R10907] "Entner-Doudoroff pathway, glucose-6P => glyceraldehyde-3P + pyruvate" carbon utilization central carbon glycolysis TRUE
+K01057 6-phosphogluconolactonase [EC:3.1.1.31] [RN:R02035] "Entner-Doudoroff pathway, glucose-6P => glyceraldehyde-3P + pyruvate" carbon utilization central carbon glycolysis TRUE
+K07404 6-phosphogluconolactonase [EC:3.1.1.31] [RN:R02035] "Entner-Doudoroff pathway, glucose-6P => glyceraldehyde-3P + pyruvate" carbon utilization central carbon glycolysis TRUE
+K01690 phosphogluconate dehydratase [EC:4.2.1.12] [RN:R02036] "Entner-Doudoroff pathway, glucose-6P => glyceraldehyde-3P + pyruvate" carbon utilization central carbon glycolysis TRUE
+K01625 2-dehydro-3-deoxyphosphogluconate aldolase [EC:4.1.2.14] [RN:R05605] "Entner-Doudoroff pathway, glucose-6P => glyceraldehyde-3P + pyruvate" carbon utilization central carbon glycolysis TRUE
+K01647 citrate synthase [EC:2.3.3.1] [RN:R00351] Glyoxylate cycle carbon utilization central carbon glycolysis TRUE
+K01681 aconitate hydratase [EC:4.2.1.3] [RN:R01325 R01900] Glyoxylate cycle carbon utilization central carbon glycolysis TRUE
+K01682 aconitate hydratase [EC:4.2.1.3] [RN:R01325 R01900] Glyoxylate cycle carbon utilization central carbon glycolysis TRUE
+K01637 isocitrate lyase [EC:4.1.3.1] [RN:R00479] Glyoxylate cycle carbon utilization central carbon glycolysis TRUE
+K01638 malate synthase [EC:2.3.3.9] [RN:R00472] Glyoxylate cycle carbon utilization central carbon glycolysis TRUE
+K19282 bifunctional (S)-malyl-CoA lyase/thioesterase [EC:4.1.3.24 3.1.2.30] [RN:R00473 R10612] Glyoxylate cycle carbon utilization central carbon glycolysis TRUE
+K00026 malate dehydrogenase [EC:1.1.1.37] [RN:R00342] Glyoxylate cycle carbon utilization central carbon glycolysis TRUE
+K00025 malate dehydrogenase [EC:1.1.1.37] [RN:R00342] Glyoxylate cycle carbon utilization central carbon glycolysis TRUE
+K00024 malate dehydrogenase [EC:1.1.1.37] [RN:R00342] Glyoxylate cycle carbon utilization central carbon glycolysis TRUE
+K05308 gluconate dehydratase [EC:4.2.1.140] [RN:R01538] "Semi-phosphorylative Entner-Doudoroff pathway, gluconate => glycerate-3P" carbon utilization central carbon glycolysis TRUE
+K00874 2-dehydro-3-deoxygluconokinase [EC:2.7.1.45] [RN:R01541] "Semi-phosphorylative Entner-Doudoroff pathway, gluconate => glycerate-3P" carbon utilization central carbon glycolysis TRUE
+K01625 2-dehydro-3-deoxyphosphogluconate aldolase [EC:4.1.2.14] [RN:R05605] "Semi-phosphorylative Entner-Doudoroff pathway, gluconate => glycerate-3P" carbon utilization central carbon glycolysis TRUE
+K00134 glyceraldehyde 3-phosphate dehydrogenase [EC:1.2.1.12] [RN:R01061] "Semi-phosphorylative Entner-Doudoroff pathway, gluconate => glycerate-3P" carbon utilization central carbon glycolysis TRUE
+K00927 phosphoglycerate kinase [EC:2.7.2.3] [RN:R01512] "Semi-phosphorylative Entner-Doudoroff pathway, gluconate => glycerate-3P" carbon utilization central carbon glycolysis TRUE
+K00131 glyceraldehyde-3-phosphate dehydrogenase (NADP+) [EC:1.2.1.9] [RN:R01058] "Semi-phosphorylative Entner-Doudoroff pathway, gluconate => glycerate-3P" carbon utilization central carbon glycolysis TRUE
+K18978 glyceraldehyde-3-phosphate dehydrogenase [NAD(P)+] [EC:1.2.1.90] [RN:R01058 R10860] "Semi-phosphorylative Entner-Doudoroff pathway, gluconate => glycerate-3P" carbon utilization central carbon glycolysis TRUE
+K05308 gluconate/galactonate dehydratase [EC:4.2.1.140] [RN:R01538 R03033] "Non-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate" carbon utilization central carbon glycolysis TRUE
+K11395 2-dehydro-3-deoxy-phosphogluconate/2-dehydro-3-deoxy-6-phosphogalactonate aldolase [EC:4.1.2.55] [RN:R08570 R10616] "Non-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate" carbon utilization central carbon glycolysis TRUE
+K18127 2-dehydro-3-deoxy-D-gluconate aldolase [EC:4.1.2.51] [RN:R08570 R10616] "Non-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate" carbon utilization central carbon glycolysis TRUE
+K18020 glyceraldehyde dehydrogenase large subunit [EC:1.2.99.8] [RN:R10324] "Non-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate" carbon utilization central carbon glycolysis TRUE
+K18021 glyceraldehyde dehydrogenase large subunit [EC:1.2.99.8] [RN:R10324] "Non-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate" carbon utilization central carbon glycolysis TRUE
+K18022 glyceraldehyde dehydrogenase large subunit [EC:1.2.99.8] [RN:R10324] "Non-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate" carbon utilization central carbon glycolysis TRUE
+K18128 glyceraldehyde dehydrogenase [EC:1.2.1.89] [RN:R10615] "Non-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate" carbon utilization central carbon glycolysis TRUE
+K03738 aldehyde:ferredoxin oxidoreductase [EC:1.2.7.5] [RN:R08571] "Non-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate" carbon utilization central carbon glycolysis TRUE
+K01684 galactonate dehydratase [EC:4.2.1.6] [RN:R03033] "D-galactonate degradation, De Ley-Doudoroff pathway, D-galactonate => glycerate-3P" carbon utilization central carbon glycolysis TRUE
+K00883 2-dehydro-3-deoxygalactonokinase [EC:2.7.1.58] [RN:R03387] "D-galactonate degradation, De Ley-Doudoroff pathway, D-galactonate => glycerate-3P" carbon utilization central carbon glycolysis TRUE
+K01631 2-dehydro-3-deoxyphosphogalactonate aldolase [EC:4.1.2.21] [RN:R01064] "D-galactonate degradation, De Ley-Doudoroff pathway, D-galactonate => glycerate-3P" carbon utilization central carbon glycolysis TRUE
+K00134 glyceraldehyde 3-phosphate dehydrogenase [EC:1.2.1.12] [RN:R01061] "D-galactonate degradation, De Ley-Doudoroff pathway, D-galactonate => glycerate-3P" carbon utilization central carbon glycolysis TRUE
+K00927 phosphoglycerate kinase [EC:2.7.2.3] [RN:R01512] "D-galactonate degradation, De Ley-Doudoroff pathway, D-galactonate => glycerate-3P" carbon utilization central carbon glycolysis TRUE
+K01812 glucuronate isomerase [EC:5.3.1.12] [RN:R01983] "D-Galacturonate degradation (bacteria), D-galacturonate => pyruvate + D-glyceraldehyde 3P" carbon utilization central carbon glycolysis TRUE
+K00041 tagaturonate reductase [EC:1.1.1.58] [RN:R02555] "D-Galacturonate degradation (bacteria), D-galacturonate => pyruvate + D-glyceraldehyde 3P" carbon utilization central carbon glycolysis TRUE
+K01685 altronate hydrolase [EC:4.2.1.7] [RN:R01540] "D-Galacturonate degradation (bacteria), D-galacturonate => pyruvate + D-glyceraldehyde 3P" carbon utilization central carbon glycolysis TRUE
+K16849 altronate hydrolase [EC:4.2.1.7] [RN:R01540] "D-Galacturonate degradation (bacteria), D-galacturonate => pyruvate + D-glyceraldehyde 3P" carbon utilization central carbon glycolysis TRUE
+K16850 altronate hydrolase [EC:4.2.1.7] [RN:R01540] "D-Galacturonate degradation (bacteria), D-galacturonate => pyruvate + D-glyceraldehyde 3P" carbon utilization central carbon glycolysis TRUE
+K00874 2-dehydro-3-deoxygluconokinase [EC:2.7.1.45] [RN:R01541] "D-Galacturonate degradation (bacteria), D-galacturonate => pyruvate + D-glyceraldehyde 3P" carbon utilization central carbon glycolysis TRUE
+K01625 2-dehydro-3-deoxy-phosphogluconate aldolase [EC:4.1.2.14] [RN:R05605] "D-Galacturonate degradation (bacteria), D-galacturonate => pyruvate + D-glyceraldehyde 3P" carbon utilization central carbon glycolysis TRUE
+K17463 2-dehydro-3-deoxy-phosphogluconate aldolase [EC:4.1.2.14] [RN:R05605] "D-Galacturonate degradation (bacteria), D-galacturonate => pyruvate + D-glyceraldehyde 3P" carbon utilization central carbon glycolysis TRUE
+K01785 aldose 1-epimerase [EC:5.1.3.3] [RN:R10619] "Galactose degradation, Leloir pathway, galactose => alpha-D-glucose-1P" carbon utilization central carbon glycolysis TRUE
+K00849 galactokinase [EC:2.7.1.6] [RN:R01092] "Galactose degradation, Leloir pathway, galactose => alpha-D-glucose-1P" carbon utilization central carbon glycolysis TRUE
+K00965 UDPglucose--hexose-1-phosphate uridylyltransferase [EC:2.7.7.12] [RN:R00955] "Galactose degradation, Leloir pathway, galactose => alpha-D-glucose-1P" carbon utilization central carbon glycolysis TRUE
+K01784 UDP-glucose 4-epimerase [EC:5.1.3.2] [RN:R00291] "Galactose degradation, Leloir pathway, galactose => alpha-D-glucose-1P" carbon utilization central carbon glycolysis TRUE
+K05308 gluconate dehydratase [EC:4.2.1.140] [RN:R01538 R03033] "Semi-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate-3P" carbon utilization central carbon glycolysis TRUE
+K18126 2-dehydro-3-deoxygluconokinase [EC:2.7.1.178] [RN:R01541 R03387] "Semi-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate-3P" carbon utilization central carbon glycolysis TRUE
+K11395 2-dehydro-3-deoxyphosphogluconate aldolase [EC:4.1.2.55] [RN:R05605 R01064] "Semi-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate-3P" carbon utilization central carbon glycolysis TRUE
+K00131 glyceraldehyde-3-phosphate dehydrogenase (NADP+) [EC:1.2.1.9] [RN:R01058] "Semi-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate-3P" carbon utilization central carbon glycolysis TRUE
+K18978 glyceraldehyde-3-phosphate dehydrogenase [NAD(P)+] [EC:1.2.1.90] [RN:R01058 R10860] "Semi-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate-3P" carbon utilization central carbon glycolysis TRUE
+K06073 "ABC.VB12.P, btuC; vitamin B12 transport system permease protein" Cobalamin salvage Transporters Vitamin B12 transport system TRUE
+K06074 "ABC.VB12.A, btuD; vitamin B12 transport system ATP-binding protein [EC:3.6.3.33]" Cobalamin salvage Transporters Vitamin B12 transport system TRUE
+K06858 "ABC.VB12.S1, btuF; vitamin B12 transport system substrate-binding protein" Cobalamin salvage Transporters Vitamin B12 transport system TRUE
+K16092 btuB; vitamin B12 transporter Cobalamin salvage Transporters Vitamin B12 transport system TRUE
+K13811 sulfate adenylyltransferase [EC:2.7.7.4] [RN:R00529] "Assimilatory sulfate reduction, sulfate => H2S" Energy Sulfur TRUE
+K00958 sulfate adenylyltransferase [EC:2.7.7.4] [RN:R00529] "Assimilatory sulfate reduction, sulfate => H2S" Energy Sulfur TRUE
+K00860 adenylylsulfate kinase [EC:2.7.1.25] [RN:R00509] "Assimilatory sulfate reduction, sulfate => H2S" Energy Sulfur TRUE
+K00955 sulfate adenylyltransferase [EC:2.7.7.4] [RN:R00529] "Assimilatory sulfate reduction, sulfate => H2S" Energy Sulfur TRUE
+K00957 sulfate adenylyltransferase [EC:2.7.7.4] [RN:R00529] "Assimilatory sulfate reduction, sulfate => H2S" Energy Sulfur TRUE
+K00956 sulfate adenylyltransferase [EC:2.7.7.4] [RN:R00529] "Assimilatory sulfate reduction, sulfate => H2S" Energy Sulfur TRUE
+K00390 phosphoadenosine phosphosulfate reductase [EC:1.8.4.8] [RN:R02021] "Assimilatory sulfate reduction, sulfate => H2S" Energy Sulfur TRUE
+K00380 sulfite reductase (NADPH) [EC:1.8.1.2] [RN:R00858] "Assimilatory sulfate reduction, sulfate => H2S" Energy Sulfur TRUE
+K00381 sulfite reductase (NADPH) [EC:1.8.1.2] [RN:R00858] "Assimilatory sulfate reduction, sulfate => H2S" Energy Sulfur TRUE
+K00392 sulfite reductase (ferredoxin) [EC:1.8.7.1] [RN:R00859] "Assimilatory sulfate reduction, sulfate => H2S" Energy Sulfur TRUE
+K17222 soxA; sulfur-oxidizing protein SoxA "Thiosulfate oxidation by SOX complex, thiosulfate => sulfate" Energy Sulfur TRUE
+K17223 soxX; sulfur-oxidizing protein SoxX "Thiosulfate oxidation by SOX complex, thiosulfate => sulfate" Energy Sulfur TRUE
+K17224 soxB; sulfur-oxidizing protein SoxB "Thiosulfate oxidation by SOX complex, thiosulfate => sulfate" Energy Sulfur TRUE
+K17225 soxC; S-disulfanyl-L-cysteine oxidoreductase SoxC [EC:1.8.2.6] "Thiosulfate oxidation by SOX complex, thiosulfate => sulfate" Energy Sulfur TRUE
+K22622 soxD; S-disulfanyl-L-cysteine oxidoreductase SoxD [EC:1.8.2.6] "Thiosulfate oxidation by SOX complex, thiosulfate => sulfate" Energy Sulfur TRUE
+K17226 soxY; sulfur-oxidizing protein SoxY "Thiosulfate oxidation by SOX complex, thiosulfate => sulfate" Energy Sulfur TRUE
+K17227 soxZ; sulfur-oxidizing protein SoxZ "Thiosulfate oxidation by SOX complex, thiosulfate => sulfate" Energy Sulfur TRUE
+K00956 sulfate adenylyltransferase [EC:2.7.7.4] [RN:R00529] "Dissimilatory sulfate reduction, sulfate => H2S" Energy Sulfur TRUE
+K00957 sulfate adenylyltransferase [EC:2.7.7.4] [RN:R00529] "Dissimilatory sulfate reduction, sulfate => H2S" Energy Sulfur TRUE
+K00958 sulfate adenylyltransferase [EC:2.7.7.4] [RN:R00529] "Dissimilatory sulfate reduction, sulfate => H2S" Energy Sulfur TRUE
+K00394 adenylylsulfate reductase [EC:1.8.99.2] [RN:R08553] "Dissimilatory sulfate reduction, sulfate => H2S" Energy Sulfur TRUE
+K00395 adenylylsulfate reductase [EC:1.8.99.2] [RN:R08553] "Dissimilatory sulfate reduction, sulfate => H2S" Energy Sulfur TRUE
+K11180 "sulfite reductase, dissimilatory-type [EC:1.8.99.5] [RN:R00861]" "Dissimilatory sulfate reduction, sulfate => H2S" Energy Sulfur TRUE
+K11181 "sulfite reductase, dissimilatory-type [EC:1.8.99.5] [RN:R00861]" "Dissimilatory sulfate reduction, sulfate => H2S" Energy Sulfur TRUE
+K08352 thiosulfate reductase / polysulfide reductase chain A [EC:1.8.5.5] Energy Sulfur TRUE
+K01011 rhodanase Energy Sulfur TRUE
+K08357 tetrathionate => thiosulfate Energy Sulfur TRUE
+K01905 "6.2.1.13, acetate---CoA ligase (ADP-forming) subunit alpha" SCFA and alcohol conversions MISC SCFA and alcohol conversions TRUE
+K01067 acetyl-CoA hydrolase [EC:3.1.2.1] SCFA and alcohol conversions MISC SCFA and alcohol conversions TRUE
+K00101 L-lactate dehydrogenase (cytochrome) [EC:1.1.2.3] SCFA and alcohol conversions MISC SCFA and alcohol conversions TRUE
+K03777 D-lactate dehydrogenase (quinone) [EC:1.1.5.12] SCFA and alcohol conversions MISC SCFA and alcohol conversions TRUE
+K00634 phosphate butyryltransferase [EC:2.3.1.19] SCFA and alcohol conversions MISC SCFA and alcohol conversions TRUE
+K00929 butyrate kinase [EC:2.7.2.7] SCFA and alcohol conversions MISC SCFA and alcohol conversions TRUE
+K01896 medium-chain acyl-CoA synthetase [EC:6.2.1.2] SCFA and alcohol conversions MISC SCFA and alcohol conversions TRUE
+K19697 propionate kinase [EC:2.7.2.15] SCFA and alcohol conversions MISC SCFA and alcohol conversions TRUE
+K01026 propionate CoA-transferase [EC:2.8.3.1] SCFA and alcohol conversions MISC SCFA and alcohol conversions TRUE
+K18857 alcohol dehydrogenase [EC:1.1.1.1] SCFA and alcohol conversions MISC SCFA and alcohol conversions TRUE
+K13980 alcohol dehydrogenase [EC:1.1.1.1] SCFA and alcohol conversions MISC SCFA and alcohol conversions TRUE
+K13953 alcohol dehydrogenase [EC:1.1.1.1] SCFA and alcohol conversions MISC SCFA and alcohol conversions TRUE
+K13952 alcohol dehydrogenase [EC:1.1.1.1] SCFA and alcohol conversions MISC SCFA and alcohol conversions TRUE
+K13951 alcohol dehydrogenase [EC:1.1.1.1] SCFA and alcohol conversions MISC SCFA and alcohol conversions TRUE
+K04072 alcohol dehydrogenase [EC:1.1.1.1] SCFA and alcohol conversions MISC SCFA and alcohol conversions TRUE
+K00121 alcohol dehydrogenase [EC:1.1.1.1] SCFA and alcohol conversions MISC SCFA and alcohol conversions TRUE
+K00163 pyruvate dehydrogenase complex [EC:1.2.4.1 2.3.1.12 1.8.1.4] [RN:R00209] "Pyruvate oxidation, pyruvate => acetyl-CoA" carbon utilization pyruvate metabolism TRUE
+K00161 pyruvate dehydrogenase complex [EC:1.2.4.1 2.3.1.12 1.8.1.4] [RN:R00209] "Pyruvate oxidation, pyruvate => acetyl-CoA" carbon utilization pyruvate metabolism TRUE
+K00162 pyruvate dehydrogenase complex [EC:1.2.4.1 2.3.1.12 1.8.1.4] [RN:R00209] "Pyruvate oxidation, pyruvate => acetyl-CoA" carbon utilization pyruvate metabolism TRUE
+K00627 pyruvate dehydrogenase complex [EC:1.2.4.1 2.3.1.12 1.8.1.4] [RN:R00209] "Pyruvate oxidation, pyruvate => acetyl-CoA" carbon utilization pyruvate metabolism TRUE
+K00382 pyruvate dehydrogenase complex [EC:1.2.4.1 2.3.1.12 1.8.1.4] [RN:R00209] "Pyruvate oxidation, pyruvate => acetyl-CoA" carbon utilization pyruvate metabolism TRUE
+K13997 pyruvate dehydrogenase complex [EC:1.2.4.1 2.3.1.12 1.8.1.4] [RN:R00209] "Pyruvate oxidation, pyruvate => acetyl-CoA" carbon utilization pyruvate metabolism TRUE
+K00169 pyruvate:ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] "Pyruvate oxidation, pyruvate => acetyl-CoA" carbon utilization pyruvate metabolism TRUE
+K00170 pyruvate:ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] "Pyruvate oxidation, pyruvate => acetyl-CoA" carbon utilization pyruvate metabolism TRUE
+K00171 pyruvate:ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] "Pyruvate oxidation, pyruvate => acetyl-CoA" carbon utilization pyruvate metabolism TRUE
+K00172 pyruvate:ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] "Pyruvate oxidation, pyruvate => acetyl-CoA" carbon utilization pyruvate metabolism TRUE
+K03737 pyruvate:ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] "Pyruvate oxidation, pyruvate => acetyl-CoA" carbon utilization pyruvate metabolism TRUE
+K00625 phosphate acetyltransferase [EC:2.3.1.8] [RN:R00230] "Phosphate acetyltransferase-acetate kinase pathway, acetyl-CoA => acetate" carbon utilization pyruvate metabolism TRUE
+K13788 phosphate acetyltransferase [EC:2.3.1.8] [RN:R00230] "Phosphate acetyltransferase-acetate kinase pathway, acetyl-CoA => acetate" carbon utilization pyruvate metabolism TRUE
+K15024 phosphate acetyltransferase [EC:2.3.1.8] [RN:R00230] "Phosphate acetyltransferase-acetate kinase pathway, acetyl-CoA => acetate" carbon utilization pyruvate metabolism TRUE
+K00925 acetate kinase [EC:2.7.2.1] [RN:R00315] "Phosphate acetyltransferase-acetate kinase pathway, acetyl-CoA => acetate" carbon utilization pyruvate metabolism TRUE
+K01965 propionyl-CoA carboxylase [EC:6.4.1.3] [RN:R01859] "Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA" carbon utilization pyruvate metabolism TRUE
+K01966 propionyl-CoA carboxylase [EC:6.4.1.3] [RN:R01859] "Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA" carbon utilization pyruvate metabolism TRUE
+K11263 propionyl-CoA carboxylase [EC:6.4.1.3] [RN:R01859] "Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA" carbon utilization pyruvate metabolism TRUE
+K18472 propionyl-CoA carboxylase [EC:6.4.1.3] [RN:R01859] "Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA" carbon utilization pyruvate metabolism TRUE
+K19312 propionyl-CoA carboxylase [EC:6.4.1.3] [RN:R01859] "Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA" carbon utilization pyruvate metabolism TRUE
+K22568 propionyl-CoA carboxylase [EC:6.4.1.3] [RN:R01859] "Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA" carbon utilization pyruvate metabolism TRUE
+K01964 propionyl-CoA carboxylase [EC:6.4.1.3] [RN:R01859] "Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA" carbon utilization pyruvate metabolism TRUE
+K15036 propionyl-CoA carboxylase [EC:6.4.1.3] [RN:R01859] "Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA" carbon utilization pyruvate metabolism TRUE
+K15037 propionyl-CoA carboxylase [EC:6.4.1.3] [RN:R01859] "Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA" carbon utilization pyruvate metabolism TRUE
+K05606 methylmalonyl-CoA/ethylmalonyl-CoA epimerase [EC:5.1.99.1] [RN:R02765] "Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA" carbon utilization pyruvate metabolism TRUE
+K01847 methylmalonyl-CoA mutase [EC:5.4.99.2] [RN:R00833] "Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA" carbon utilization pyruvate metabolism TRUE
+K01848 methylmalonyl-CoA mutase [EC:5.4.99.2] [RN:R00833] "Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA" carbon utilization pyruvate metabolism TRUE
+K01849 methylmalonyl-CoA mutase [EC:5.4.99.2] [RN:R00833] "Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA" carbon utilization pyruvate metabolism TRUE
+K00132 acetaldehyde dehydrogenase (acetylating) fermentation- carbon utilization pyruvate metabolism TRUE
+K13954 alcohol dehydrogenase fermentation- carbon utilization pyruvate metabolism TRUE
+K00001 alcohol dehydrogenase fermentation- carbon utilization pyruvate metabolism TRUE
+K00016 L-lactate dehydrogenase fermentation- carbon utilization pyruvate metabolism TRUE
+K03778 D-lactate dehydrogenase fermentation- carbon utilization pyruvate metabolism TRUE
+K00656 formate acetyltransferase (pyruvate-formate lyase ) pyruvate metabolism carbon utilization pyruvate metabolism TRUE
+K04069 pyruvate formate lyase activating enzyme pyruvate metabolism carbon utilization pyruvate metabolism TRUE
+K04070 putative pyruvate formate lyase activating enzyme pyruvate metabolism carbon utilization pyruvate metabolism TRUE
+K01512 acylphosphatase pyruvate metabolism carbon utilization pyruvate metabolism TRUE
+K00074 3-hydroxybutyryl-CoA dehydrogenase pyruvate metabolism carbon utilization pyruvate metabolism TRUE
+K02703 psbA; photosystem II reaction center D1 protein [EC:1.10.3.9] Photosystem II Energy Photosynthesis TRUE
+K02706 psbD; photosystem II reaction center D2 protein [EC:1.10.3.9] Photosystem II Energy Photosynthesis TRUE
+K02705 psbC; photosystem II CP43 chlorophyll apoprotein Photosystem II Energy Photosynthesis TRUE
+K02704 psbB; photosystem II CP47 chlorophyll apoprotein Photosystem II Energy Photosynthesis TRUE
+K02707 psbE; photosystem II cytochrome b559 subunit alpha Photosystem II Energy Photosynthesis TRUE
+K02708 psbF; photosystem II cytochrome b559 subunit beta Photosystem II Energy Photosynthesis TRUE
+K02635 cytochrome b6 Cytochrome b6f complex Energy Photosynthesis TRUE
+K02637 cytochrome b6-f complex subunit 4 Cytochrome b6f complex Energy Photosynthesis TRUE
+K02634 apocytochrome f Cytochrome b6f complex Energy Photosynthesis TRUE
+K02636 cytochrome b6-f complex iron-sulfur subunit Cytochrome b6f complex Energy Photosynthesis TRUE
+K02642 cytochrome b6-f complex subunit 6 Cytochrome b6f complex Energy Photosynthesis TRUE
+K02643 cytochrome b6-f complex subunit 7 Cytochrome b6f complex Energy Photosynthesis TRUE
+K03689 cytochrome b6-f complex subunit 8 Cytochrome b6f complex Energy Photosynthesis TRUE
+K02640 cytochrome b6-f complex subunit 5 Cytochrome b6f complex Energy Photosynthesis TRUE
+K02689 psaA; photosystem I P700 chlorophyll a apoprotein A1 Photosystem I Energy Photosynthesis TRUE
+K02690 psaB; photosystem I P700 chlorophyll a apoprotein A2 Photosystem I Energy Photosynthesis TRUE
+K02691 psaC; photosystem I subunit VII Photosystem I Energy Photosynthesis TRUE
+K02692 psaD; photosystem I subunit II Photosystem I Energy Photosynthesis TRUE
+K02693 psaE; photosystem I subunit IV Photosystem I Energy Photosynthesis TRUE
+K02694 psaF; photosystem I subunit III Photosystem I Energy Photosynthesis TRUE
+K00281 glycine cleavage system [RN:R01221] Photorespiration Energy Photosynthesis TRUE
+K00283 glycine cleavage system [RN:R01221] Photorespiration Energy Photosynthesis TRUE
+K00605 glycine cleavage system [RN:R01221] Photorespiration Energy Photosynthesis TRUE
+K00382 glycine cleavage system [RN:R01221] Photorespiration Energy Photosynthesis TRUE
+K02437 glycine cleavage system [RN:R01221] Photorespiration Energy Photosynthesis TRUE
+K08928 pufL; photosynthetic reaction center L subunit Anoxygenic photosystem II Energy Photosynthesis TRUE
+K08929 pufM; photosynthetic reaction center M subunit Anoxygenic photosystem II Energy Photosynthesis TRUE
+K08940 pscA; photosystem P840 reaction center large subunit Anoxygenic photosystem I Energy Photosynthesis TRUE
+K08941 pscB; photosystem P840 reaction center iron-sulfur protein Anoxygenic photosystem I Energy Photosynthesis TRUE
+K08942 pscC; photosystem P840 reaction center cytochrome c551 Anoxygenic photosystem I Energy Photosynthesis TRUE
+K08943 pscD; photosystem P840 reaction center protein PscD Anoxygenic photosystem I Energy Photosynthesis TRUE
+K02638 plastocyanin Cytochrome b6f complex Energy Photosynthesis TRUE
+K02639 ferredoxin Cytochrome b6f complex Energy Photosynthesis TRUE
+K02641 ferredoxin--NADP+ reductase Cytochrome b6f complex Energy Photosynthesis TRUE
+A01B "Catlytic type: Aspartate; residues with large hydrophobic sidechains on either side of the scissile bond, but several members have more restricted specificities that allow protein-processing functions (see additional Info); The amino acid sequences show signal peptides and propeptides except for bacterial homologues which also lack disulfide bridges and are probably cytoplasmic (Rawlings & Bateman, 2009). Many three-dimensional structures have been described. The catalytic site is located between the two lobes of the molecules, and a 'flap' structure containing a conserved Tyr residue controls specificity (James, 2004; Hong & Tang, 2004). Several of the peptidases are glycosylated (e.g. cathepsin D, A01.009) and a few are membrane-bound (memapsin-1 and memapsin-2, A01.041 and A01.004, respectively). Some family A1 peptidases from plants (e.g. phytepsin, A01.020) contain inserted saposin-like sequences, and the effects of these on enzymatic activity have been investigated (Payie et al., 2003). The secreted proteins in subfamily A usually have three conserved disulfide bridges, whereas in subfamily B there are six, and the unusual stability of nepenthesin (A01.040) to a wide pH range has been attributed to these disulfide bridges (Takahashi et al., 2005)." Endopeptidases (most of which are most active at acidic pH) Organic Nitrogen Peptidase TRUE
+A01A "Catlytic type: Aspartate; residues with large hydrophobic sidechains on either side of the scissile bond, but several members have more restricted specificities that allow protein-processing functions (see additional Info); The amino acid sequences show signal peptides and propeptides except for bacterial homologues which also lack disulfide bridges and are probably cytoplasmic (Rawlings & Bateman, 2009). Many three-dimensional structures have been described. The catalytic site is located between the two lobes of the molecules, and a 'flap' structure containing a conserved Tyr residue controls specificity (James, 2004; Hong & Tang, 2004). Several of the peptidases are glycosylated (e.g. cathepsin D, A01.009) and a few are membrane-bound (memapsin-1 and memapsin-2, A01.041 and A01.004, respectively). Some family A1 peptidases from plants (e.g. phytepsin, A01.020) contain inserted saposin-like sequences, and the effects of these on enzymatic activity have been investigated (Payie et al., 2003). The secreted proteins in subfamily A usually have three conserved disulfide bridges, whereas in subfamily B there are six, and the unusual stability of nepenthesin (A01.040) to a wide pH range has been attributed to these disulfide bridges (Takahashi et al., 2005)." Endopeptidases (most of which are most active at acidic pH) Organic Nitrogen Peptidase TRUE
+A05 Catlytic type: Aspartate; preference for hydrophobic residues in P1 and P1; pH optimum of 2.0 and is mainly active from pH 1-5 Endopeptidase Organic Nitrogen Peptidase TRUE
+A08 Catlytic type: Aspartate; cleavage site is known as the 'lipobox sequence' and is Leu-Xaa-YaaCys in which Xaa is Ala or Ser and Yaa is Gly or Ala; essential step in the production of the bacterial cell wall "Endopeptidase, the bacterial signal peptidase II" Organic Nitrogen Peptidase TRUE
+A09 "Catlytic type: Aspartate; processes Gag and Pol viral polyproteins in which four cleavages are made, all except one being at asparaginyl bondsour cleavages are made" "Endopeptidase, spumapepsin" Organic Nitrogen Peptidase TRUE
+A24B "Catlytic type: Aspartate; leader peptides are 5 - 8 residues long, rich in acidic amino acids, and immediately precede a 20-residue hydrophobic region; cleavage site is Gly-Phe; process type 4 pilin precursor proteins (prepilins) to their mature forms by removal of leader peptides" Membrane-inserted endopeptidases Organic Nitrogen Peptidase TRUE
+A24A "Catlytic type: Aspartate; leader peptides are 5 - 8 residues long, rich in acidic amino acids, and immediately precede a 20-residue hydrophobic region; cleavage site is GlyPhe; process type 4 pilin precursor proteins (prepilins) to their mature forms by removal of leader peptides" Membrane-inserted endopeptidases Organic Nitrogen Peptidase TRUE
+A25 "Catlytic type: Aspartate; acidic residue at P1, hydrophobic at P1, Ala at P2 and an acidic residue at P4; during the germination of spores, proteins ('small acid-soluble proteins': SASP) are degraded in a process that is initiated by the 'germination protease'" A single endopeptidase Organic Nitrogen Peptidase TRUE
+A26 "Catlytic type: Aspartate; cleavage between consecutive basic amino acids, but is capable of cleavage when P1 is a non-basic residue" Membrane-inserted endopeptidases Organic Nitrogen Peptidase TRUE
+A28B Catlytic type: Aspartic; No peptidase activity has been shown for any member of the family No peptidase activity has been shown for any member of the family Organic Nitrogen Peptidase TRUE
+A28A Catlytic type: Aspartic; No peptidase activity has been shown for any member of the family No peptidase activity has been shown for any member of the family Organic Nitrogen Peptidase TRUE
+A31 "Catlytic type: Aspartate; HycI endopeptidase releases a 32-residue C-terminal peptide by cleavage of an -Arg-Met- bond;HybD cleaves following the equivalent -His-Met- bond in hydrogenase 2, removing 15 residues; HycI and HybD are in the processing of the precursors of bacterial hydrogenases to their active forms" Endopeptidases Organic Nitrogen Peptidase TRUE
+A32 "Catlytic type: Aspartate; Important for processing the polar factor PodJ, which recruits proteins to the correct cell pole during cell division" PerP peptidase Organic Nitrogen Peptidase TRUE
+A36 Catlytic type: Aspartate; N-terminal propeptide is removed from the sigma factor E precursor Endopeptidases Organic Nitrogen Peptidase TRUE
+A37 Catlytic type: Aspartate Pepstatin-insensitive aspartic endopeptidases Organic Nitrogen Peptidase TRUE
+C10 Catlytic type: Cysteine; broad specificity with a hydrophobic residue in the P2 position Bacterial cysteine endopeptidases Organic Nitrogen Peptidase TRUE
+C100 Catlytic type: Cysteine; a fungal lectin and a calcium-dependent cysteine endopeptidase that is toxic to the nematodes that feed on the fungus Cysteine endopeptidases Organic Nitrogen Peptidase TRUE
+C101 Catlytic type: Cysteine; cleaves linear ubiquitin linkages Deubiquitinases Organic Nitrogen Peptidase TRUE
+C102 Catlytic type: Cysteine; degrades the GTPase Rab proteins ; helps the pathogen to evade detection in the lysosome Cysteine endopeptidases Organic Nitrogen Peptidase TRUE
+C106 Catlytic type: Cysteine; member is archaeosortase A (Haloferax volcanii ) archaeosortase A Organic Nitrogen Peptidase TRUE
+C11B "Catlytic type: Cysteine; Selective for hydrolysis of arginyl bonds; It requires calcium ions for activity, as well as a reducing environment; member is clostripain" Cysteine endopeptidase clostripain and its homologues Organic Nitrogen Peptidase TRUE
+C11A "Catlytic type: Cysteine; Selective for hydrolysis of arginyl bonds; It requires calcium ions for activity, as well as a reducing environment; member is clostripain" Cysteine endopeptidase clostripain and its homologues Organic Nitrogen Peptidase TRUE
+C110 Catlytic type: Cysteine Cysteine endopeptidases Organic Nitrogen Peptidase TRUE
+C111 Catlytic type: Cysteine coagulation factor XIIIa Organic Nitrogen Peptidase TRUE
+C115 Catlytic type: Cysteine; member is MINDY-1 protein (Homo sapiens) MINDY-1 protein Organic Nitrogen Peptidase TRUE
+C116 Catlytic type: Cysteine; member is dermonecrotic toxin (Pasteurella multocida) dermonecrotic toxin Organic Nitrogen Peptidase TRUE
+C117 Catlytic type: Cysteine; member is SpvD g.p. (Salmonella enterica) SpvD gp Organic Nitrogen Peptidase TRUE
+C118 Catlytic type: Cysteine; member is EspL g.p. (Escherichia coli) EspL gp Organic Nitrogen Peptidase TRUE
+C12 "Catlytic type: Cysteine; hydrolysis of bonds formed by the C-terminal Gly of ubiquitin, which may be alpha-peptide, isopeptide, amide or ester bonds; remain intracellular" Ubiquitinyl hydrolases Organic Nitrogen Peptidase TRUE
+C13 Catlytic type: Cysteine; restricted specificity for asparaginyl bonds Asparaginyl endopeptidases and glycosylphosphatidylinositol:protein transamidase Organic Nitrogen Peptidase TRUE
+C15 Catlytic type: Cysteine; removal of a pyroglutamate (pGlu) residue from the N-terminus of a peptide; intracellular and soluble Omega peptidases that release an N-terminal pyroglutamate residue Organic Nitrogen Peptidase TRUE
+C25 Catlytic type: Cysteine; gingipains R and K are endopeptidases with specificity for arginyl and lysyl bonds; often secreted by the bacterium Porphyromonas gingivalis involved in periodontal disease "Cysteine endopeptidases from bacteria, notably gingipain R (##C25001##) and gingipain K (##C25002##)" Organic Nitrogen Peptidase TRUE
+C45 Catlytic type: Cysteine; cleavage occurs at the Gly102-Cys bond; last enzyme in the penicillin biosynthetic pathway Autolytic endopeptidases Organic Nitrogen Peptidase TRUE
+C47 Catlytic type: Cysteine; staphopains are suggested to be important for the survival of Staphylococcus sp. in vivo Endopeptidases Organic Nitrogen Peptidase TRUE
+C50 Catlytic type: Cysteine; Arg in P1 and an acidic residue in P4; there is also a preference for an acidic residue in P6 ; required for the separation of sister chromatids during mitosis in a range of organisms from yeasts to man Endopeptidases Organic Nitrogen Peptidase TRUE
+C54 Catlytic type: Cysteine; cleavage (Gly116-Arg) to release the C-terminal Arg of the protein Apg8/Aut7;it cleaves the same bond even if a peptide replaces the C-terminal Arg Endopeptidases with specificity for glycyl bonds Organic Nitrogen Peptidase TRUE
+C55 Catlytic type: Cysteine; no direct demonstration of peptidase activity of any member of family C55; responsible for certain pathogenic effects of bacteria that cause diseases in animals and plants Bacterial endopeptidases with restricted specificity Organic Nitrogen Peptidase TRUE
+C56 "Catlytic type: Cysteine; acts only on peptides of less than 20 amino acids; a preference for bulky, hydrophobic P1 residues" PfpI endopeptidase of {Pyrococcus furiosus} Organic Nitrogen Peptidase TRUE
+C58B "Catlytic type: Cysteine; activates itself by cleaving the Lys62|+|Gly bond, and the newly exposed N-terminal Gly is then lipid-modified. Amongst other proteins, only those with a prenylated cysteine are substrates. Substrates include RhoA, the Rac and Cdc42 GTPases and host serine/threonine kinase PBS1 (which is cleaved at a single bond: <%Zhu, M. %etal, 2004[20040510A717]%>).; act as transamidases by attaching a lipid moiety to the newly exposed N-terminus of the substrate; RhoA, the Rac and Cdc42 GTPases and host serine/threonine kinase PBS1" "Endopeptidases that also act as transamidases, attaching a lipid moiety to the newly exposed N-terminus of the substrate" Organic Nitrogen Peptidase TRUE
+C58A "Catlytic type: Cysteine; activates itself by cleaving the Lys62|+|Gly bond, and the newly exposed N-terminal Gly is then lipid-modified. Amongst other proteins, only those with a prenylated cysteine are substrates. Substrates include RhoA, the Rac and Cdc42 GTPases and host serine/threonine kinase PBS1 (which is cleaved at a single bond: <%Zhu, M. %etal, 2004[20040510A717]%>).; act as transamidases by attaching a lipid moiety to the newly exposed N-terminus of the substrate; RhoA, the Rac and Cdc42 GTPases and host serine/threonine kinase PBS1" "Endopeptidases that also act as transamidases, attaching a lipid moiety to the newly exposed N-terminus of the substrate" Organic Nitrogen Peptidase TRUE
+C64 Catlytic type: Cysteine; release ubiquitin from linear or branched synthetic ubiquitin chains and from ubiquitinated proteins Endoisopeptidases that release ubiquitin from ubiquitinated proteins Organic Nitrogen Peptidase TRUE
+C65 Catlytic type: Cysteine; No physiological substrates have been identified for any members of the family; No biological roles have been determined for any members of the family Isopeptidases that release ubiquitin from polyubiquitin Organic Nitrogen Peptidase TRUE
+C66 Catlytic type: Cysteine; cleaves both gamma chains of human IgG or its Fc fragment in the hinge region after Gly236 Bacterial endopeptidase Organic Nitrogen Peptidase TRUE
+C67 "Catlytic type: Cysteine; de-ubiquitinating activity that is directed towards non-Lys48-linked polyubiquitin chains; involved in formation of NF-kB, which is important to inflammation response" Endopeptidases that release ubiquitin from polyubiquitinated proteins Organic Nitrogen Peptidase TRUE
+C69 Catlytic type: Cysteine; cleaves Leu-Leu and Phe-Leu dipeptides with free C-terminus Dipeptidases and aminopeptidases Organic Nitrogen Peptidase TRUE
+C70 Catlytic type: Cysteine; autolytic cleavage at Gly71Gly72 and also for the elimination of the host RIN4 protein ; could contribute to the pathogenic activity of Pseudomonas syringae A putative bacterial peptidase Organic Nitrogen Peptidase TRUE
+C75 "Catlytic type: Cysteine; cleaves off the C-terminus, and the N-terminus is cleaved by the signal peptidase, SpsB; contribute to the synthesis of bacterial autoinducing peptides by cleavage of precursor proteins" Endopeptidases Organic Nitrogen Peptidase TRUE
+C79 Catlytic type: Cysteine; hydrolyse ubiquitinyl bonds Deubiquitinylating activity Organic Nitrogen Peptidase TRUE
+C80 Catlytic type: Cysteine; preference for Leu in P1;has been shown to be able to degrade the leucine-rich protein YopM; precursors of the cholera RTX toxin Self-cleaving proteins that are precursors of bacterial toxins Organic Nitrogen Peptidase TRUE
+C82B Catlytic type: Cysteine; hydrolyse the L-Lys(3)-D-Ala(4) bonds of bacterial cell wall components; protein showed cell-wall cross-linking activity Hydrolase (and transfer) bacterial cell wall peptides Organic Nitrogen Peptidase TRUE
+C82A Catlytic type: Cysteine; hydrolyse the L-Lys(3)-D-Ala(4) bonds of bacterial cell wall components; protein showed cell-wall cross-linking activity Hydrolase (and transfer) bacterial cell wall peptides Organic Nitrogen Peptidase TRUE
+C83 "Catlytic type: Cysteine; glutathione is cleaved to gamma-Glu-Cys + Gly, either by hydrolysis or transpeptidation" Exopeptidases some of which also have transferase activity Organic Nitrogen Peptidase TRUE
+C84 Catlytic type: Cysteine; hydrolyses Bz-Val-Gly-Arg-p-nitroanilide; association with periodontitis Endopeptidases Organic Nitrogen Peptidase TRUE
+C86 Catlytic type: Cysteine; deubiquitinylating activity Deubiquitinylating peptidases Organic Nitrogen Peptidase TRUE
+C88 Catlytic type: Cysteine; cleaves longer polyubiquitin chains with Lys48 linkages Deubiquitinylating enzymes Organic Nitrogen Peptidase TRUE
+C93 Catlytic type: Cysteine; member is LapG peptidase (Pseudomonas fluorescens) LapG peptidase Organic Nitrogen Peptidase TRUE
+C95 Catlytic type: Cysteine; known proteolytic activity is a processing event that is assumed to be the result of autolytic activity Self-cleaving proteins Organic Nitrogen Peptidase TRUE
+C96 Catlytic type: Cysteine; removes the leader peptide of microcin J25 Cysteine type endopeptidases Organic Nitrogen Peptidase TRUE
+C98 Catlytic type: Cysteine; release SUMO from its precursor Isopeptidases that release SUMO from conjugated proteins Organic Nitrogen Peptidase TRUE
+G01 Catlytic type: Glutamate; cleave (amongst others) the Tyr26-Thr27 bond in the B chain of oxidized insulin Endopeptidases from fungi Organic Nitrogen Peptidase TRUE
+I01 Inhibitors of serine endopeptidases Inhibitors of serine endopeptidases Organic Nitrogen Peptidase TRUE
+I03B "Inhibit serine peptidases, particularly belonging to family S1; Members of family I3 inhibit serine peptidases by the Laskowski mechanism" Inhibitors of serine and some other peptidases Organic Nitrogen Peptidase TRUE
+I03A "Inhibit serine peptidases, particularly belonging to family S1; Members of family I3 inhibit serine peptidases by the Laskowski mechanism" Inhibitors of serine and some other peptidases Organic Nitrogen Peptidase TRUE
+I05 A single inhibitor of serine peptidases A single inhibitor of serine peptidases Organic Nitrogen Peptidase TRUE
+I06 Serine peptidase inhibitors Serine peptidase inhibitors Organic Nitrogen Peptidase TRUE
+I07 Serine endopeptidase inhibitors Serine endopeptidase inhibitors Organic Nitrogen Peptidase TRUE
+I09 Inhibitors of serine peptidases of the subtilisin family (S8) Inhibitors of serine peptidases of the subtilisin family (S8) Organic Nitrogen Peptidase TRUE
+I10 Serine endopeptidase inhibitors Serine endopeptidase inhibitors Organic Nitrogen Peptidase TRUE
+I100 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I101 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I102 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I11 "A single serine endopeptidase inhibitor, ecotin" "A single serine endopeptidase inhibitor, ecotin" Organic Nitrogen Peptidase TRUE
+I12 Inhibitors of serine endopeptidases in clan PA Inhibitors of serine endopeptidases in clan PA Organic Nitrogen Peptidase TRUE
+I13 Inhibitors of serine peptidases Inhibitors of serine peptidases Organic Nitrogen Peptidase TRUE
+I14 Inhibitors of the serine endopeptidase thrombin Inhibitors of the serine endopeptidase thrombin Organic Nitrogen Peptidase TRUE
+I15 Inhibitors of serine endopeptidases in family S1 Inhibitors of serine endopeptidases in family S1 Organic Nitrogen Peptidase TRUE
+I16 Inhibitors of serine endopeptidases and at least one metallopeptidase Inhibitors of serine endopeptidases and at least one metallopeptidase Organic Nitrogen Peptidase TRUE
+I17 Serine endopeptidase inhibitors Serine endopeptidase inhibitors Organic Nitrogen Peptidase TRUE
+I18 Inhibitors of trypsin and other endopeptidases in family S1 Inhibitors of trypsin and other endopeptidases in family S1 Organic Nitrogen Peptidase TRUE
+I19 Inhibitors of serine endopeptidases Inhibitors of serine endopeptidases Organic Nitrogen Peptidase TRUE
+I20 Serine endopeptidase inhibitors Serine endopeptidase inhibitors Organic Nitrogen Peptidase TRUE
+I21 Inhibitor of a serine endopeptidase from family S8 Inhibitor of a serine endopeptidase from family S8 Organic Nitrogen Peptidase TRUE
+I22 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I23 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I26 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I27 "Inhibitors of calpains (in peptidase family C2); roles in nerve growth, muscle homeostasis, signal transduction and apoptosis" Inhibitors of calpains (in peptidase family C2) Organic Nitrogen Peptidase TRUE
+I28 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I30 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I31 Inhibitors primarily of the papain-like cysteine peptidases in family C1 known as the thyropins Inhibitors primarily of the papain-like cysteine peptidases Organic Nitrogen Peptidase TRUE
+I33 Inhibitors of aspartic peptidases (all of which are endopeptidases) from family A1 Inhibitors of aspartic peptidases (all of which are endopeptidases) Organic Nitrogen Peptidase TRUE
+I34 Inhibitor of saccharopepsin from Saccharomyces cerevisiae Inhibitor of saccharopepsin from Saccharomyces cerevisiae Organic Nitrogen Peptidase TRUE
+I35 Inhibitors of metalloendopeptidases (matrixins) in family M10A and M12B Inhibitors of metalloendopeptidases (matrixins) Organic Nitrogen Peptidase TRUE
+I37 a metallocarboxypeptidase inhibitor of family M14 metallocarboxypeptidase inhibitor Organic Nitrogen Peptidase TRUE
+I38 Inhibitors of metalloendopeptidases in subfamily M10 Inhibitors of metalloendopeptidases in subfamily M10 Organic Nitrogen Peptidase TRUE
+I39 interact with endopeptidases regardless of catalytic type Mammalian alpha-macroglobulin and other large homologous proteins that interact with endopeptidases regardless of catalytic type Organic Nitrogen Peptidase TRUE
+I40 "Bombyx subtilisin inhibitor, an inhibitor of serine peptidases from family S8" "Bombyx subtilisin inhibitor, an inhibitor of serine peptidases from family S8" Organic Nitrogen Peptidase TRUE
+I41 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I42 Inhibitors of cysteine endopeptidases from family C1 Inhibitors of cysteine endopeptidases Organic Nitrogen Peptidase TRUE
+I44 "inhibited is carboxypeptidase A, but does not affect other members of M14" Inhibitors of metallocarboxypeptidases in family M14 Organic Nitrogen Peptidase TRUE
+I45 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I46 Inhibitors of peptidases in family M14 Leech carboxypeptidase inhibitor (LCI) Organic Nitrogen Peptidase TRUE
+I47 Inhibitors of metallocarboxypeptidases in family M14 Inhibitors of metallocarboxypeptidases in family M14 Organic Nitrogen Peptidase TRUE
+I48 Inhibitors of cysteine endopeptidases "Inhibitors of cysteine endopeptidases from family C1 including papain, cathepsin L, cathepsin B, stem bromelain, but not cathepsin H, trypsin, and pepsin" Organic Nitrogen Peptidase TRUE
+I49 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I52 strong inhibition of coagulation factor Xa and weak inhibition of other peptidases in family S1 such as trypsin Inhibitors of coagulation factor Xa Organic Nitrogen Peptidase TRUE
+I53 Inhibitors of the serine-type endopeptidase thrombin; prevent conversion of fibrinogen to fibrin Inhibitors of the serine-type endopeptidase thrombin Organic Nitrogen Peptidase TRUE
+I54 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I55 aspartic peptidase inhibitor aspartic peptidase inhibitor Organic Nitrogen Peptidase TRUE
+I56 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I57 "Inhibitors of cysteine endopeptidases in family C47, the staphopains" "Inhibitors of cysteine endopeptidases in family C47, the staphopains" Organic Nitrogen Peptidase TRUE
+I58 "Inhibitor of the cysteine endopeptidase, specifically staphopain A" "Inhibitor of the cysteine endopeptidase, specifically staphopain A" Organic Nitrogen Peptidase TRUE
+I59 shown to inhibit thrombin; facilitates the feeding of the organism by delaying the clotting of the blood of the host Anticoagulant proteins from blood-feeding hemiptera Organic Nitrogen Peptidase TRUE
+I60 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I61 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I62 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I64 Proteins that inhibit coagulation Proteins that inhibit coagulation Organic Nitrogen Peptidase TRUE
+I65 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I66 "Inhibitors, specificity unknown; Members include Lentinus peptidase inhibitor" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I67 "Inhibitors of cysteine endopeptidases, specifically stem bromelain as well as weak inhibition of trypsin" Inhibitors of cysteine endopeptidases Organic Nitrogen Peptidase TRUE
+I68 "Carboxypeptidase inhibitor, specifically those from subfamily M14A; suggested to enhance endogenous fibrinolysis" Carboxypeptidase inhibitor Organic Nitrogen Peptidase TRUE
+I69 "Inhibitors, specificity unknown; has been shown prevoiouslt to inhibit streptopain" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I70 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I71 Cysteine peptidase inhibitors from family C1 and calpain from family C2 Cysteine peptidase inhibitors Organic Nitrogen Peptidase TRUE
+I72 Inhibitors of the serine peptidase thrombin Inhibitors of the serine peptidase thrombin Organic Nitrogen Peptidase TRUE
+I73 Inhibitors of serine-type endopeptidases "Inhibitors of serine-type endopeptidases, specifically trypsin" Organic Nitrogen Peptidase TRUE
+I74 Inhibitors of the serine-type endopeptidase thrombin; Thrombin is the final peptidase in the blood coagulation cascade in mammals Inhibitors of the serine-type endopeptidase thrombin Organic Nitrogen Peptidase TRUE
+I76 Inhibitors of the serine-type endopeptidase thrombin; Thrombin is the final peptidase in the blood coagulation cascade in mammals Inhibitors of the serine-type endopeptidase thrombin Organic Nitrogen Peptidase TRUE
+I77 Inhibitors of the serine-type endopeptidase thrombin; Thrombin is the final peptidase in the blood coagulation cascade in mammals Inhibitors of the serine-type endopeptidase thrombin Organic Nitrogen Peptidase TRUE
+I78 Inhibitors of serine-type endopeptidases Inhibitors of serine-type endopeptidases Organic Nitrogen Peptidase TRUE
+I79 Inhibitors of cysteine peptidases from family C1 (especially PIP1 and RCR3); host defensive protein that is secreted to the apoplast and initiates a hypersensitive response in the presence of the Avr2 inhibitor and the RCR3 peptidase Inhibitors of cysteine peptidases Organic Nitrogen Peptidase TRUE
+I80 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I81 Inhibitors of cysteine endopeptidases from family C1 (especially TgCPL peptidase) Inhibitors of cysteine endopeptidases Organic Nitrogen Peptidase TRUE
+I82 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I83 Inhibitors of serine endopeptidases; Inlcude peptidases involved in Insect defence mechanisms against pathogenic attack Inhibitors of serine endopeptidases Organic Nitrogen Peptidase TRUE
+I84 serine peptidases from family S8 (especially perkisin) and trypsin from S1 Serine peptidase inhibitors Organic Nitrogen Peptidase TRUE
+I85 inhibit cysteine peptidases from family C1 and trypsins; generally called macrocypins Cysteine and serine peptidase inhibitors Organic Nitrogen Peptidase TRUE
+I86 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I88 Serine endopeptidase inhibitors Serine endopeptidase inhibitors Organic Nitrogen Peptidase TRUE
+I89 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I90 Inhibitors of trypsin Inhibitors of trypsin Organic Nitrogen Peptidase TRUE
+I92 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I93 Inhibitors of metallopeptidases Inhibitors of metallopeptidases Organic Nitrogen Peptidase TRUE
+I94 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I95 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I96 "Inhibitors, specificity unknown; extracellular adherence protein" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I98 "Inhibitors, specificity unknown; extracellular adherence protein" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+I99 "Inhibitors, specificity unknown" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase TRUE
+M01 Catlytic type: Metallo; each is capable of releasing a variety of residues; none have been shown to hydrolyse Xaa-Pro-bonds Aminopeptidases Organic Nitrogen Peptidase TRUE
+M02 Catlytic type: Metallo; exopeptidases acting near the C-terminus of oligopeptides Metallo-exopeptidases Organic Nitrogen Peptidase TRUE
+M04 "Catlytic type: Metallo; cleave of Xaa+Yaa, in which Xaa is a hydrophobic residue and Yaa is Leu, Phe, Ile, or Val; secreted enzymes that degrade extracellular proteins and peptides for bacterial nutrition; member is thermolysin" Metalloendopeptidases Organic Nitrogen Peptidase TRUE
+M05 Catlytic type: Metallo; a member is mycolysin Metalloendopeptidase Organic Nitrogen Peptidase TRUE
+M06 "Catlytic type: Metallo; digesting two classes of antibacterial humoral factors: cecropins and attacins, with no specific cleaving pattern; may contribute to the virulence of Bacillus thuringiensis" Metalloendopeptidases Organic Nitrogen Peptidase TRUE
+M07 Catlytic type: Metallo; a member is snapalysin; only known activity is cleavage of proteins of skimmed milk "Metalloendopeptidase, snapalysin" Organic Nitrogen Peptidase TRUE
+M08 "Catlytic type: Metallo; P1 residue at a site of cleavage is often Leu, Ile or Val, and Lys in P3 or P4 may be favourable; most abundant surface protein of leishmania promastigotes and contributes to its virulence" Metallo-endopeptidase leishmanolysin and its homologues Organic Nitrogen Peptidase TRUE
+M09B Catlytic type: Metallo; Vibrio collegenases cleave at XaaGly bond in the alpha-1 chain type of collagen; Clostridium collegenases cleave all three collagens at Yaa-Gly bonds in the repeating Gly-Xaa-Yaa collagen sequence Bacterial collagenases from Vibrio and Clostridium Organic Nitrogen Peptidase TRUE
+M09A Catlytic type: Metallo; Vibrio collegenases cleave at XaaGly bond in the alpha-1 chain type of collagen; Clostridium collegenases cleave all three collagens at Yaa-Gly bonds in the repeating Gly-Xaa-Yaa collagen sequence Bacterial collagenases from Vibrio and Clostridium Organic Nitrogen Peptidase TRUE
+M100 Catlytic type: Metallo; a member is spartan peptidase (Homo sapiens) spartan peptidase Organic Nitrogen Peptidase TRUE
+M101 Catlytic type: Metallo; a member is flagellinolysin (Clostridium haemolyticum) flagellinolysin Organic Nitrogen Peptidase TRUE
+M102 Catlytic type: Metallo; a member is DA1 peptidase (Arabidopsis thaliana) DA1 peptidase Organic Nitrogen Peptidase TRUE
+M11 Catlytic type: Metallo; degrades the proline- and hydroxyproline-rich proteins of the algal cell wall; a member is Gametolysin; degradation of the cell wall allows the release of gametes "A metallo-endopeptidase, gametolysin" Organic Nitrogen Peptidase TRUE
+M17 "Catlytic type: Metallo; any N-terminal amino acid can be released from dipeptides and polypeptides, although there is a preference for leucine; bonds with proline in P1 are not cleaved; maximally active between pH 9 and 9.5" Aminopeptidases Organic Nitrogen Peptidase TRUE
+M18 Catlytic type: Metallo; acting on N-terminal leucine and most other amino acids Metalloaminopeptidases Organic Nitrogen Peptidase TRUE
+M19 Catlytic type: Metallo; cleaves dipeptides and beta-lactams; cleaves dipeptides with D-amino acids in the P1 position; often membrane localized Dipeptidases Organic Nitrogen Peptidase TRUE
+M22 "Catlytic type: Metallo; cleaves only proteins that are {O}-sialoglycosylated; shown to cleave glycophorin A and the leukocyte surface antigens CD34, CD43, CD44 and CD45" Endopeptidases Organic Nitrogen Peptidase TRUE
+M24C Catlytic type: Metallo Exopeptidases that require co-catalytic ions of cobalt or manganese Organic Nitrogen Peptidase TRUE
+M24B Catlytic type: Metallo; cleave the bond XaaPro; found in eukaryotes associated with collagen recycling Exopeptidases that require co-catalytic ions of cobalt or manganese Organic Nitrogen Peptidase TRUE
+M24A "Catlytic type: Metallo; cleave the Met-Xaa (where Xaa is any amino acid) bond in the removal of the initiating N-terminal methionine from newly synthesized proteins; essential for the removal of the initiating methionine of many proteins, acting co-translationally in association with the ribosomes" Exopeptidases that require co-catalytic ions of cobalt or manganese Organic Nitrogen Peptidase TRUE
+M26 Catlytic type: Metallo; cleaves the heavy chain of human IgA1 at the Pro227-Thr228 bond; tightly associated with the bacterial cell surface Endopeptidases Organic Nitrogen Peptidase TRUE
+M28F Catlytic type: Metallo; able to release a variety of N-terminal amino acids Aminopeptidases and carboxypeptidases Organic Nitrogen Peptidase TRUE
+M28E Catlytic type: Metallo; able to release a variety of N-terminal amino acids Aminopeptidases and carboxypeptidases Organic Nitrogen Peptidase TRUE
+M28D Catlytic type: Metallo; able to release a variety of N-terminal amino acids Aminopeptidases and carboxypeptidases Organic Nitrogen Peptidase TRUE
+M28C "Catlytic type: Metallo; able to release a variety of N-terminal amino acids, with preference for basic amino acids" Aminopeptidases and carboxypeptidases Organic Nitrogen Peptidase TRUE
+M28B "Catlytic type: Metallo; able to release a variety of N-terminal amino acids, with preference for C-terminal glutamates" Aminopeptidases and carboxypeptidases Organic Nitrogen Peptidase TRUE
+M28A Catlytic type: Metallo; able to release a variety of N-terminal amino acids Aminopeptidases and carboxypeptidases Organic Nitrogen Peptidase TRUE
+M29 "Catlytic type: Metallo; broad specificity, but preferentially releases Leu, Val, Phe or Tyr; can release Pro but is unable to cleave peptides with Pro in P1. Leu-NHPhNO2 is the usual synthetic substrate" Aminopeptidases Organic Nitrogen Peptidase TRUE
+M30 Catlytic type: Metallo; cleaves azocasein and gelatin Endopeptidases Organic Nitrogen Peptidase TRUE
+M32 Catlytic type: Metallo; hydrolyses amino acids with long side chains most readily Metallocarboxypeptidases Organic Nitrogen Peptidase TRUE
+M34 "Catlytic type: Metallo; cleaves at the Xbb-Xbb-Xbb-Xbb-Xaa-Xcc-Xaa+Xcc bond, in which Xaa is any amino acid, Xbb is Lys or Arg, and Xcc is a hydrophobic amino acid" Highly-selective bacterial endopeptidase Organic Nitrogen Peptidase TRUE
+M35 "Catlytic type: Metallo; cleaves Xaa-Lys bonds, in which Xaa can even be Pro" Fungal metalloendopeptidases Organic Nitrogen Peptidase TRUE
+M36 "Catlytic type: Metallo; hydrolyses laminins, elastin and collagen, with a preference for cleavage on the amino side of hydrophobic residues with bulky side-chains; a member is funalysin" Endopeptidases Organic Nitrogen Peptidase TRUE
+M49 "Catlytic type: Metallo; DPPIII releases N-terminal dipeptides sequentially from a peptide. Angiotensins II and III, Leu-enkephalin, prolactin and alpha-melanocyte-stimulating hormone are readily cleaved, whereas tripeptides are poor substrates and angiotensin I and polypeptides of more than ten residues are not cleaved. In addition, proline is not accepted in P1 or P1’ . The recommended synthetic substrate is Arg-Arg|+|NHMec (<%Chen & Barrett, 2004[20040525A373]%>).; polypeptides of more than ten residues are not cleaved and proline in the P1 or P1 position will not cleave" Dipeptidylpeptidase Organic Nitrogen Peptidase TRUE
+M50B "Catlytic type: Metallo; activates the factor sigmaK precursor by cleaving off a 20-residue propeptide; cleavage occurs within, or very close to, membranes" Metallo-endopeptidases Organic Nitrogen Peptidase TRUE
+M50A "Catlytic type: Metallo; cleaves a Leu-Cys bond in the first transmembrane helix of the substrate; cleavage occurs within, or very close to, membranes" Metallo-endopeptidases Organic Nitrogen Peptidase TRUE
+M54 Catlytic type: Metallo; eukaryote archelysin has a preference for arginine in P1; the AMZ1 protein cleaves alanyl bonds "Aminopeptidases, sometimes termed archaelysins or archaemetzincins" Organic Nitrogen Peptidase TRUE
+M55 Catlytic type: Metallo; cleaves D-Ala-D-Ala and D-Ala-Gly-Gly Aminopeptidase and a number of uncharacterised putative peptidases Organic Nitrogen Peptidase TRUE
+M57 Catlytic type: Metallo Endopeptidase Organic Nitrogen Peptidase TRUE
+M61 "Catlytic type: Metallo; hydrolyses a broad range of N-terminal amino acids, but shows a preference for glycine or alanine; degradation of extracellular proteins for uptake of amino acids" Aminopeptidase Organic Nitrogen Peptidase TRUE
+M64 Catlytic type: Metallo; cleaves both the alpha1 and alpha2 A2m(1) heavy chains at the Val-Pro-Cys-Pro221Val222 peptide bond located just before the hinge region; may help the organisms to exist as a commensal organism in the human intestine Highly selective metalloendopeptidase Organic Nitrogen Peptidase TRUE
+M66 Catlytic type: Metallo; cleavse C1 esterase inhibitor A single metallopeptidase Organic Nitrogen Peptidase TRUE
+M72 Catlytic type: Metallo; cleaves peptide bonds at the amino side of aspartate or cysteic acid Metallo-endopeptidases Organic Nitrogen Peptidase TRUE
+M73 "Catlytic type: Metallo; cleaves proteins such as caseins, actin and collagen type I, with preference for bonds with an aliphatic or hydrophilic residue in P1" Metallo-endopeptidases Organic Nitrogen Peptidase TRUE
+M74 Catlytic type: Metallo; hydrolyses the Ala-D-Glu-meso-diaminopimelateD-Ala bond in the crosslinking peptide and the Ala-D-Glu-meso-diaminopimelatemeso-diaminopimelate-D-Glu-Ala bond between crosslinking peptides Murein endopeptidase MepA Organic Nitrogen Peptidase TRUE
+M75 Catlytic type: Metallo; cleaves the oxidized insulin B chain with a preference for aromatic hydrophobic amino acids at P1 Metalloendopeptidases Organic Nitrogen Peptidase TRUE
+M76 "Catlytic type: Metallo; processes the mitochondrially-encoded, subunit Atp6 of the F1FO-ATP synthase" Endopeptidases Organic Nitrogen Peptidase TRUE
+M77 Catlytic type: Metallo Aminopeptidases Organic Nitrogen Peptidase TRUE
+M80 Catlytic type: Metallo Isopeptidases Organic Nitrogen Peptidase TRUE
+M81 Catlytic type: Metallo; degrades both microcystins LR and LA Metallopeptidases Organic Nitrogen Peptidase TRUE
+M82 Catlytic type: Metallo; inactivates the anti-sigma factor RsiW by performing the first of several cleavages Endopeptidases Organic Nitrogen Peptidase TRUE
+M84 Catlytic type: Metallo; The only proteolytic activity reported is against azocasein Endopeptidases Organic Nitrogen Peptidase TRUE
+M85 "Catlytic type: Metallo; cleaves the p65 subunit of NF-kappaB, but cleavage positions have not been identified" Endopeptidases Organic Nitrogen Peptidase TRUE
+M87 "Catlytic type: Metallo; Self-cleavage occurs at a well-conserved site, in which P1 is basic or Gly, P1 is small (predominantly Gly or Ala), P2 is hydrophobic, P3 is Tyr and P6 is Gl" Self-cleaving proteins Organic Nitrogen Peptidase TRUE
+M88 Catlytic type: Metallo; protects the bacterium from immunological attack by impairing the extravasation of neutrophils Endopeptidases Organic Nitrogen Peptidase TRUE
+M90 "Catlytic type: Metallo; member is MtfA peptidase, involved in control of the glucose-phosphotransferase system" Aminopeptidases Organic Nitrogen Peptidase TRUE
+M91 Catlytic type: Metallo; secreted by type III secretion systems in E. coli Endopeptidases Organic Nitrogen Peptidase TRUE
+M93 Catlytic type: Metallo Organic Nitrogen Peptidase TRUE
+M95 Catlytic type: Metallo; member is abylysin (Pyrococcus abyssi) Organic Nitrogen Peptidase TRUE
+M96 "Catlytic type: Metallo; N-terminal octapeptide is removed from the Wnt-3a protein, with cleavage occurring at at Leu+Ala bond" signaling peptidase Organic Nitrogen Peptidase TRUE
+M97 Catlytic type: Metallo; a member is EcxAB peptidase (Escherichia coli) Organic Nitrogen Peptidase TRUE
+M98 Catlytic type: Metallo; a member is YghJ g.p. (Escherichia coli) Organic Nitrogen Peptidase TRUE
+M99 Catlytic type: Metallo; a member is Csd4 peptidase (Helicobacter pylori) Organic Nitrogen Peptidase TRUE
+N06 Catlytic type: Asparagine; cleaves at the tetrapeptide Asn+Pro-Thr-His; essential for mediating the switch in the secretion of proteins in the type III secretion system Autoprocessing endopeptidases Organic Nitrogen Peptidase TRUE
+P01 "Catlytic type: Mixed (C, S, T) catalytic type; releases amino acid residues in the L-configuration in its action on peptides; part of the general peptidase pool" Aminopeptidases and self-processing proteins Organic Nitrogen Peptidase TRUE
+P02B "Catlytic type: Mixed (C, S, T) catalytic type; polycystin-1" mucin-like hormone receptor Organic Nitrogen Peptidase TRUE
+P02A "Catlytic type: Mixed (C, S, T) catalytic type; EGF-like module containing mucin-like hormone receptor-like 2" mucin-like hormone receptor Organic Nitrogen Peptidase TRUE
+S10 Catlytic type: Serine; preference for hydrophobic residues in positions P1 and P1 OR preference for the basic amino acids either side of the scissile bond Carboxypeptidases Organic Nitrogen Peptidase TRUE
+S13 "Catlytic type: Serine; hydrolyses the D-Ala-D-Ala bond in the cross-linking peptide precursor OR degrades this D-Ala-meso-2,6-diaminopimelate bond" "Peptidases that cleave D-Ala bonds, acting either as carboxypeptidases or as atypical 'endopeptidases'" Organic Nitrogen Peptidase TRUE
+S15 Catlytic type: Serine; cleaves Xaa-Pro from the N-terminus of peptides provided that there is not a Pro in the P2 or P1 positions; plays important role in degradation of casein Xaa-Pro dipeptidyl peptidase and its homologues Organic Nitrogen Peptidase TRUE
+S37 Catlytic type: Serine; activate the transglutaminase precursor by removal of a leading tri- or tetrapeptide Tripeptidyl-peptidase from {Streptomyces} Organic Nitrogen Peptidase TRUE
+S41B "Catlytic type: Serine; recognizes a C-terminal tripeptide, Xaa-Yaa-Zaa, in which Xaa is preferably Ala or Leu, Yaa is preferably Ala or Tyr and Zaa is preferably Ala and cleaves at a variable distance from the C-terminus; important for the degradation of incorrectly synthesized proteins" Serine endopeptidases Organic Nitrogen Peptidase TRUE
+S41A "Catlytic type: Serine; recognizes a C-terminal tripeptide, Xaa-Yaa-Zaa, in which Xaa is preferably Ala or Leu, Yaa is preferably Ala or Tyr and Zaa is preferably Ala and cleaves at a variable distance from the C-terminus; important for the degradation of incorrectly synthesized proteins" Serine endopeptidases Organic Nitrogen Peptidase TRUE
+S45 "Catlytic type: Serine; amino side of the catalytic serine is cleaved in an intramolecular reaction, and then there is an intermolecular cleavage of a bond further toward the N-terminus; a member is penicillin G acylase precursor (Escherichia coli)" Self-cleaving precursor proteins of N-terminal nucleophile acylases Organic Nitrogen Peptidase TRUE
+S46 Catlytic type: Serine; long peptides and N-terminally blocked peptides are not cleaved Dipeptidyl-peptidases from bacteria Organic Nitrogen Peptidase TRUE
+S48 Catlytic type: Serine the protein HetR that is reported to be an autolytic serine endopeptidase Organic Nitrogen Peptidase TRUE
+S51 "Catlytic type: Serine; hydrolyses Asp-Xaa dipeptides in which Xaa is not Glu, Asn or Gln; nutritional function in bacteria" Exopeptidases that hydrolyse alpha-aspartyl bonds Organic Nitrogen Peptidase TRUE
+S55 Catlytic type: Serine Endopeptidases Organic Nitrogen Peptidase TRUE
+S59 Catlytic type: Serine; cleaves at the Phe-Ser bond within the active site motif Autolytic endopeptidase Organic Nitrogen Peptidase TRUE
+S60 Catlytic type: Serine; cleaves at arginyl and lysyl bonds Endopeptidase Organic Nitrogen Peptidase TRUE
+S63 Catlytic type: Serine Autolytic endopeptidases Organic Nitrogen Peptidase TRUE
+S64 Catlytic type: Serine; Ssy5 peptidase is believed to cleave both itself and the Stp1 protein within a motif that is conserved between the two proteins; this contains the sequence PISMS that is required for cleavage to take place; plays a key role in the adaptive response of Saccharomyces cerevisiae and likely other fungi Endopeptidases Organic Nitrogen Peptidase TRUE
+S66 Catlytic type: Serine; hydrolyses the bond to the C-terminal D-Ala in tetrapeptide peptidoglycan fragments that contain an L-configured residue (lysine or meso-diaminopimelic acid) that is attached a C-terminal D-alanine residue; produced when bacterial cell walls are degraded Bacterial LD-carboxypeptidases Organic Nitrogen Peptidase TRUE
+S68 Catlytic type: Serine; autolyses at two Ser-Trp bonds; proteolysis leads to activation of cell survival or apoptotic pathways Autolytic endopeptidases Organic Nitrogen Peptidase TRUE
+S70 Catlytic type: Serine; a member is LepA Serine-type endopeptidases Organic Nitrogen Peptidase TRUE
+S71 Catlytic type: Serine; autolytic cleavage at Gly-Ser bond; involved in the synthesis of Mucin 1 Self-cleaving precursor proteins Organic Nitrogen Peptidase TRUE
+S72 Catlytic type: Serine; cleaves at arginyl and lysyl bonds Autolytic serine-type endopeptidases Organic Nitrogen Peptidase TRUE
+S79 Catlytic type: Serine; autoactivation Self-processing proteins Organic Nitrogen Peptidase TRUE
+S82 Catlytic type: Serine autocrine proliferation repressor protein A Organic Nitrogen Peptidase TRUE
+T02 Catlytic type: Threonine; hydrolyses the GlcNAc+Asn (the natural linkage structure between protein and carbohydrate in Asn-linked glycoproteins) and taspase-1 which cleaves aspartyl bonds D+GADD and D+GVDD N-terminal nucleophile hydrolases Organic Nitrogen Peptidase TRUE
+T05 Catlytic type: Threonine Self-processing ornithine acetyltransferase precursor Organic Nitrogen Peptidase TRUE
+T06 Catlytic type: Threonine; cleaves itself at the Leu3048|+|Thr bond; cleavage occurs in the endoplasmic reticulum or the Golgi Threonine-type autoprocessing endopeptidases Organic Nitrogen Peptidase TRUE
+T07 Catlytic type: Threonine CwpV (Clostridium difficile) self-cleaving threonine peptidase Organic Nitrogen Peptidase TRUE
+T08 Catlytic type: Threonine; member is HopB1 g.p. (Pseudomonas syringae) Organic Nitrogen Peptidase TRUE
+U49 cleaves domain I of elongation factor Tu; important role in bacterial cell death Lit peptidase from Escherischia coli Organic Nitrogen Peptidase TRUE
+U56 "hydrolyses substrates of chymotrypsin, trypsin, and casein" Endopeptidases Organic Nitrogen Peptidase TRUE
+U57 SpoIVA and YrbA are degraded during stage IV of the sporulation process Endopeptidases involved in bacterial sporulation Organic Nitrogen Peptidase TRUE
+U62 Catlytic type: Metallo; cleaves the bacteriocin microcin B17 precursor at Gly26|+|Val27 Microcin-processing peptidases Organic Nitrogen Peptidase TRUE
+U69 Self-processing occurs at the Ser846|+|Ala bond. Self-processing peptidases Organic Nitrogen Peptidase TRUE
+U72 "Pup (prokaryotic ubiquitin-like protein) tags bacterial protiens for degradation. ; In releasing Pup from conjugates, Dop acts as an isopeptidase. In degradation of Pup, Dop acts as an endopeptidase." Isopeptidase and endopeptidases Organic Nitrogen Peptidase TRUE
+U74 Catlytic type: Peptidase of unknown catalytic type neprosin Organic Nitrogen Peptidase TRUE
+U75 Catlytic type: Peptidase of unknown catalytic type Ras/Rap1-specific peptidase Organic Nitrogen Peptidase TRUE
+K00412 CYTB; ubiquinol-cytochrome c reductase cytochrome b subunit Cytochrome bc1 complex respiratory unit Energy Oxygen TRUE
+K00413 CYC1; ubiquinol-cytochrome c reductase cytochrome c1 subunit Cytochrome bc1 complex respiratory unit Energy Oxygen TRUE
+K00410 fbcH; ubiquinol-cytochrome c reductase cytochrome b/c1 subunit Cytochrome bc1 complex respiratory unit Energy Oxygen TRUE
+K00411 UQCRFS1; ubiquinol-cytochrome c reductase iron-sulfur subunit Cytochrome bc1 complex respiratory unit Energy Oxygen TRUE
+K03886 MQCRA; menaquinol-cytochrome c reductase iron-sulfur subunit [EC:1.10.2.-] Cytochrome bc1 complex respiratory unit Energy Oxygen TRUE
+K03887 MQCRB; menaquinol-cytochrome c reductase cytochrome b subunit Cytochrome bc1 complex respiratory unit Energy Oxygen TRUE
+K03888 MQCRC; menaquinol-cytochrome c reductase cytochrome b/c subunit Cytochrome bc1 complex respiratory unit Energy Oxygen TRUE
+K03890 qcrA; ubiquinol-cytochrome c reductase iron-sulfur subunit Cytochrome bc1 complex respiratory unit Energy Oxygen TRUE
+K03891 qcrB; ubiquinol-cytochrome c reductase cytochrome b subunit Cytochrome bc1 complex respiratory unit Energy Oxygen TRUE
+K03889 qcrC; ubiquinol-cytochrome c reductase cytochrome c subunit Cytochrome bc1 complex respiratory unit Energy Oxygen TRUE
+K00412 CYTB; ubiquinol-cytochrome c reductase cytochrome b subunit Cytochrome bc1 complex Energy Oxygen TRUE
+K00413 CYC1; ubiquinol-cytochrome c reductase cytochrome c1 subunit Cytochrome bc1 complex Energy Oxygen TRUE
+K00410 FBCH; ubiquinol-cytochrome c reductase cytochrome b/c1 subunit Cytochrome bc1 complex Energy Oxygen TRUE
+K00411 UQCRFS1; ubiquinol-cytochrome c reductase iron-sulfur subunit Cytochrome bc1 complex Energy Oxygen TRUE
+K00414 QCR1; ubiquinol-cytochrome c reductase core subunit 1 Cytochrome bc1 complex Energy Oxygen TRUE
+K00415 QCR2; ubiquinol-cytochrome c reductase core subunit 2 Cytochrome bc1 complex Energy Oxygen TRUE
+K00416 QCR6; ubiquinol-cytochrome c reductase subunit 6 Cytochrome bc1 complex Energy Oxygen TRUE
+K00417 QCR7; ubiquinol-cytochrome c reductase subunit 7 Cytochrome bc1 complex Energy Oxygen TRUE
+K00418 QCR8; ubiquinol-cytochrome c reductase subunit 8 Cytochrome bc1 complex Energy Oxygen TRUE
+K00419 QCR9; ubiquinol-cytochrome c reductase subunit 9 Cytochrome bc1 complex Energy Oxygen TRUE
+K00420 QCR10; ubiquinol-cytochrome c reductase subunit 10 Cytochrome bc1 complex Energy Oxygen TRUE
+K00425 cytochrome bd ubiquinol oxidase subunit I [EC:1.10.3.14] Cytochrome bd ubiquinol oxidase Energy Oxygen TRUE
+K00426 cytochrome bd ubiquinol oxidase subunit II [EC:1.10.3.14] Cytochrome bd ubiquinol oxidase Energy Oxygen TRUE
+K00424 cydX; cytochrome bd-I ubiquinol oxidase subunit X [EC:1.10.3.14] Cytochrome bd ubiquinol oxidase Energy Oxygen TRUE
+K22501 appX; cytochrome bd-II ubiquinol oxidase subunit AppX [EC:1.10.3.14] Cytochrome bd ubiquinol oxidase Energy Oxygen TRUE
+K02257 COX10; protoheme IX farnesyltransferase [EC:2.5.1.-] Cytochrome c oxidase Energy Oxygen TRUE
+K02262 COX3; cytochrome c oxidase subunit 3 Cytochrome c oxidase Energy Oxygen TRUE
+K02256 COX1; cytochrome c oxidase subunit 1 [EC:1.9.3.1] Cytochrome c oxidase Energy Oxygen TRUE
+K02261 COX2; cytochrome c oxidase subunit 2 Cytochrome c oxidase Energy Oxygen TRUE
+K02263 COX4; cytochrome c oxidase subunit 4 Cytochrome c oxidase Energy Oxygen TRUE
+K02264 COX5A; cytochrome c oxidase subunit 5a Cytochrome c oxidase Energy Oxygen TRUE
+K02265 COX5B; cytochrome c oxidase subunit 5b Cytochrome c oxidase Energy Oxygen TRUE
+K02266 COX6A; cytochrome c oxidase subunit 6a Cytochrome c oxidase Energy Oxygen TRUE
+K02267 COX6B; cytochrome c oxidase subunit 6b Cytochrome c oxidase Energy Oxygen TRUE
+K02268 COX6C; cytochrome c oxidase subunit 6c Cytochrome c oxidase Energy Oxygen TRUE
+K02269 COX7; cytochrome c oxidase subunit 7 Cytochrome c oxidase Energy Oxygen TRUE
+K02270 COX7A; cytochrome c oxidase subunit 7a Cytochrome c oxidase Energy Oxygen TRUE
+K02271 COX7B; cytochrome c oxidase subunit 7b Cytochrome c oxidase Energy Oxygen TRUE
+K02272 COX7C; cytochrome c oxidase subunit 7c Cytochrome c oxidase Energy Oxygen TRUE
+K02273 COX8; cytochrome c oxidase subunit 8 Cytochrome c oxidase Energy Oxygen TRUE
+K02258 COX11; cytochrome c oxidase assembly protein subunit 11 Cytochrome c oxidase Energy Oxygen TRUE
+K02259 COX15; cytochrome c oxidase assembly protein subunit 15 Cytochrome c oxidase Energy Oxygen TRUE
+K02260 COX17; cytochrome c oxidase assembly protein subunit 17 Cytochrome c oxidase Energy Oxygen TRUE
+K02275 coxB; cytochrome c oxidase subunit II [EC:1.9.3.1] "Cytochrome c oxidase, prokaryotes" Energy Oxygen TRUE
+K02274 coxA; cytochrome c oxidase subunit I [EC:1.9.3.1] "Cytochrome c oxidase, prokaryotes" Energy Oxygen TRUE
+K02276 coxC; cytochrome c oxidase subunit III [EC:1.9.3.1] "Cytochrome c oxidase, prokaryotes" Energy Oxygen TRUE
+K15408 coxAC; cytochrome c oxidase subunit I+III [EC:1.9.3.1] "Cytochrome c oxidase, prokaryotes" Energy Oxygen TRUE
+K02277 coxD; cytochrome c oxidase subunit IV [EC:1.9.3.1] "Cytochrome c oxidase, prokaryotes" Energy Oxygen TRUE
+K00404 ccoN; cb-type cytochrome c oxidase subunit I [EC:1.9.3.1] "Cytochrome c oxidase, cbb3-type" Energy Oxygen TRUE
+K00405 ccoO; cb-type cytochrome c oxidase subunit II "Cytochrome c oxidase, cbb3-type" Energy Oxygen TRUE
+K15862 ccoNO; cbb3-type cytochrome c oxidase subunit I/II "Cytochrome c oxidase, cbb3-type" Energy Oxygen TRUE
+K00407 ccoQ; cb-type cytochrome c oxidase subunit IV "Cytochrome c oxidase, cbb3-type" Energy Oxygen TRUE
+K00406 ccoP; cb-type cytochrome c oxidase subunit III "Cytochrome c oxidase, cbb3-type" Energy Oxygen TRUE
+K02827 qoxB; cytochrome aa3-600 menaquinol oxidase subunit I [EC:1.10.3.12] Cytochrome aa3-600 menaquinol oxidase Energy Oxygen TRUE
+K02826 qoxA; cytochrome aa3-600 menaquinol oxidase subunit II [EC:1.10.3.12] Cytochrome aa3-600 menaquinol oxidase Energy Oxygen TRUE
+K02828 qoxC; cytochrome aa3-600 menaquinol oxidase subunit III [EC:1.10.3.12] Cytochrome aa3-600 menaquinol oxidase Energy Oxygen TRUE
+K02829 qoxD; cytochrome aa3-600 menaquinol oxidase subunit IV [EC:1.10.3.12] Cytochrome aa3-600 menaquinol oxidase Energy Oxygen TRUE
+K02297 cyoA; cytochrome o ubiquinol oxidase subunit II [EC:1.10.3.10] Cytochrome o ubiquinol oxidase Energy Oxygen TRUE
+K02298 cyoB; cytochrome o ubiquinol oxidase subunit I [EC:1.10.3.10] Cytochrome o ubiquinol oxidase Energy Oxygen TRUE
+K02299 cyoC; cytochrome o ubiquinol oxidase subunit III Cytochrome o ubiquinol oxidase Energy Oxygen TRUE
+K02300 cyoD; cytochrome o ubiquinol oxidase operon protein cyoD Cytochrome o ubiquinol oxidase Energy Oxygen TRUE
+K00937 polyphosphate kinase ??? Cytochrome d ubiquinol oxidase Energy Oxygen TRUE
+K20932 hzs; Hydrazine synthase subunit (aka: hzsC) [EC:1.7.2.7] [RN:R09799] "Nitrification, ammonia => nitrite" Energy Nitrogen TRUE
+K20933 hzs; Hydrazine synthase subunit (aka: hzsC) [EC:1.7.2.7] [RN:R09799] "Nitrification, ammonia => nitrite" Energy Nitrogen TRUE
+K20934 hzs; Hydrazine synthase subunit (aka: hzsC) [EC:1.7.2.7] [RN:R09799] "Nitrification, ammonia => nitrite" Energy Nitrogen TRUE
+K20935 hzs; Hydrazine synthase subunit (aka: hzsC) [EC:1.7.2.7] [RN:R09799] "Nitrification, ammonia => nitrite" Energy Nitrogen TRUE
+K02588 nitrogenase iron protein [RN:R05185] "Nitrogen fixation, nitrogen => ammonia" Energy Nitrogen TRUE
+K02586 nitrogenase molybdenum-iron protein [EC:1.18.6.1] [RN:R05185] "Nitrogen fixation, nitrogen => ammonia" Energy Nitrogen TRUE
+K02591 nitrogenase molybdenum-iron protein [EC:1.18.6.1] [RN:R05185] "Nitrogen fixation, nitrogen => ammonia" Energy Nitrogen TRUE
+K00531 nitrogenase delta subunit [EC:1.18.6.1] [RN:R05185] "Nitrogen fixation, nitrogen => ammonia" Energy Nitrogen TRUE
+K22896 vanadium-dependent nitrogenase [EC:1.18.6.2] [RN:R12084] "Nitrogen fixation, nitrogen => ammonia" Energy Nitrogen TRUE
+K22897 vanadium-dependent nitrogenase [EC:1.18.6.2] [RN:R12084] "Nitrogen fixation, nitrogen => ammonia" Energy Nitrogen TRUE
+K22898 vanadium nitrogenase delta subunit [EC:1.18.6.2] [RN:R12084] "Nitrogen fixation, nitrogen => ammonia" Energy Nitrogen TRUE
+K22899 vanadium nitrogenase iron protein [RN:R12084] "Nitrogen fixation, nitrogen => ammonia" Energy Nitrogen TRUE
+K10944 ammonia monooxygenase [EC:1.14.99.39] [RN:R00148] "Nitrification, ammonia => nitrite" Energy Nitrogen TRUE
+K10945 ammonia monooxygenase [EC:1.14.99.39] [RN:R00148] "Nitrification, ammonia => nitrite" Energy Nitrogen TRUE
+K10946 ammonia monooxygenase [EC:1.14.99.39] [RN:R00148] "Nitrification, ammonia => nitrite" Energy Nitrogen TRUE
+K10535 hydroxylamine oxidase [EC:1.7.2.6] [RN:R10164] "Nitrification, ammonia => nitrite" Energy Nitrogen TRUE
+K00370 nitrate reductase 1 [EC:1.7.99.-] [RN:R00798] "Denitrification, nitrate => nitrogen" Energy Nitrogen TRUE
+K00371 nitrate reductase 1 [EC:1.7.99.-] [RN:R00798] "Denitrification, nitrate => nitrogen" Energy Nitrogen TRUE
+K00374 nitrate reductase 1 [EC:1.7.99.-] [RN:R00798] "Denitrification, nitrate => nitrogen" Energy Nitrogen TRUE
+K02567 periplasmic nitrate reductase NapA [EC:1.7.99.-] [RN:R00798] "Denitrification, nitrate => nitrogen" Energy Nitrogen TRUE
+K02568 cytochrome c-type protein NapB [RN:R00798] "Denitrification, nitrate => nitrogen" Energy Nitrogen TRUE
+K00368 nitrite reductase (NO-forming) [EC:1.7.2.1] [RN:R00783 R00785] "Denitrification, nitrate => nitrogen" Energy Nitrogen TRUE
+K15864 nitrite reductase (NO-forming) [EC:1.7.2.1] [RN:R00783 R00785] "Denitrification, nitrate => nitrogen" Energy Nitrogen TRUE
+K04561 nitric oxide reductase [EC:1.7.2.5] [RN:R00294] "Denitrification, nitrate => nitrogen" Energy Nitrogen TRUE
+K02305 nitric oxide reductase [EC:1.7.2.5] [RN:R00294] "Denitrification, nitrate => nitrogen" Energy Nitrogen TRUE
+K15877 fungal nitric oxide reductase [EC:1.7.1.14] [RN:R02492 R09446 R09808 R09809] "Denitrification, nitrate => nitrogen" Energy Nitrogen TRUE
+K00376 nitrous-oxide reductase [EC:1.7.2.4] [RN:R02804] "Denitrification, nitrate => nitrogen" Energy Nitrogen TRUE
+K00370 respiratory nitrate reductase 1 [EC:1.7.99.-] [RN:R00798] "Dissimilatory nitrate reduction, nitrate => ammonia" Energy Nitrogen TRUE
+K00371 respiratory nitrate reductase 1 [EC:1.7.99.-] [RN:R00798] "Dissimilatory nitrate reduction, nitrate => ammonia" Energy Nitrogen TRUE
+K00374 respiratory nitrate reductase 1 [EC:1.7.99.-] [RN:R00798] "Dissimilatory nitrate reduction, nitrate => ammonia" Energy Nitrogen TRUE
+K02567 dissimilatory nitrate reductase [EC:1.7.99.-] [RN:R00798] "Dissimilatory nitrate reduction, nitrate => ammonia" Energy Nitrogen TRUE
+K02568 dissimilatory nitrate reductase [EC:1.7.99.-] [RN:R00798] "Dissimilatory nitrate reduction, nitrate => ammonia" Energy Nitrogen TRUE
+K00362 respiratory nitrite reductase [EC:1.7.1.15] [RN:R00787] "Dissimilatory nitrate reduction, nitrate => ammonia" Energy Nitrogen TRUE
+K00363 respiratory nitrite reductase [EC:1.7.1.15] [RN:R00787] "Dissimilatory nitrate reduction, nitrate => ammonia" Energy Nitrogen TRUE
+K03385 respiratory nitrite reductase [EC:1.7.2.2] [RN:R05712] "Dissimilatory nitrate reduction, nitrate => ammonia" Energy Nitrogen TRUE
+K15876 respiratory nitrite reductase [EC:1.7.2.2] [RN:R05712] "Dissimilatory nitrate reduction, nitrate => ammonia" Energy Nitrogen TRUE
+K00367 assimilatory nitrate reductase [EC:1.7.7.2] [RN:R00791] "Assimilatory nitrate reduction, nitrate => ammonia" Energy Nitrogen TRUE
+K10534 nitrate reductase (NAD(P)H) [EC:1.7.1.1 1.7.1.2 1.7.1.3] [RN:R00794 R00796] "Assimilatory nitrate reduction, nitrate => ammonia" Energy Nitrogen TRUE
+K00372 assimilatory nitrate reductase [EC:1.7.99.-] [RN:R00798] "Assimilatory nitrate reduction, nitrate => ammonia" Energy Nitrogen TRUE
+K00360 assimilatory nitrate reductase [EC:1.7.99.-] [RN:R00798] "Assimilatory nitrate reduction, nitrate => ammonia" Energy Nitrogen TRUE
+K00366 assimilatory nitrite reductase [EC:1.7.7.1] [RN:R00790] "Assimilatory nitrate reduction, nitrate => ammonia" Energy Nitrogen TRUE
+K17877 assimilatory nitrite reductase [EC:1.7.1.4] [RN:R00787 R00789] "Assimilatory nitrate reduction, nitrate => ammonia" Energy Nitrogen TRUE
+K02575 "NRT; MFS transporter, NNP family, nitrate/nitrite transporter" Nitrate assimilation Energy Nitrogen TRUE
+K10944 ammonia monooxygenase [EC:1.14.99.39] [RN:R00148] "Complete nitrification, comammox, ammonia => nitrite => nitrate" Energy Nitrogen TRUE
+K10945 ammonia monooxygenase [EC:1.14.99.39] [RN:R00148] "Complete nitrification, comammox, ammonia => nitrite => nitrate" Energy Nitrogen TRUE
+K10946 ammonia monooxygenase [EC:1.14.99.39] [RN:R00148] "Complete nitrification, comammox, ammonia => nitrite => nitrate" Energy Nitrogen TRUE
+K10535 hydroxylamine oxidase [EC:1.7.2.6] [RN:R10164] "Complete nitrification, comammox, ammonia => nitrite => nitrate" Energy Nitrogen TRUE
+K00370 nitrite oxidoreductase [EC:1.7.99.4] [RN:R00798] "Complete nitrification, comammox, ammonia => nitrite => nitrate" Energy Nitrogen TRUE
+K00371 nitrite oxidoreductase [EC:1.7.99.4] [RN:R00798] "Complete nitrification, comammox, ammonia => nitrite => nitrate" Energy Nitrogen TRUE
+K20935 hdh; hydrazine dehydrogenase nitrite + ammonia => nitrogen Energy Nitrogen nitrite + ammonia => nitrogen TRUE
+K20932 hzs; Hydrazine synthase subunit (aka: hzsC) [EC:1.7.2.7] [RN:R09799] nitrite + ammonia => nitrogen Energy Nitrogen nitrite + ammonia => nitrogen TRUE
+K20933 hzs; Hydrazine synthase subunit (aka: hzsC) [EC:1.7.2.7] [RN:R09799] nitrite + ammonia => nitrogen Energy Nitrogen nitrite + ammonia => nitrogen TRUE
+K20934 hzs; Hydrazine synthase subunit (aka: hzsC) [EC:1.7.2.7] [RN:R09799] nitrite + ammonia => nitrogen Energy Nitrogen nitrite + ammonia => nitrogen TRUE
+K20935 hzs; Hydrazine synthase subunit (aka: hzsC) [EC:1.7.2.7] [RN:R09799] nitrite + ammonia => nitrogen Energy Nitrogen nitrite + ammonia => nitrogen TRUE
+K10535 "hox, hydroxylamine oxidase [EC:1.7.2.6] [RN:R10164]" nitrite + ammonia => nitrogen Energy Nitrogen nitrite + ammonia => nitrogen TRUE
+K00368 "nir, nitrite reductase (NO-forming) [EC:1.7.2.1] [RN:R00783 R00785]" nitrite + ammonia => nitrogen Energy Nitrogen nitrite + ammonia => nitrogen TRUE
+K15864 "nir, nitrite reductase (NO-forming) [EC:1.7.2.1] [RN:R00783 R00785]" nitrite + ammonia => nitrogen Energy Nitrogen nitrite + ammonia => nitrogen TRUE
+K00370 "nxr, nitrite oxidoreductase [EC:1.7.99.4] [RN:R00798]" nitrite + ammonia => nitrogen Energy Nitrogen nitrite + ammonia => nitrogen TRUE
+K00371 "nxr, nitrite oxidoreductase [EC:1.7.99.4] [RN:R00798]" nitrite + ammonia => nitrogen Energy Nitrogen nitrite + ammonia => nitrogen TRUE
+K01661 naphthoate synthase Menaquinone biosynthesis MISC MISC TRUE
+K01851 salicylate biosynthesis isochorismate synthase Menaquinone biosynthesis MISC MISC TRUE
+K01911 O-succinylbenzoic acid--CoA ligase Menaquinone biosynthesis MISC MISC TRUE
+K02361 isochorismate synthase Menaquinone biosynthesis MISC MISC TRUE
+K02548 "1,4-dihydroxy-2-naphthoate octaprenyltransferase" Menaquinone biosynthesis MISC MISC TRUE
+K02549 O-succinylbenzoate synthase Menaquinone biosynthesis MISC MISC TRUE
+K02551 2-succinyl-5-enolpyruvyl-6-hydroxy-3-cyclohexene-1-carboxylate synthase Menaquinone biosynthesis MISC MISC TRUE
+K02552 menaquinone-specific isochorismate synthase Menaquinone biosynthesis MISC MISC TRUE
+K03183 "demethylmenaquinone methyltransferase / 2-methoxy-6-polyprenyl-1,4-benzoquinol methylase" Menaquinone biosynthesis MISC MISC TRUE
+K08680 "2-succinyl-6-hydroxy-2,4-cyclohexadiene-1-carboxylate synthase" Menaquinone biosynthesis MISC MISC TRUE
+K12073 "1,4-dihydroxy-2-naphthoyl-CoA hydrolase" Menaquinone biosynthesis MISC MISC TRUE
+K19222 "1,4-dihydroxy-2-naphthoyl-CoA hydrolase" Menaquinone biosynthesis MISC MISC TRUE
+K00568 2-polyprenyl-6-hydroxyphenyl methylase / 3-demethylubiquinone-9 3-methyltransferase Ubiquinone biosynthesis MISC MISC TRUE
+K03179 4-hydroxybenzoate polyprenyltransferase Ubiquinone biosynthesis MISC MISC TRUE
+K03181 chorismate--pyruvate lyase Ubiquinone biosynthesis MISC MISC TRUE
+K03182 4-hydroxy-3-polyprenylbenzoate decarboxylase Ubiquinone biosynthesis MISC MISC TRUE
+K03183 "demethylmenaquinone methyltransferase / 2-methoxy-6-polyprenyl-1,4-benzoquinol methylase" Ubiquinone biosynthesis MISC MISC TRUE
+K03184 "2-octaprenyl-3-methyl-6-methoxy-1,4-benzoquinol hydroxylase" Ubiquinone biosynthesis MISC MISC TRUE
+K03185 2-octaprenyl-6-methoxyphenol hydroxylase Ubiquinone biosynthesis MISC MISC TRUE
+K03186 4-hydroxy-3-polyprenylbenzoate decarboxylase Ubiquinone biosynthesis MISC MISC TRUE
+K18240 chorismate lyase / 3-hydroxybenzoate synthase Ubiquinone biosynthesis MISC MISC TRUE
+K18800 2-octaprenylphenol hydroxylase Ubiquinone biosynthesis MISC MISC TRUE
+K22225 ahbAB; siroheme decarboxylase [RN:R12000] "Heme biosynthesis, archaea, siroheme => heme" MISC MISC TRUE
+K22226 "ahbC; 12,18-didecarboxysiroheme decarboxylase [RN:R12001]" "Heme biosynthesis, archaea, siroheme => heme" MISC MISC TRUE
+K22227 ahbD; heme synthase [RN:R12002] "Heme biosynthesis, archaea, siroheme => heme" MISC MISC TRUE
+K00232 acyl-CoA oxidase [EC:1.3.3.6] [RN:R07934 R07950] "beta-Oxidation, peroxisome, VLCFA" MISC MISC TRUE
+K12405 (3R)-3-hydroxyacyl-CoA dehydrogenase / enoyl-CoA hydratase 2 [EC:1.1.1.- 4.2.1.119] [RN:R07935 R07936 R07951 R07952] "beta-Oxidation, peroxisome, VLCFA" MISC MISC TRUE
+K07513 acetyl-CoA acyltransferase 1 [EC:2.3.1.16] [RN:R07937 R07953] "beta-Oxidation, peroxisome, VLCFA" MISC MISC TRUE
+K08764 sterol carrier protein 2 [EC:2.3.1.176] [RN:R07937 R07953] "beta-Oxidation, peroxisome, VLCFA" MISC MISC TRUE
+K10214 "3alpha,7alpha,12alpha-trihydroxy-5beta-cholestanoyl-CoA 24-hydroxylase [EC:1.17.99.3] [RN:R08735 R08740]" "beta-Oxidation, peroxisome, tri/dihydroxycholestanoyl-CoA => choloyl/chenodeoxycholoyl-CoA" MISC MISC TRUE
+K12405 "(3R)-3-hydroxyacyl-CoA dehydrogenase / 3a,7a,12a-trihydroxy-5b-cholest-24-enoyl-CoA hydratase [EC:1.1.1.- 4.2.1.107] [RN:R04813 R04812 R04809 R04810]" "beta-Oxidation, peroxisome, tri/dihydroxycholestanoyl-CoA => choloyl/chenodeoxycholoyl-CoA" MISC MISC TRUE
+K08764 sterol carrier protein 2 [EC:2.3.1.176] [RN:R03719 R04811] "beta-Oxidation, peroxisome, tri/dihydroxycholestanoyl-CoA => choloyl/chenodeoxycholoyl-CoA" MISC MISC TRUE
+K00643 5-aminolevulinate synthase [EC:2.3.1.37] [RN:R00830] "Heme biosynthesis, animals and fungi, glycine => heme" MISC MISC TRUE
+K01698 porphobilinogen synthase [EC:4.2.1.24] [RN:R00036] "Heme biosynthesis, animals and fungi, glycine => heme" MISC MISC TRUE
+K01749 hydroxymethylbilane synthase [EC:2.5.1.61] [RN:R00084] "Heme biosynthesis, animals and fungi, glycine => heme" MISC MISC TRUE
+K01719 uroporphyrinogen-III synthase [EC:4.2.1.75] [RN:R03165] "Heme biosynthesis, animals and fungi, glycine => heme" MISC MISC TRUE
+K01599 uroporphyrinogen decarboxylase [EC:4.1.1.37] [RN:R03197] "Heme biosynthesis, animals and fungi, glycine => heme" MISC MISC TRUE
+K00228 coproporphyrinogen III oxidase [EC:1.3.3.3] [RN:R03220] "Heme biosynthesis, animals and fungi, glycine => heme" MISC MISC TRUE
+K00231 protoporphyrinogen/coproporphyrinogen III oxidase [EC:1.3.3.4] [RN:R03222] "Heme biosynthesis, animals and fungi, glycine => heme" MISC MISC TRUE
+K01772 protoporphyrin/coproporphyrin ferrochelatase [EC:4.99.1.1] [RN:R00310] "Heme biosynthesis, animals and fungi, glycine => heme" MISC MISC TRUE
+K00012 UDPglucose 6-dehydrogenase [EC:1.1.1.22] [RN:R00286] Glucuronate pathway (uronate pathway) MISC MISC TRUE
+K12447 UDP-sugar pyrophosphorylase [EC:2.7.7.64] [RN:R01381] Glucuronate pathway (uronate pathway) MISC MISC TRUE
+K16190 glucuronokinase [EC:2.7.1.43] [RN:R01476] Glucuronate pathway (uronate pathway) MISC MISC TRUE
+K00699 glucuronosyltransferase [EC:2.4.1.17] [RN:R01383] Glucuronate pathway (uronate pathway) MISC MISC TRUE
+K01195 beta-glucuronidase [EC:3.2.1.31] [RN:R01478] Glucuronate pathway (uronate pathway) MISC MISC TRUE
+K14756 beta-glucuronidase [EC:3.2.1.31] [RN:R01478] Glucuronate pathway (uronate pathway) MISC MISC TRUE
+K00002 alcohol dehydrogenase (NADP+) [EC:1.1.1.2] [RN:R01481] Glucuronate pathway (uronate pathway) MISC MISC TRUE
+K13247 L-gulonate 3-dehydrogenase [EC:1.1.1.45] [RN:R02640] Glucuronate pathway (uronate pathway) MISC MISC TRUE
+K03331 L-xylulose reductase [EC:1.1.1.10] [RN:R01904] Glucuronate pathway (uronate pathway) MISC MISC TRUE
+K05351 D-xylulose reductase [EC:1.1.1.9] [RN:R01896] Glucuronate pathway (uronate pathway) MISC MISC TRUE
+K00008 L-iditol 2-dehydrogenase [EC:1.1.1.14] [RN:R01896] Glucuronate pathway (uronate pathway) MISC MISC TRUE
+K00854 xylulokinase [EC:2.7.1.17] [RN:R01639] Glucuronate pathway (uronate pathway) MISC MISC TRUE
+EC:1.16.1.1 mercury(II) reductase Mercury Energy Metal Reduction TRUE
+EC:1.20.4.1 arsenate reductase (glutaredoxin); ArsC (ambiguous) Arsenate Energy Metal Reduction TRUE
+EC:1.20.99.1 arsenate reductase (donor); arsenate:(acceptor) oxidoreductase Arsenate Energy Metal Reduction TRUE
+K17050 selenate/chlorate reductase subunit alpha[EC:1.97.1.9 1.97.1.1] Selenate/Chlorate Energy Metal Reduction TRUE
+K01697 cystathionine beta-synthase [EC:4.2.1.22] [RN:R01290] "Cysteine biosynthesis, homocysteine + serine => cysteine" Organic Nitrogen Amino Acid TRUE
+K10150 cystathionine beta-synthase [EC:4.2.1.22] [RN:R01290] "Cysteine biosynthesis, homocysteine + serine => cysteine" Organic Nitrogen Amino Acid TRUE
+K01758 cystathionine gamma-lyase [EC:4.4.1.1] [RN:R01001] "Cysteine biosynthesis, homocysteine + serine => cysteine" Organic Nitrogen Amino Acid TRUE
+K00789 S-adenosylmethionine synthetase [EC:2.5.1.6] [RN:R00177] "Cysteine biosynthesis, methionine => cysteine" Organic Nitrogen Amino Acid TRUE
+K17462 putative AdoMet-dependent methyltransferase [EC:2.1.1.-] [RN:R10404] "Cysteine biosynthesis, methionine => cysteine" Organic Nitrogen Amino Acid TRUE
+K01243 S-adenosylhomocysteine/5'-methylthioadenosine nucleosidase [EC:3.2.2.9] [RN:R00194] "Cysteine biosynthesis, methionine => cysteine" Organic Nitrogen Amino Acid TRUE
+K18284 S-adenosylhomocysteine/5'-methylthioadenosine nucleosidase [EC:3.2.2.9] [RN:R00194] "Cysteine biosynthesis, methionine => cysteine" Organic Nitrogen Amino Acid TRUE
+K07173 S-ribosylhomocysteine lyase [EC:4.4.1.21] [RN:R01291] "Cysteine biosynthesis, methionine => cysteine" Organic Nitrogen Amino Acid TRUE
+K17216 cystathionine beta-synthase (O-acetyl-L-serine) [EC:2.5.1.134] [RN:R10305] "Cysteine biosynthesis, methionine => cysteine" Organic Nitrogen Amino Acid TRUE
+K17217 cystathionine gamma-lyase [EC:4.4.1.1] [RN:R01001] "Cysteine biosynthesis, methionine => cysteine" Organic Nitrogen Amino Acid TRUE
+K00436 NAD-reducing hydrogenase large subunit [EC:1.12.1.2] hydrogenase Energy Hydrogenases TRUE
+K00437 [NiFe] hydrogenase large subunit [EC:1.12.2.1] hydrogenase Energy Hydrogenases TRUE
+K00440 coenzyme F420 hydrogenase subunit alpha [EC:1.12.98.1] hydrogenase Energy Hydrogenases TRUE
+K00441 coenzyme F420 hydrogenase subunit beta [EC:1.12.98.1] hydrogenase Energy Hydrogenases TRUE
+K00442 coenzyme F420 hydrogenase subunit delta hydrogenase Energy Hydrogenases TRUE
+K00443 coenzyme F420 hydrogenase subunit gamma [EC:1.12.98.1] hydrogenase Energy Hydrogenases TRUE
+K00532 ferredoxin hydrogenase [EC:1.12.7.2] hydrogenase Energy Hydrogenases TRUE
+K00533 ferredoxin hydrogenase large subunit [EC:1.12.7.2] hydrogenase Energy Hydrogenases TRUE
+K00534 ferredoxin hydrogenase small subunit [EC:1.12.7.2] hydrogenase Energy Hydrogenases TRUE
+K05586 bidirectional [NiFe] hydrogenase diaphorase subunit [EC:7.1.1.2] hydrogenase Energy Hydrogenases TRUE
+K05587 bidirectional [NiFe] hydrogenase diaphorase subunit [EC:7.1.1.2] hydrogenase Energy Hydrogenases TRUE
+K05588 bidirectional [NiFe] hydrogenase diaphorase subunit [EC:7.1.1.2] hydrogenase Energy Hydrogenases TRUE
+K06441 ferredoxin hydrogenase gamma subunit [EC:1.12.7.2] hydrogenase Energy Hydrogenases TRUE
+K06862 energy-converting hydrogenase B subunit Q hydrogenase Energy Hydrogenases TRUE
+K13942 "5,10-methenyltetrahydromethanopterin hydrogenase [EC:1.12.98.2]" hydrogenase Energy Hydrogenases TRUE
+K14068 "methanophenazine hydrogenase, large subunit [EC:1.12.98.3]" hydrogenase Energy Hydrogenases TRUE
+K14069 "methanophenazine hydrogenase, cytochrome b subunit [EC:1.12.98.3]" hydrogenase Energy Hydrogenases TRUE
+K14070 methanophenazine hydrogenase [EC:1.12.98.3] hydrogenase Energy Hydrogenases TRUE
+K14086 ech hydrogenase subunit A hydrogenase Energy Hydrogenases TRUE
+K14087 ech hydrogenase subunit B hydrogenase Energy Hydrogenases TRUE
+K14088 ech hydrogenase subunit C hydrogenase Energy Hydrogenases TRUE
+K14089 ech hydrogenase subunit D hydrogenase Energy Hydrogenases TRUE
+K14090 ech hydrogenase subunit E hydrogenase Energy Hydrogenases TRUE
+K14091 ech hydrogenase subunit F hydrogenase Energy Hydrogenases TRUE
+K14092 energy-converting hydrogenase A subunit A hydrogenase Energy Hydrogenases TRUE
+K14093 energy-converting hydrogenase A subunit B hydrogenase Energy Hydrogenases TRUE
+K14094 energy-converting hydrogenase A subunit C hydrogenase Energy Hydrogenases TRUE
+K14095 energy-converting hydrogenase A subunit D hydrogenase Energy Hydrogenases TRUE
+K14096 energy-converting hydrogenase A subunit E hydrogenase Energy Hydrogenases TRUE
+K14097 energy-converting hydrogenase A subunit F hydrogenase Energy Hydrogenases TRUE
+K14098 energy-converting hydrogenase A subunit G hydrogenase Energy Hydrogenases TRUE
+K14099 energy-converting hydrogenase A subunit H hydrogenase Energy Hydrogenases TRUE
+K14100 energy-converting hydrogenase A subunit I hydrogenase Energy Hydrogenases TRUE
+K14101 energy-converting hydrogenase A subunit J hydrogenase Energy Hydrogenases TRUE
+K14102 energy-converting hydrogenase A subunit K hydrogenase Energy Hydrogenases TRUE
+K14103 energy-converting hydrogenase A subunit L hydrogenase Energy Hydrogenases TRUE
+K14104 energy-converting hydrogenase A subunit M hydrogenase Energy Hydrogenases TRUE
+K14105 energy-converting hydrogenase A subunit N hydrogenase Energy Hydrogenases TRUE
+K14106 energy-converting hydrogenase A subunit O hydrogenase Energy Hydrogenases TRUE
+K14107 energy-converting hydrogenase A subunit P hydrogenase Energy Hydrogenases TRUE
+K14108 energy-converting hydrogenase A subunit Q hydrogenase Energy Hydrogenases TRUE
+K14109 energy-converting hydrogenase A subunit R hydrogenase Energy Hydrogenases TRUE
+K14110 energy-converting hydrogenase B subunit A hydrogenase Energy Hydrogenases TRUE
+K14111 energy-converting hydrogenase B subunit B hydrogenase Energy Hydrogenases TRUE
+K14112 energy-converting hydrogenase B subunit C hydrogenase Energy Hydrogenases TRUE
+K14113 energy-converting hydrogenase B subunit D hydrogenase Energy Hydrogenases TRUE
+K14114 energy-converting hydrogenase B subunit E hydrogenase Energy Hydrogenases TRUE
+K14115 energy-converting hydrogenase B subunit F hydrogenase Energy Hydrogenases TRUE
+K14116 energy-converting hydrogenase B subunit G hydrogenase Energy Hydrogenases TRUE
+K14117 energy-converting hydrogenase B subunit H hydrogenase Energy Hydrogenases TRUE
+K14118 energy-converting hydrogenase B subunit I hydrogenase Energy Hydrogenases TRUE
+K14119 energy-converting hydrogenase B subunit J hydrogenase Energy Hydrogenases TRUE
+K14120 energy-converting hydrogenase B subunit K hydrogenase Energy Hydrogenases TRUE
+K14121 energy-converting hydrogenase B subunit L hydrogenase Energy Hydrogenases TRUE
+K14122 energy-converting hydrogenase B subunit M hydrogenase Energy Hydrogenases TRUE
+K14123 energy-converting hydrogenase B subunit N hydrogenase Energy Hydrogenases TRUE
+K14124 energy-converting hydrogenase B subunit O hydrogenase Energy Hydrogenases TRUE
+K14125 energy-converting hydrogenase B subunit P hydrogenase Energy Hydrogenases TRUE
+K14126 F420-non-reducing hydrogenase large subunit [EC:1.12.99.- 1.8.98.5] hydrogenase Energy Hydrogenases TRUE
+K14127 F420-non-reducing hydrogenase iron-sulfur subunit [EC:1.12.99.- 1.8.98.5 1.8.98.6] hydrogenase Energy Hydrogenases TRUE
+K14128 F420-non-reducing hydrogenase small subunit [EC:1.12.99.- 1.8.98.5] hydrogenase Energy Hydrogenases TRUE
+K17992 NADP-reducing hydrogenase subunit HndB [EC:1.12.1.3] hydrogenase Energy Hydrogenases TRUE
+K18005 [NiFe] hydrogenase diaphorase moiety large subunit [EC:1.12.1.2] hydrogenase Energy Hydrogenases TRUE
+K18006 [NiFe] hydrogenase diaphorase moiety small subunit [EC:1.12.1.2] hydrogenase Energy Hydrogenases TRUE
+K18007 NAD-reducing hydrogenase small subunit [EC:1.12.1.2] hydrogenase Energy Hydrogenases TRUE
+K18008 [NiFe] hydrogenase small subunit [EC:1.12.2.1] hydrogenase Energy Hydrogenases TRUE
+K18016 membrane-bound hydrogenase subunit alpha [EC:1.12.7.2] hydrogenase Energy Hydrogenases TRUE
+K18017 membrane-bound hydrogenase subunit beta [EC:1.12.7.2] hydrogenase Energy Hydrogenases TRUE
+K18023 membrane-bound hydrogenase subunit mbhJ [EC:1.12.7.2] hydrogenase Energy Hydrogenases TRUE
+K18330 NADP-reducing hydrogenase subunit HndA [EC:1.12.1.3] hydrogenase Energy Hydrogenases TRUE
+K18331 NADP-reducing hydrogenase subunit HndC [EC:1.12.1.3] hydrogenase Energy Hydrogenases TRUE
+K18332 NADP-reducing hydrogenase subunit HndD [EC:1.12.1.3] hydrogenase Energy Hydrogenases TRUE
+K19640 "putative two-component system protein, hydrogenase maturation factor HypX/HoxX" hydrogenase Energy Hydrogenases TRUE
+K23548 uptake hydrogenase small subunit [EC:1.12.99.6] hydrogenase Energy Hydrogenases TRUE
+K23549 uptake hydrogenase large subunit [EC:1.12.99.6] hydrogenase Energy Hydrogenases TRUE
+K07540 benzylsuccinate synthase [EC:4.1.99.11] [RN:R05598] "Toluene degradation, anaerobic, toluene => benzoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K07543 benzylsuccinate CoA-transferase subunit [EC:2.8.3.15] [RN:R05588] "Toluene degradation, anaerobic, toluene => benzoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K07544 benzylsuccinate CoA-transferase subunit [EC:2.8.3.15] [RN:R05588] "Toluene degradation, anaerobic, toluene => benzoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K07545 bbsG; (R)-benzylsuccinyl-CoA dehydro genase [EC:1.3.8.3] [RN:R05584] "Toluene degradation, anaerobic, toluene => benzoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K07546 bbsH; E-phenylitaconyl-CoA hydratase [EC:4.2.1.-] [RN:R05599] "Toluene degradation, anaerobic, toluene => benzoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K07547 2-[hydroxy(phenyl)methyl]-succinyl-CoA dehydrogenase [EC:1.1.1.35] [RN:R05575] "Toluene degradation, anaerobic, toluene => benzoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K07548 2-[hydroxy(phenyl)methyl]-succinyl-CoA dehydrogenase [EC:1.1.1.35] [RN:R05575] "Toluene degradation, anaerobic, toluene => benzoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K07549 benzoylsuccinyl-CoA thiolase [EC:2.3.1.-] [RN:R05587] "Toluene degradation, anaerobic, toluene => benzoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K07550 benzoylsuccinyl-CoA thiolase [EC:2.3.1.-] [RN:R05587] "Toluene degradation, anaerobic, toluene => benzoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K05549 "benzoate/toluate 1,2-dioxygenase [EC:1.14.12.10 1.14.12.-] [RN:R05621 R05290 R05428 R05665]" "Benzoate degradation, benzoate => catechol / methylbenzoate => methylcatechol" carbon utilization hydrocarbon degradation TRUE
+K05550 "benzoate/toluate 1,2-dioxygenase [EC:1.14.12.10 1.14.12.-] [RN:R05621 R05290 R05428 R05665]" "Benzoate degradation, benzoate => catechol / methylbenzoate => methylcatechol" carbon utilization hydrocarbon degradation TRUE
+K05784 "benzoate/toluate 1,2-dioxygenase [EC:1.14.12.10 1.14.12.-] [RN:R05621 R05290 R05428 R05665]" "Benzoate degradation, benzoate => catechol / methylbenzoate => methylcatechol" carbon utilization hydrocarbon degradation TRUE
+K05783 "1,6-dihydroxycyclohexa-2,4-diene-1-carboxylate dehydrogenase [EC:1.3.1.25] [RN:R00813 R05292 R05314 R05309]" "Benzoate degradation, benzoate => catechol / methylbenzoate => methylcatechol" carbon utilization hydrocarbon degradation TRUE
+K18106 D-galacturonate reductase [EC:1.1.1.-] [RN:R07676 R10565] "D-Galacturonate degradation (fungi), D-galacturonate => glycerol" carbon utilization hydrocarbon degradation TRUE
+K19634 D-galacturonate reductase [EC:1.1.1.365] [RN:R07676] "D-Galacturonate degradation (fungi), D-galacturonate => glycerol" carbon utilization hydrocarbon degradation TRUE
+K18102 L-galactonate dehydratase [EC:4.2.1.146] [RN:R10532] "D-Galacturonate degradation (fungi), D-galacturonate => glycerol" carbon utilization hydrocarbon degradation TRUE
+K18103 L-threo-3-deoxy-hexylosonate aldolase [EC:4.1.2.54] [RN:R10550] "D-Galacturonate degradation (fungi), D-galacturonate => glycerol" carbon utilization hydrocarbon degradation TRUE
+K18107 L-glyceraldehyde reductase [EC:1.1.1.372] [RN:R10563] "D-Galacturonate degradation (fungi), D-galacturonate => glycerol" carbon utilization hydrocarbon degradation TRUE
+K00455 "3,4-dihydroxyphenylacetate 2,3-dioxygenase [EC:1.13.11.15] [RN:R03303]" "Homoprotocatechuate degradation, homoprotocatechuate => 2-oxohept-3-enedioate" carbon utilization hydrocarbon degradation TRUE
+K00151 5-carboxymethyl-2-hydroxymuconic-semialdehyde dehydrogenase [EC:1.2.1.60] [RN:R04418] "Homoprotocatechuate degradation, homoprotocatechuate => 2-oxohept-3-enedioate" carbon utilization hydrocarbon degradation TRUE
+K10219 2-hydroxy-4-carboxymuconate semialdehyde hemiacetal dehydrogenase [EC:1.1.1.312] [RN:R04418] "Homoprotocatechuate degradation, homoprotocatechuate => 2-oxohept-3-enedioate" carbon utilization hydrocarbon degradation TRUE
+K01826 5-carboxymethyl-2-hydroxymuconate isomerase [EC:5.3.3.10][RN:R04379] "Homoprotocatechuate degradation, homoprotocatechuate => 2-oxohept-3-enedioate" carbon utilization hydrocarbon degradation TRUE
+K05921 "5-oxopent-3-ene-1,2,5-tricarboxylate decarboxylase / 2-hydroxyhepta-2,4-diene-1,7-dioate isomerase [EC:4.1.1.68 5.3.3.-] [RN:R04380 R04134]" "Homoprotocatechuate degradation, homoprotocatechuate => 2-oxohept-3-enedioate" carbon utilization hydrocarbon degradation TRUE
+K14579 "nahA; naphthalene 1,2-dioxygenase [EC:1.14.12.12] [RN:R02968]" "Naphthalene degradation, naphthalene => salicylate" carbon utilization hydrocarbon degradation TRUE
+K14580 "nahA; naphthalene 1,2-dioxygenase [EC:1.14.12.12] [RN:R02968]" "Naphthalene degradation, naphthalene => salicylate" carbon utilization hydrocarbon degradation TRUE
+K14578 "nahA; naphthalene 1,2-dioxygenase [EC:1.14.12.12] [RN:R02968]" "Naphthalene degradation, naphthalene => salicylate" carbon utilization hydrocarbon degradation TRUE
+K14581 "nahA; naphthalene 1,2-dioxygenase [EC:1.14.12.12] [RN:R02968]" "Naphthalene degradation, naphthalene => salicylate" carbon utilization hydrocarbon degradation TRUE
+K14582 "nahB; cis-1,2-dihydro-1,2-dihydroxynaphthalene/dibenzothiophene dihydrodiol dehydrogenase [EC:1.3.1.29] [RN:R04115]" "Naphthalene degradation, naphthalene => salicylate" carbon utilization hydrocarbon degradation TRUE
+K14583 "1,2-dihydroxynaphthalene dioxygenase [EC:1.13.11.56] [RN:R04117]" "Naphthalene degradation, naphthalene => salicylate" carbon utilization hydrocarbon degradation TRUE
+K14584 2-hydroxychromene-2-carboxylate isomerase [EC:5.99.1.4] [RN:R05137] "Naphthalene degradation, naphthalene => salicylate" carbon utilization hydrocarbon degradation TRUE
+K14585 trans-o-hydroxybenzylidenepyruvate hydratase-aldolase [EC:4.1.2.45] [RN:R05136] "Naphthalene degradation, naphthalene => salicylate" carbon utilization hydrocarbon degradation TRUE
+K00152 salicylaldehyde dehydrogenase [EC:1.2.1.65] [RN:R02941] "Naphthalene degradation, naphthalene => salicylate" carbon utilization hydrocarbon degradation TRUE
+K15757 xylM; xylene monooxygenase [EC:1.14.13.-] [RN:R05288 R05442 R05443] "Xylene degradation, xylene => methylbenzoate" carbon utilization hydrocarbon degradation TRUE
+K15758 xylene monooxygenase electron transfer component [EC:1.18.1.3] "Xylene degradation, xylene => methylbenzoate" carbon utilization hydrocarbon degradation TRUE
+K00055 E1.1.1.90; aryl-alcohol dehydrogenase [EC:1.1.1.90] [RN:R05282 R05348 R05347] "Xylene degradation, xylene => methylbenzoate" carbon utilization hydrocarbon degradation TRUE
+K00141 xylC; benzaldehyde dehydrogenase (NAD) [EC:1.2.1.28] [RN:R05289 R05663 R05664] "Xylene degradation, xylene => methylbenzoate" carbon utilization hydrocarbon degradation TRUE
+K15760 toluene monooxygenase system [EC:1.14.13.-] [RN:R02550] "Toluene degradation, toluene => benzoate" carbon utilization hydrocarbon degradation TRUE
+K15761 toluene monooxygenase system [EC:1.14.13.-] [RN:R02550] "Toluene degradation, toluene => benzoate" carbon utilization hydrocarbon degradation TRUE
+K15762 toluene monooxygenase system [EC:1.14.13.-] [RN:R02550] "Toluene degradation, toluene => benzoate" carbon utilization hydrocarbon degradation TRUE
+K15763 toluene monooxygenase system [EC:1.14.13.-] [RN:R02550] "Toluene degradation, toluene => benzoate" carbon utilization hydrocarbon degradation TRUE
+K15764 toluene monooxygenase system [EC:1.14.13.-] [RN:R02550] "Toluene degradation, toluene => benzoate" carbon utilization hydrocarbon degradation TRUE
+K15765 toluene monooxygenase system [EC:1.14.13.-] [RN:R02550] "Toluene degradation, toluene => benzoate" carbon utilization hydrocarbon degradation TRUE
+K00055 xylB; aryl-alcohol dehydrogenase [EC:1.1.1.90] [RN:R01763] "Toluene degradation, toluene => benzoate" carbon utilization hydrocarbon degradation TRUE
+K00141 xylC; benzaldehyde dehydrogenase (NAD) [EC:1.2.1.28] [RN:R01419] "Toluene degradation, toluene => benzoate" carbon utilization hydrocarbon degradation TRUE
+K10619 "cmtA; p-cumate 2,3-dioxygenase [EC:1.14.12.25] [RN:R05247]" "Cumate degradation, p-cumate => 2-oxopent-4-enoate + 2-methylpropanoate" carbon utilization hydrocarbon degradation TRUE
+K16303 "cmtA; p-cumate 2,3-dioxygenase [EC:1.14.12.25] [RN:R05247]" "Cumate degradation, p-cumate => 2-oxopent-4-enoate + 2-methylpropanoate" carbon utilization hydrocarbon degradation TRUE
+K16304 "cmtA; p-cumate 2,3-dioxygenase [EC:1.14.12.25] [RN:R05247]" "Cumate degradation, p-cumate => 2-oxopent-4-enoate + 2-methylpropanoate" carbon utilization hydrocarbon degradation TRUE
+K18227 "cmtA; p-cumate 2,3-dioxygenase [EC:1.14.12.25] [RN:R05247]" "Cumate degradation, p-cumate => 2-oxopent-4-enoate + 2-methylpropanoate" carbon utilization hydrocarbon degradation TRUE
+K10620 "cmtB; 2,3-dihydroxy-2,3-dihydro-p-cumate dehydrogenase [EC:1.3.1.58] [RN:R05240]" "Cumate degradation, p-cumate => 2-oxopent-4-enoate + 2-methylpropanoate" carbon utilization hydrocarbon degradation TRUE
+K10621 "cmtC; 2,3-dihydroxy-p-cumate-3,4-dioxygenase [EC:1.13.11.-] [RN:R05248]" "Cumate degradation, p-cumate => 2-oxopent-4-enoate + 2-methylpropanoate" carbon utilization hydrocarbon degradation TRUE
+K10622 cmtD; HCOMODA decarboxylase [EC:4.1.1.-] [RN:R05377] "Cumate degradation, p-cumate => 2-oxopent-4-enoate + 2-methylpropanoate" carbon utilization hydrocarbon degradation TRUE
+K10623 cmtE; HOMODA hydrolase [EC:3.7.1.-] [RN: R05364] "Cumate degradation, p-cumate => 2-oxopent-4-enoate + 2-methylpropanoate" carbon utilization hydrocarbon degradation TRUE
+K04116 aliA; cyclohexanecarboxylate-CoA ligase [EC:6.2.1.-] [RN:R05620] "Benzoate degradation, cyclohexanecarboxylic acid =>pimeloyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K04117 aliB; cyclohexanecarboxyl-CoA dehydrogenase [EC:1.3.99.-] [RN:R05619] "Benzoate degradation, cyclohexanecarboxylic acid =>pimeloyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K07534 badK; cyclohex-1-ene-1-carboxyl-CoA hydratase [EC:4.2.1.-] [RN:R05600] "Benzoate degradation, cyclohexanecarboxylic acid =>pimeloyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K07535 badH; 2-hydroxycyclohexanecarboxyl-CoA dehydrogenase [EC:1.1.1.-] [RN:R05582] "Benzoate degradation, cyclohexanecarboxylic acid =>pimeloyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K07536 badI; 2-ketocyclohexanecarboxyl-CoA hydrolase [EC:3.1.2.-] [RN:R05592] "Benzoate degradation, cyclohexanecarboxylic acid =>pimeloyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K04112 benzoyl-CoA reductase [EC:1.3.7.8] [RN:R02451] "Benzoyl-CoA degradation, benzoyl-CoA => 3-hydroxypimeloyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K04113 benzoyl-CoA reductase [EC:1.3.7.8] [RN:R02451] "Benzoyl-CoA degradation, benzoyl-CoA => 3-hydroxypimeloyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K04114 benzoyl-CoA reductase [EC:1.3.7.8] [RN:R02451] "Benzoyl-CoA degradation, benzoyl-CoA => 3-hydroxypimeloyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K04115 benzoyl-CoA reductase [EC:1.3.7.8] [RN:R02451] "Benzoyl-CoA degradation, benzoyl-CoA => 3-hydroxypimeloyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K19515 benzoyl-CoA reductase [EC:1.3.-.-] [RN:R10961] "Benzoyl-CoA degradation, benzoyl-CoA => 3-hydroxypimeloyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K19516 benzoyl-CoA reductase [EC:1.3.-.-] [RN:R10961] "Benzoyl-CoA degradation, benzoyl-CoA => 3-hydroxypimeloyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K07537 "cyclohexa-1,5-dienecarbonyl-CoA hydratase [EC:4.2.1.100] [RN:R05597]" "Benzoyl-CoA degradation, benzoyl-CoA => 3-hydroxypimeloyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K07538 6-hydroxycyclohex-1-ene-1-carboxyl-CoA dehydrogenase [EC:1.1.1.368] [RN:R05581] "Benzoyl-CoA degradation, benzoyl-CoA => 3-hydroxypimeloyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K07539 6-oxo-cyclohex-1-ene-carbonyl-CoA hydrolase [EC:3.7.1.21] [RN:R05594] "Benzoyl-CoA degradation, benzoyl-CoA => 3-hydroxypimeloyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K08689 "biphenyl 2,3-dioxygenase [EC:1.14.12.18] [RN:R05263 R05264 R05261 R05262]" "Biphenyl degradation, biphenyl => 2-oxopent-4-enoate + benzoate" carbon utilization hydrocarbon degradation TRUE
+K15750 "biphenyl 2,3-dioxygenase [EC:1.14.12.18] [RN:R05263 R05264 R05261 R05262]" "Biphenyl degradation, biphenyl => 2-oxopent-4-enoate + benzoate" carbon utilization hydrocarbon degradation TRUE
+K18087 "biphenyl 2,3-dioxygenase [EC:1.14.12.18] [RN:R05263 R05264 R05261 R05262]" "Biphenyl degradation, biphenyl => 2-oxopent-4-enoate + benzoate" carbon utilization hydrocarbon degradation TRUE
+K18088 "biphenyl 2,3-dioxygenase [EC:1.14.12.18] [RN:R05263 R05264 R05261 R05262]" "Biphenyl degradation, biphenyl => 2-oxopent-4-enoate + benzoate" carbon utilization hydrocarbon degradation TRUE
+K08690 "cis-2,3-dihydrobiphenyl-2,3-diol dehydrogenase [EC:1.3.1.56] [RN:R05239 R05241]" "Biphenyl degradation, biphenyl => 2-oxopent-4-enoate + benzoate" carbon utilization hydrocarbon degradation TRUE
+K00462 "biphenyl-2,3-diol 1,2-dioxygenase [EC:1.13.11.39] [RN:R03462 R05245]" "Biphenyl degradation, biphenyl => 2-oxopent-4-enoate + benzoate" carbon utilization hydrocarbon degradation TRUE
+K10222 "2,6-dioxo-6-phenylhexa-3-enoate hydrolase [EC:3.7.1.8] [RN:R02606 R05359]" "Biphenyl degradation, biphenyl => 2-oxopent-4-enoate + benzoate" carbon utilization hydrocarbon degradation TRUE
+K15751 "carbazole 1,9a-dioxygenase [EC:1.14.12.22] [RN:R05414 R09512]" "Carbazole degradation, carbazole => 2-oxopent-4-enoate + anthranilate" carbon utilization hydrocarbon degradation TRUE
+K15752 "carbazole 1,9a-dioxygenase [EC:1.14.12.22] [RN:R05414 R09512]" "Carbazole degradation, carbazole => 2-oxopent-4-enoate + anthranilate" carbon utilization hydrocarbon degradation TRUE
+K15753 "carbazole 1,9a-dioxygenase [EC:1.14.12.22] [RN:R05414 R09512]" "Carbazole degradation, carbazole => 2-oxopent-4-enoate + anthranilate" carbon utilization hydrocarbon degradation TRUE
+K15754 "2'-aminobiphenyl-2,3-diol 1,2-dioxygenase [EC:1.13.11.-] [RN:R05415]" "Carbazole degradation, carbazole => 2-oxopent-4-enoate + anthranilate" carbon utilization hydrocarbon degradation TRUE
+K15755 "2'-aminobiphenyl-2,3-diol 1,2-dioxygenase [EC:1.13.11.-] [RN:R05415]" "Carbazole degradation, carbazole => 2-oxopent-4-enoate + anthranilate" carbon utilization hydrocarbon degradation TRUE
+K15756 "2-hydroxy-6-oxo-6-(2'-aminophenyl)hexa-2, 4-dienoate hydrolase [EC:3.7.1.13] [RN:R05365]" "Carbazole degradation, carbazole => 2-oxopent-4-enoate + anthranilate" carbon utilization hydrocarbon degradation TRUE
+K05708 3-phenylpropionate/cinnamic acid dioxygenase [EC:1.14.12.19] [RN:R06783] "Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K05709 3-phenylpropionate/cinnamic acid dioxygenase [EC:1.14.12.19] [RN:R06783] "Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K05710 3-phenylpropionate/cinnamic acid dioxygenase [EC:1.14.12.19] [RN:R06783] "Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K00529 3-phenylpropionate/cinnamic acid dioxygenase [EC:1.14.12.19] [RN:R06783] "Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K05711 "2,3-dihydroxy-2,3-dihydrophenylpropionate dehydrogenase [EC:1.3.1.87] [RN:R06785]" "Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K05712 mhpA; 3-(3-hydroxy-phenyl)propionate hydroxylase [EC:1.14.13.127] [RN:R06787] "Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K05713 "2,3-dihydroxyphenylpropionate 1,2-dioxygenase [EC:1.13.11.16] [RN:R06788]" "Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K05714 "2-hydroxy-6-ketonona-2,4-dienedioic acid hydrolase [EC:3.7.1.14] [RN:R06789]" "Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K02554 2-keto-4-pentenoate hydratase [EC:4.2.1.80] [RN:R02601] "Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K01666 4-hydroxy 2-oxovalerate aldolase [EC:4.1.3.39] [RN:R00750] "Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K04073 acetaldehyde dehydrogenase [EC:1.2.1.10] [RN:R00228] "Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K03268 benzene/toluene dioxygenase subunit alpha [EC:1.14.12.3 1.14.12.11] [RN:R03543 R03559] "Benzene/toluene degradation, benzene => catechol / toluene => 3-methylcatechol" carbon utilization hydrocarbon degradation TRUE
+K16268 benzene/toluene dioxygenase subunit alpha [EC:1.14.12.3 1.14.12.11] [RN:R03543 R03559] "Benzene/toluene degradation, benzene => catechol / toluene => 3-methylcatechol" carbon utilization hydrocarbon degradation TRUE
+K18089 benzene/toluene dioxygenase subunit alpha [EC:1.14.12.3 1.14.12.11] [RN:R03543 R03559] "Benzene/toluene degradation, benzene => catechol / toluene => 3-methylcatechol" carbon utilization hydrocarbon degradation TRUE
+K18090 benzene/toluene dioxygenase subunit alpha [EC:1.14.12.3 1.14.12.11] [RN:R03543 R03559] "Benzene/toluene degradation, benzene => catechol / toluene => 3-methylcatechol" carbon utilization hydrocarbon degradation TRUE
+K16269 "cis-1,2-dihydrobenzene-1,2-diol dehydrogenase [EC:1.3.1.19] [RN:R00812 R04088]" "Benzene/toluene degradation, benzene => catechol / toluene => 3-methylcatechol" carbon utilization hydrocarbon degradation TRUE
+K16249 dmpK; phenol hydroxylase P0 protein [RN:R10042 R10043] "Benzene degradation, benzene => catechol" carbon utilization hydrocarbon degradation TRUE
+K16243 dmpL; Phenol hydroxylase P1 protein [RN:R10042 R10043] "Benzene degradation, benzene => catechol" carbon utilization hydrocarbon degradation TRUE
+K16244 dmpM; phenol hydroxylase P2 protein [RN:R10042 R10043] "Benzene degradation, benzene => catechol" carbon utilization hydrocarbon degradation TRUE
+K16242 dmpN; phenol hydroxylase P3 protein [EC:1.14.13.-] [RN:R10042 R10043] "Benzene degradation, benzene => catechol" carbon utilization hydrocarbon degradation TRUE
+K16245 dmpO; phenol hydroxylase P4 protein [RN:R10042 R10043] "Benzene degradation, benzene => catechol" carbon utilization hydrocarbon degradation TRUE
+K16246 dmpP; phenol hydroxylase P5 protein [RN:R10042 R10043] "Benzene degradation, benzene => catechol" carbon utilization hydrocarbon degradation TRUE
+K18068 "phthalate 4,5-dioxygenase [EC:1.14.12.7] [RN:R03630]" "Phthalate degradation, phthalate => protocatechuate" carbon utilization hydrocarbon degradation TRUE
+K18069 "phthalate 4,5-dioxygenase [EC:1.14.12.7] [RN:R03630]" "Phthalate degradation, phthalate => protocatechuate" carbon utilization hydrocarbon degradation TRUE
+K18067 "phthalate 4,5-cis-dihydrodiol dehydrogenase [EC:1.3.1.64] [RN:R05275]" "Phthalate degradation, phthalate => protocatechuate" carbon utilization hydrocarbon degradation TRUE
+K04102 "4,5-dihydroxyphthalate decarboxylase [EC:4.1.1.55] [RN:R01635]" "Phthalate degradation, phthalate => protocatechuate" carbon utilization hydrocarbon degradation TRUE
+K18074 "K18075,K18077 terephthalate 1,2-dioxygenase [EC:1.14.12.15] [RN:R05148]" "Terephthalate degradation, terephthalate => 3,4-dihydroxybenzoate" carbon utilization hydrocarbon degradation TRUE
+K18075 tphA3 "Terephthalate degradation, terephthalate => 3,4-dihydroxybenzoate" carbon utilization hydrocarbon degradation TRUE
+K18077 tphA1 "Terephthalate degradation, terephthalate => 3,4-dihydroxybenzoate" carbon utilization hydrocarbon degradation TRUE
+K18076 "1,2-dihydroxy-3,5-cyclohexadiene-1,4-dicarboxylate dehydrogenase [EC:1.3.1.53] [RN:R01633]" "Terephthalate degradation, terephthalate => 3,4-dihydroxybenzoate" carbon utilization hydrocarbon degradation TRUE
+K18251 "phtA; phthalate 3,4-dioxygenase [EC:1.14.12.-] [RN:R09227]" "Phthalate degradation, phthalate => protocatechuate" carbon utilization hydrocarbon degradation TRUE
+K18252 "phtA; phthalate 3,4-dioxygenase [EC:1.14.12.-] [RN:R09227]" "Phthalate degradation, phthalate => protocatechuate" carbon utilization hydrocarbon degradation TRUE
+K18253 "phtA; phthalate 3,4-dioxygenase [EC:1.14.12.-] [RN:R09227]" "Phthalate degradation, phthalate => protocatechuate" carbon utilization hydrocarbon degradation TRUE
+K18254 "phtA; phthalate 3,4-dioxygenase [EC:1.14.12.-] [RN:R09227]" "Phthalate degradation, phthalate => protocatechuate" carbon utilization hydrocarbon degradation TRUE
+K18255 "phtB; phthalate 3,4-cis-dihydrodiol dehydrogenase [EC:1.3.1.-] [RN:R09228]" "Phthalate degradation, phthalate => protocatechuate" carbon utilization hydrocarbon degradation TRUE
+K18256 "phtC; 3,4-dihydroxyphthalate decarboxylase [EC:4.1.1.69] [RN:R01634]" "Phthalate degradation, phthalate => protocatechuate" carbon utilization hydrocarbon degradation TRUE
+K03381 "catechol 1,2-dioxygenase [EC:1.13.11.1] [RN:R00817]" "Catechol ortho-cleavage, catechol => 3-oxoadipate" carbon utilization hydrocarbon degradation TRUE
+K01856 muconate cycloisomerase [EC:5.5.1.1] [RN:R06989] "Catechol ortho-cleavage, catechol => 3-oxoadipate" carbon utilization hydrocarbon degradation TRUE
+K03464 muconolactone D-isomerase [EC:5.3.3.4] [RN:R06990] "Catechol ortho-cleavage, catechol => 3-oxoadipate" carbon utilization hydrocarbon degradation TRUE
+K01055 3-oxoadipate enol-lactonase [EC:3.1.1.24] [RN:R02991] "Catechol ortho-cleavage, catechol => 3-oxoadipate" carbon utilization hydrocarbon degradation TRUE
+K14727 oxoadipate enol-lactonase / 4-carboxymuconolactone decarboxylase [EC:3.1.1.24 4.1.1.44] "Catechol ortho-cleavage, catechol => 3-oxoadipate" carbon utilization hydrocarbon degradation TRUE
+K00446 "catechol 2,3-dioxygenase [EC:1.13.11.2] [RN:R00816 R05295]" "Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K07104 "catechol 2,3-dioxygenase [EC:1.13.11.2] [RN:R00816 R05295]" "Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K10217 2-hydroxymuconate-6-semialdehyde dehydrogenase [EC:1.2.1.85] [RN:R02762 R05353] "Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K01821 4-oxalocrotonate tautomerase [EC:5.3.2.6] [RN:R03966 R05389] "Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K01617 4-oxalocrotonate decarboxylase [EC:4.1.1.77] [RN:R02602 R05374] "Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K10216 2-hydroxymuconate-semialdehyde hydrolase [EC:3.7.1.9] [RN:R02604 R05865] "Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K18364 2-oxopent-4-enoate/cis-2-oxohex-4-enoate hydratase [EC:4.2.1.80 4.2.1.132] [RN:R02601 R05864] "Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K02554 2-keto-4-pentenoate hydratase [EC:4.2.1.80] [RN:R02601] "Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K18365 4-hydroxy-2-oxovalerate/4-hydroxy-2-oxohexanoate aldolase [EC:4.1.3.39 4.1.3.43] [RN:R00750 R05298] "Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K01666 4-hydroxy 2-oxovalerate aldolase [EC:4.1.3.39] [RN:R00750] "Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K18366 acetaldehyde/propanal dehydrogenase [EC:1.2.1.10 1.2.1.87] [RN:R00228 R09097] "Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K04073 acetaldehyde dehydrogenase [EC:1.2.1.10] [RN:R00228] "Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K00448 "pcaG; protocatechuate 3,4-dioxygenase, alpha subunit [EC:1.13.11.3]" "protocatechuate degradation, protocatechuate => 3-oxoadipate" carbon utilization hydrocarbon degradation TRUE
+K00449 "pcaH; protocatechuate 3,4-dioxygenase, beta subunit [EC:1.13.11.3]" "protocatechuate degradation, protocatechuate => 3-oxoadipate" carbon utilization hydrocarbon degradation TRUE
+K01857 "pcaB; 3-carboxy-cis,cis-muconate cycloisomerase [EC:5.5.1.2]" "protocatechuate degradation, protocatechuate => 3-oxoadipate" carbon utilization hydrocarbon degradation TRUE
+K01607 pcaC; 4-carboxymuconolactone decarboxylase [EC:4.1.1.44] "protocatechuate degradation, protocatechuate => 3-oxoadipate" carbon utilization hydrocarbon degradation TRUE
+K14727 pcaL; 3-oxoadipate enol-lactonase / 4-carboxymuconolactone decarboxylase [EC:3.1.1.24 4.1.1.44] "protocatechuate degradation, protocatechuate => 3-oxoadipate" carbon utilization hydrocarbon degradation TRUE
+K04100 "ligaA; protocatechuate 4,5-dioxygenase, alpha chain [EC:1.13.11.8]" "protocatechuate degradation, protocatechuate => oxaloacteate + pyruvate" carbon utilization hydrocarbon degradation TRUE
+K04101 "ligB; protocatechuate 4,5-dioxygenase, beta chain [EC:1.13.11.8]" "protocatechuate degradation, protocatechuate => oxaloacteate + pyruvate" carbon utilization hydrocarbon degradation TRUE
+K10219 ligC; 2-hydroxy-4-carboxymuconate semialdehyde hemiacetal dehydrogenase [EC:1.1.1.312] "protocatechuate degradation, protocatechuate => oxaloacteate + pyruvate" carbon utilization hydrocarbon degradation TRUE
+K10221 "ligI; 2-pyrone-4,6-dicarboxylate lactonase [EC:3.1.1.57]" "protocatechuate degradation, protocatechuate => oxaloacteate + pyruvate" carbon utilization hydrocarbon degradation TRUE
+K16514 galD; 4-oxalomesaconate tautomerase [EC:5.3.2.8] "protocatechuate degradation, protocatechuate => oxaloacteate + pyruvate" carbon utilization hydrocarbon degradation TRUE
+K10220 ligJ; 4-oxalmesaconate hydratase [EC:4.2.1.83] "protocatechuate degradation, protocatechuate => oxaloacteate + pyruvate" carbon utilization hydrocarbon degradation TRUE
+K10218 ligK; 4-hydroxy-4-methyl-2-oxoglutarate aldolase [EC:4.1.3.17] "protocatechuate degradation, protocatechuate => oxaloacteate + pyruvate" carbon utilization hydrocarbon degradation TRUE
+K10759 tannase [EC:3.1.1.20] hydrolyzable tannin degradation => gallate carbon utilization hydrocarbon degradation TRUE
+K04099 "desB, galA; gallate dioxygenase [EC:1.13.11.57]" aerobic gallate degradation carbon utilization hydrocarbon degradation TRUE
+K22958 lpdC; gallate decarboxylase subunit C [EC:4.1.1.59] "anaerobic gallate degradation, gallate => 3-hydroxybutanoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K22959 lpdB; gallate decarboxylase subunit B "anaerobic gallate degradation, gallate => 3-hydroxybutanoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K22960 lpdD; gallate decarboxylase subunit D "anaerobic gallate degradation, gallate => 3-hydroxybutanoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+1.97.1.2 pyrogallol transhydroxylase "anaerobic gallate degradation, gallate => 3-hydroxybutanoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+1.3.1.57 phloroglucinol reductase "anaerobic gallate degradation, gallate => 3-hydroxybutanoyl-CoA" carbon utilization hydrocarbon degradation TRUE
+K15064 desA; syringate O-demethylase [EC:2.1.1.-] lignin subunit degradation carbon utilization hydrocarbon degradation TRUE
+K15066 ligM; vanillate/3-O-methylgallate O-demethylase [EC:2.1.1.341] lignin subunit degradation carbon utilization hydrocarbon degradation TRUE
+K15065 "desZ; 3-O-methylgallate 3,4-dioxygenase [EC:1.13.11.-]" lignin subunit degradation carbon utilization hydrocarbon degradation TRUE
+k21802 vdh; vanillin dehydrogenase [EC:1.2.1.67] lignin subunit degradation carbon utilization hydrocarbon degradation TRUE
+K03862 vanA; vanillate monooxygenase [EC:1.14.13.82] lignin subunit degradation carbon utilization hydrocarbon degradation TRUE
+K03863 vanB; vanillate monooxygenase ferredoxin subunit lignin subunit degradation carbon utilization hydrocarbon degradation TRUE
+K15060 "ligX; 5,5'-dehydrodivanillate O-demethylase" lignin subunit degradation carbon utilization hydrocarbon degradation TRUE
+K15061 ligZ; OH-DDVA oxygenase lignin subunit degradation carbon utilization hydrocarbon degradation TRUE
+K15062 ligY; OH-DDVA meta-cleavage compound hydrolase lignin subunit degradation carbon utilization hydrocarbon degradation TRUE
+K15063 ligW; 5-carboxyvanillate decarboxylase lignin subunit degradation carbon utilization hydrocarbon degradation TRUE
+K23526 "gcoA; aromatic O-demethylase, cytochrome P450 subunit [EC:1.14.14.-]" lignin subunit degradation carbon utilization hydrocarbon degradation TRUE
+K23527 "gcoB; aromatic O-demethylase, reductase subunit [EC:1.6.2.-]" lignin subunit degradation carbon utilization hydrocarbon degradation TRUE
+K02399 flagella synthesis protein FlgN Flagellar Assembly MISC Flagellar cytoplasmic chaperone TRUE
+K02413 flagellar FliJ protein Flagellar Assembly MISC Flagellar cytoplasmic chaperone TRUE
+K02422 flagellar protein FliS Flagellar Assembly MISC Flagellar cytoplasmic chaperone TRUE
+K02423 flagellar protein FliT Flagellar Assembly MISC Flagellar cytoplasmic chaperone TRUE
+K02386 flagella basal body P-ring formation protein FlgA Flagellar Assembly MISC Flagellar cytoplasmic chaperone TRUE
+K02406 flagellin Flagellar Assembly MISC Flagella Structure TRUE
+K02407 flagellar hook-associated protein 2 Flagellar Assembly MISC Flagella Structure TRUE
+K02397 flagellar hook-associated protein 3 FlgL Flagellar Assembly MISC Flagella Structure TRUE
+K02396 flagellar hook-associated protein 1 FlgK Flagellar Assembly MISC Flagella Structure TRUE
+K02414 flagellar hook-length control protein FliK Flagellar Assembly MISC Flagella Structure TRUE
+K02389 flagellar basal-body rod modification protein FlgD Flagellar Assembly MISC Flagella Structure TRUE
+K02390 flagellar hook protein FlgE Flagellar Assembly MISC Flagella Structure TRUE
+K02391 flagellar basal-body rod protein FlgF Flagellar Assembly MISC Flagella Structure TRUE
+K02392 flagellar basal-body rod protein FlgG Flagellar Assembly MISC Flagella Structure TRUE
+K02393 flagellar L-ring protein precursor FlgH Flagellar Assembly MISC Flagella Structure TRUE
+K02394 flagellar P-ring protein precursor FlgI Flagellar Assembly MISC Flagella Structure TRUE
+K02387 flagellar basal-body rod protein FlgB Flagellar Assembly MISC Flagella Structure TRUE
+K02388 flagellar basal-body rod protein FlgC Flagellar Assembly MISC Flagella Structure TRUE
+K02408 flagellar hook-basal body complex protein FliE Flagellar Assembly MISC Flagella Structure TRUE
+K02409 flagellar M-ring protein FliF Flagellar Assembly MISC Flagella Structure TRUE
+K02410 flagellar motor switch protein FliG Flagellar Assembly MISC Flagella Structure TRUE
+K02416 flagellar motor switch protein FliM Flagellar Assembly MISC Flagella Structure TRUE
+K02417 flagellar motor switch protein FliN/FliY Flagellar Assembly MISC Flagella Structure TRUE
+K02400 flagellar biosynthesis protein FlhA Flagellar Assembly MISC Flagella Structure TRUE
+K02401 flagellar biosynthetic protein FlhB Flagellar Assembly MISC Flagella Structure TRUE
+K02411 flagellar assembly protein FliH Flagellar Assembly MISC Flagella Structure TRUE
+K02412 flagellum-specific ATP synthase [EC:7.4.2.8] Flagellar Assembly MISC Flagella Structure TRUE
+K02418 flagellar protein FliO/FliZ Flagellar Assembly MISC Flagella Structure TRUE
+K02419 flagellar biosynthetic protein FliP Flagellar Assembly MISC Flagella Structure TRUE
+K02420 flagellar biosynthetic protein FliQ Flagellar Assembly MISC Flagella Structure TRUE
+K02421 flagellar biosynthetic protein FliR Flagellar Assembly MISC Flagella Structure TRUE
+K13820 flagellar biosynthetic protein FliR/FlhB Flagellar Assembly MISC Flagella Structure TRUE
+K02556 chemotaxis protein MotA Flagellar Assembly MISC Flagella Structure TRUE
+K02557 chemotaxis protein MotB Flagellar Assembly MISC Flagella Structure TRUE
+K21217 sodium-type polar flagellar protein MotX Flagellar Assembly MISC Flagella Structure TRUE
+K21218 sodium-type flagellar protein MotY Flagellar Assembly MISC Flagella Structure TRUE
+K00249 acyl-CoA dehydrogenase [EC:1.3.8.7] [RN:R04432] "Malonate semialdehyde pathway, propanoyl-CoA => acetyl-CoA" Energy Electron transport Chain TRUE
+K07511 enoyl-CoA hydratase [EC:4.2.1.17] [RN:R03045] "Malonate semialdehyde pathway, propanoyl-CoA => acetyl-CoA" Energy Electron transport Chain TRUE
+K07514 enoyl-CoA hydratase [EC:4.2.1.17] [RN:R03045] "Malonate semialdehyde pathway, propanoyl-CoA => acetyl-CoA" Energy Electron transport Chain TRUE
+K07515 enoyl-CoA hydratase [EC:4.2.1.17] [RN:R03045] "Malonate semialdehyde pathway, propanoyl-CoA => acetyl-CoA" Energy Electron transport Chain TRUE
+K14729 multifunctional beta-oxidation protein [EC:4.2.1.-] [RN:R03045] "Malonate semialdehyde pathway, propanoyl-CoA => acetyl-CoA" Energy Electron transport Chain TRUE
+K05605 3-hydroxyisobutyryl-CoA hydrolase [EC:3.1.2.4] [RN:R03157 R03158] "Malonate semialdehyde pathway, propanoyl-CoA => acetyl-CoA" Energy Electron transport Chain TRUE
+K23146 3-hydroxypropionate dehydrogenase [EC:1.1.1.59] [RN:R01608] "Malonate semialdehyde pathway, propanoyl-CoA => acetyl-CoA" Energy Electron transport Chain TRUE
+K00140 malonate-semialdehyde dehydrogenase (acetylating) [EC:1.2.1.18] [RN:R00740] "Malonate semialdehyde pathway, propanoyl-CoA => acetyl-CoA" Energy Electron transport Chain TRUE
+K00330 nuoA; NADH-quinone oxidoreductase subunit A [EC:7.1.1.2] "NADH:quinone oxidoreductase, prokaryotes" Energy Electron transport Chain TRUE
+K00331 nuoB; NADH-quinone oxidoreductase subunit B [EC:7.1.1.2] "NADH:quinone oxidoreductase, prokaryotes" Energy Electron transport Chain TRUE
+K00332 nuoC; NADH-quinone oxidoreductase subunit C [EC:7.1.1.2] "NADH:quinone oxidoreductase, prokaryotes" Energy Electron transport Chain TRUE
+K00333 nuoD; NADH-quinone oxidoreductase subunit D [EC:7.1.1.2] "NADH:quinone oxidoreductase, prokaryotes" Energy Electron transport Chain TRUE
+K13378 nuoCD; NADH-quinone oxidoreductase subunit C/D [EC:7.1.1.2] "NADH:quinone oxidoreductase, prokaryotes" Energy Electron transport Chain TRUE
+K13380 nuoBCD; NADH-quinone oxidoreductase subunit B/C/D [EC:7.1.1.2] "NADH:quinone oxidoreductase, prokaryotes" Energy Electron transport Chain TRUE
+K00334 nuoE; NADH-quinone oxidoreductase subunit E [EC:7.1.1.2] "NADH:quinone oxidoreductase, prokaryotes" Energy Electron transport Chain TRUE
+K00335 nuoF; NADH-quinone oxidoreductase subunit F [EC:7.1.1.2] "NADH:quinone oxidoreductase, prokaryotes" Energy Electron transport Chain TRUE
+K00336 nuoG; NADH-quinone oxidoreductase subunit G [EC:7.1.1.2] "NADH:quinone oxidoreductase, prokaryotes" Energy Electron transport Chain TRUE
+K00337 nuoH; NADH-quinone oxidoreductase subunit H [EC:7.1.1.2] "NADH:quinone oxidoreductase, prokaryotes" Energy Electron transport Chain TRUE
+K00338 nuoI; NADH-quinone oxidoreductase subunit I [EC:7.1.1.2] "NADH:quinone oxidoreductase, prokaryotes" Energy Electron transport Chain TRUE
+K00339 nuoJ; NADH-quinone oxidoreductase subunit J [EC:7.1.1.2] "NADH:quinone oxidoreductase, prokaryotes" Energy Electron transport Chain TRUE
+K00340 nuoK; NADH-quinone oxidoreductase subunit K [EC:7.1.1.2] "NADH:quinone oxidoreductase, prokaryotes" Energy Electron transport Chain TRUE
+K00341 nuoL; NADH-quinone oxidoreductase subunit L [EC:7.1.1.2] "NADH:quinone oxidoreductase, prokaryotes" Energy Electron transport Chain TRUE
+K00342 nuoM; NADH-quinone oxidoreductase subunit M [EC:7.1.1.2] "NADH:quinone oxidoreductase, prokaryotes" Energy Electron transport Chain TRUE
+K15863 nuoLM; NADH-quinone oxidoreductase subunit L/M [EC:7.1.1.2] "NADH:quinone oxidoreductase, prokaryotes" Energy Electron transport Chain TRUE
+K00343 nuoN; NADH-quinone oxidoreductase subunit N [EC:7.1.1.2] "NADH:quinone oxidoreductase, prokaryotes" Energy Electron transport Chain TRUE
+K05574 ndhC; NAD(P)H-quinone oxidoreductase subunit 3 [EC:7.1.1.2] "NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria" Energy Electron transport Chain TRUE
+K05582 ndhK; NAD(P)H-quinone oxidoreductase subunit K [EC:7.1.1.2] "NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria" Energy Electron transport Chain TRUE
+K05581 ndhJ; NAD(P)H-quinone oxidoreductase subunit J [EC:7.1.1.2] "NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria" Energy Electron transport Chain TRUE
+K05579 ndhH; NAD(P)H-quinone oxidoreductase subunit H [EC:7.1.1.2] "NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria" Energy Electron transport Chain TRUE
+K05572 ndhA; NAD(P)H-quinone oxidoreductase subunit 1 [EC:7.1.1.2] "NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria" Energy Electron transport Chain TRUE
+K05580 ndhI; NAD(P)H-quinone oxidoreductase subunit I [EC:7.1.1.2] "NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria" Energy Electron transport Chain TRUE
+K05578 ndhG; NAD(P)H-quinone oxidoreductase subunit 6 [EC:7.1.1.2] "NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria" Energy Electron transport Chain TRUE
+K05576 ndhE; NAD(P)H-quinone oxidoreductase subunit 4L [EC:7.1.1.2] "NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria" Energy Electron transport Chain TRUE
+K05577 ndhF; NAD(P)H-quinone oxidoreductase subunit 5 [EC:7.1.1.2] "NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria" Energy Electron transport Chain TRUE
+K05575 ndhD; NAD(P)H-quinone oxidoreductase subunit 4 [EC:7.1.1.2] "NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria" Energy Electron transport Chain TRUE
+K05573 ndhB; NAD(P)H-quinone oxidoreductase subunit 2 [EC:7.1.1.2] "NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria" Energy Electron transport Chain TRUE
+K05583 ndhL; NAD(P)H-quinone oxidoreductase subunit L [EC:7.1.1.2] "NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria" Energy Electron transport Chain TRUE
+K05584 ndhM; NAD(P)H-quinone oxidoreductase subunit M [EC:7.1.1.2] "NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria" Energy Electron transport Chain TRUE
+K05585 ndhN; NAD(P)H-quinone oxidoreductase subunit N [EC:7.1.1.2] "NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria" Energy Electron transport Chain TRUE
+K00236 SDHC; succinate dehydrogenase (ubiquinone) cytochrome b560 subunit Succinate dehydrogenase (ubiquinone) Energy Electron transport Chain TRUE
+K00237 SDHD; succinate dehydrogenase (ubiquinone) membrane anchor subunit Succinate dehydrogenase (ubiquinone) Energy Electron transport Chain TRUE
+K00234 SDHA; succinate dehydrogenase (ubiquinone) flavoprotein subunit [EC:1.3.5.1] Succinate dehydrogenase (ubiquinone) Energy Electron transport Chain TRUE
+K00235 SDHB; succinate dehydrogenase (ubiquinone) iron-sulfur subunit [EC:1.3.5.1] Succinate dehydrogenase (ubiquinone) Energy Electron transport Chain TRUE
+K00241 sdhC; succinate dehydrogenase cytochrome b556 subunit "Succinate dehydrogenase, prokaryotes" Energy Electron transport Chain TRUE
+K00242 sdhD; succinate dehydrogenase membrane anchor subunit "Succinate dehydrogenase, prokaryotes" Energy Electron transport Chain TRUE
+K00239 sdhA; succinate dehydrogenase flavoprotein subunit [EC:1.3.5.1] "Succinate dehydrogenase, prokaryotes" Energy Electron transport Chain TRUE
+K00240 sdhB; succinate dehydrogenase iron-sulfur subunit [EC:1.3.5.1] "Succinate dehydrogenase, prokaryotes" Energy Electron transport Chain TRUE
+K00244 frdA; fumarate reductase flavoprotein subunit [EC:1.3.5.4] "Fumarate reductase, prokaryotes" Energy Electron transport Chain TRUE
+K00245 frdB; fumarate reductase iron-sulfur subunit [EC:1.3.5.4] "Fumarate reductase, prokaryotes" Energy Electron transport Chain TRUE
+K00246 frdC; fumarate reductase subunit C "Fumarate reductase, prokaryotes" Energy Electron transport Chain TRUE
+K00247 frdD; fumarate reductase subunit D "Fumarate reductase, prokaryotes" Energy Electron transport Chain TRUE
+K02111 ATPF1A; F-type H+-transporting ATPase subunit alpha [EC:3.6.3.14] "F-type ATPase, prokaryotes and chloroplasts" Energy Electron transport Chain TRUE
+K02112 ATPF1B; F-type H+-transporting ATPase subunit beta [EC:3.6.3.14] "F-type ATPase, prokaryotes and chloroplasts" Energy Electron transport Chain TRUE
+K02113 ATPF1D; F-type H+-transporting ATPase subunit delta "F-type ATPase, prokaryotes and chloroplasts" Energy Electron transport Chain TRUE
+K02114 ATPF1E; F-type H+-transporting ATPase subunit epsilon "F-type ATPase, prokaryotes and chloroplasts" Energy Electron transport Chain TRUE
+K02115 "ATPF1G, atpG" "F-type ATPase, prokaryotes and chloroplasts" Energy Electron transport Chain TRUE
+K02108 ATPF0A; F-type H+-transporting ATPase subunit a "F-type ATPase, prokaryotes and chloroplasts" Energy Electron transport Chain TRUE
+K02109 ATPF0B; F-type H+-transporting ATPase subunit b "F-type ATPase, prokaryotes and chloroplasts" Energy Electron transport Chain TRUE
+K02110 ATPF0C; F-type H+-transporting ATPase subunit c "F-type ATPase, prokaryotes and chloroplasts" Energy Electron transport Chain TRUE
+K02117 ATPVA; V/A-type H+-transporting ATPase subunit A [EC:3.6.3.14] "V/A-type ATPase, prokaryotes" Energy Electron transport Chain TRUE
+K02118 ATPVB; V/A-type H+-transporting ATPase subunit B "V/A-type ATPase, prokaryotes" Energy Electron transport Chain TRUE
+K02119 ATPVC; V/A-type H+-transporting ATPase subunit C "V/A-type ATPase, prokaryotes" Energy Electron transport Chain TRUE
+K02120 ATPVD; V/A-type H+-transporting ATPase subunit D "V/A-type ATPase, prokaryotes" Energy Electron transport Chain TRUE
+K02121 ATPVE; V/A-type H+-transporting ATPase subunit E "V/A-type ATPase, prokaryotes" Energy Electron transport Chain TRUE
+K02122 ATPVF; V/A-type H+-transporting ATPase subunit F "V/A-type ATPase, prokaryotes" Energy Electron transport Chain TRUE
+K02107 ATPVG; V/A-type H+-transporting ATPase subunit G/H "V/A-type ATPase, prokaryotes" Energy Electron transport Chain TRUE
+K02123 ATPVI; V/A-type H+-transporting ATPase subunit I "V/A-type ATPase, prokaryotes" Energy Electron transport Chain TRUE
+K02124 ATPVK; V/A-type H+-transporting ATPase subunit K "V/A-type ATPase, prokaryotes" Energy Electron transport Chain TRUE
+K00346 Na+-transporting NADH:ubiquinone oxidoreductase subunit A [EC:1.6.5.-] Na+-transporting NADH:ubiquinone oxidoreductase- Energy Electron transport Chain TRUE
+K00347 Na+-transporting NADH:ubiquinone oxidoreductase subunit B [EC:1.6.5.-] Na+-transporting NADH:ubiquinone oxidoreductase- Energy Electron transport Chain TRUE
+K00348 Na+-transporting NADH:ubiquinone oxidoreductase subunit C [EC:1.6.5.-] Na+-transporting NADH:ubiquinone oxidoreductase- Energy Electron transport Chain TRUE
+K00349 Na+-transporting NADH:ubiquinone oxidoreductase subunit D [EC:1.6.5.-] Na+-transporting NADH:ubiquinone oxidoreductase- Energy Electron transport Chain TRUE
+K00350 Na+-transporting NADH:ubiquinone oxidoreductase subunit E [EC:1.6.5.-] Na+-transporting NADH:ubiquinone oxidoreductase- Energy Electron transport Chain TRUE
+K00351 Na+-transporting NADH:ubiquinone oxidoreductase subunit F [EC:1.6.5.-] Na+-transporting NADH:ubiquinone oxidoreductase- Energy Electron transport Chain TRUE
+K05565 multicomponent Na+:H+ antiporter subunit A Multicomponent Na+/H+ antiporter Energy Electron transport Chain TRUE
+K05568 multicomponent Na+:H+ antiporter subunit D Multicomponent Na+/H+ antiporter Energy Electron transport Chain TRUE
+K05567 multicomponent Na+:H+ antiporter subunit C Multicomponent Na+/H+ antiporter Energy Electron transport Chain TRUE
+K05566 multicomponent Na+:H+ antiporter subunit B Multicomponent Na+/H+ antiporter Energy Electron transport Chain TRUE
+K05571 multicomponent Na+:H+ antiporter subunit G Multicomponent Na+/H+ antiporter Energy Electron transport Chain TRUE
+K05570 multicomponent Na+:H+ antiporter subunit F Multicomponent Na+/H+ antiporter Energy Electron transport Chain TRUE
+K05569 multicomponent Na+:H+ antiporter subunit E Multicomponent Na+/H+ antiporter Energy Electron transport Chain TRUE
+K03616 electron transport complex protein RnfB RNF complex Energy Electron transport Chain TRUE
+K03617 electron transport complex protein RnfA RNF complex Energy Electron transport Chain TRUE
+K03613 electron transport complex protein RnfE RNF complex Energy Electron transport Chain TRUE
+K03612 electron transport complex protein RnfG RNF complex Energy Electron transport Chain TRUE
+K03614 electron transport complex protein RnfD RNF complex Energy Electron transport Chain TRUE
+K03615 electron transport complex protein RnfC RNF complex Energy Electron transport Chain TRUE
+K03878 ND1; NADH-ubiquinone oxidoreductase chain 1 [EC:7.1.1.2] "NADH:ubiquinone oxidoreductase, mitochondria" Energy Electron transport Chain TRUE
+K03879 ND2; NADH-ubiquinone oxidoreductase chain 2 [EC:7.1.1.2] "NADH:ubiquinone oxidoreductase, mitochondria" Energy Electron transport Chain TRUE
+K03880 ND3; NADH-ubiquinone oxidoreductase chain 3 [EC:7.1.1.2] "NADH:ubiquinone oxidoreductase, mitochondria" Energy Electron transport Chain TRUE
+K03881 ND4; NADH-ubiquinone oxidoreductase chain 4 [EC:7.1.1.2] "NADH:ubiquinone oxidoreductase, mitochondria" Energy Electron transport Chain TRUE
+K03882 ND4L; NADH-ubiquinone oxidoreductase chain 4L [EC:7.1.1.2] "NADH:ubiquinone oxidoreductase, mitochondria" Energy Electron transport Chain TRUE
+K03883 ND5; NADH-ubiquinone oxidoreductase chain 5 [EC:7.1.1.2] "NADH:ubiquinone oxidoreductase, mitochondria" Energy Electron transport Chain TRUE
+K03884 ND6; NADH-ubiquinone oxidoreductase chain 6 [EC:7.1.1.2] "NADH:ubiquinone oxidoreductase, mitochondria" Energy Electron transport Chain TRUE
+K03934 NDUFS1; NADH dehydrogenase (ubiquinone) Fe-S protein 1 [EC:7.1.1.2 1.6.99.3] "NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria" Energy Electron transport Chain TRUE
+K03935 NDUFS2; NADH dehydrogenase (ubiquinone) Fe-S protein 2 [EC:7.1.1.2 1.6.99.3] "NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria" Energy Electron transport Chain TRUE
+K03936 NDUFS3; NADH dehydrogenase (ubiquinone) Fe-S protein 3 [EC:7.1.1.2 1.6.99.3] "NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria" Energy Electron transport Chain TRUE
+K03937 NDUFS4; NADH dehydrogenase (ubiquinone) Fe-S protein 4 "NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria" Energy Electron transport Chain TRUE
+K03938 NDUFS5; NADH dehydrogenase (ubiquinone) Fe-S protein 5 "NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria" Energy Electron transport Chain TRUE
+K03939 NDUFS6; NADH dehydrogenase (ubiquinone) Fe-S protein 6 "NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria" Energy Electron transport Chain TRUE
+K03940 NDUFS7; NADH dehydrogenase (ubiquinone) Fe-S protein 7 [EC:7.1.1.2 1.6.99.3] "NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria" Energy Electron transport Chain TRUE
+K03941 NDUFS8; NADH dehydrogenase (ubiquinone) Fe-S protein 8 [EC:7.1.1.2 1.6.99.3] "NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria" Energy Electron transport Chain TRUE
+K03942 NDUFV1; NADH dehydrogenase (ubiquinone) flavoprotein 1 [EC:7.1.1.2 1.6.99.3] "NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria" Energy Electron transport Chain TRUE
+K03943 NDUFV2; NADH dehydrogenase (ubiquinone) flavoprotein 2 [EC:7.1.1.2 1.6.99.3] "NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria" Energy Electron transport Chain TRUE
+K03944 NDUFV3; NADH dehydrogenase (ubiquinone) flavoprotein 3 "NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria" Energy Electron transport Chain TRUE
+K03945 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 1 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex Energy Electron transport Chain TRUE
+K03946 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 2 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex Energy Electron transport Chain TRUE
+K03947 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 3 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex Energy Electron transport Chain TRUE
+K03948 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 4 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex Energy Electron transport Chain TRUE
+K03949 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 5 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex Energy Electron transport Chain TRUE
+K03950 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 6 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex Energy Electron transport Chain TRUE
+K03951 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 7 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex Energy Electron transport Chain TRUE
+K03952 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 8 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex Energy Electron transport Chain TRUE
+K03953 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 9 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex Energy Electron transport Chain TRUE
+K03954 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 10 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex Energy Electron transport Chain TRUE
+K03955 NADH dehydrogenase (ubiquinone) 1 alpha/beta subcomplex 1 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex Energy Electron transport Chain TRUE
+K03956 NADH-ubiquinone oxidoreductase subunit NADH dehydrogenase (ubiquinone) 1 alpha subcomplex Energy Electron transport Chain TRUE
+K11352 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 12 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex Energy Electron transport Chain TRUE
+K11353 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 13 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex Energy Electron transport Chain TRUE
+K03957 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 1 NADH dehydrogenase (ubiquinone) 1 beta subcomplex Energy Electron transport Chain TRUE
+K03958 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 2 NADH dehydrogenase (ubiquinone) 1 beta subcomplex Energy Electron transport Chain TRUE
+K03959 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 3 NADH dehydrogenase (ubiquinone) 1 beta subcomplex Energy Electron transport Chain TRUE
+K03960 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 4 NADH dehydrogenase (ubiquinone) 1 beta subcomplex Energy Electron transport Chain TRUE
+K03961 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 5 NADH dehydrogenase (ubiquinone) 1 beta subcomplex Energy Electron transport Chain TRUE
+K03962 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 6 NADH dehydrogenase (ubiquinone) 1 beta subcomplex Energy Electron transport Chain TRUE
+K03963 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 7 NADH dehydrogenase (ubiquinone) 1 beta subcomplex Energy Electron transport Chain TRUE
+K03964 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 8 NADH dehydrogenase (ubiquinone) 1 beta subcomplex Energy Electron transport Chain TRUE
+K03965 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 9 NADH dehydrogenase (ubiquinone) 1 beta subcomplex Energy Electron transport Chain TRUE
+K03966 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 10 NADH dehydrogenase (ubiquinone) 1 beta subcomplex Energy Electron transport Chain TRUE
+K11351 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 11 NADH dehydrogenase (ubiquinone) 1 beta subcomplex Energy Electron transport Chain TRUE
+K03967 NADH dehydrogenase (ubiquinone) 1 subcomplex unknown 1 NADH dehydrogenase (ubiquinone) 1 beta subcomplex Energy Electron transport Chain TRUE
+K03968 NADH dehydrogenase (ubiquinone) 1 subcomplex unknown 2 NADH dehydrogenase (ubiquinone) 1 beta subcomplex Energy Electron transport Chain TRUE
+K02132 ATPeF1A; F-type H+-transporting ATPase subunit alpha "F-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02133 ATPeF1B; F-type H+-transporting ATPase subunit beta [EC:3.6.3.14] "F-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02136 ATPeF1G; F-type H+-transporting ATPase subunit gamma "F-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02134 ATPeF1D; F-type H+-transporting ATPase subunit delta "F-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02135 ATPeF1E; F-type H+-transporting ATPase subunit epsilon "F-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02137 ATPeF0O; F-type H+-transporting ATPase subunit O "F-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02126 ATPeF0A; F-type H+-transporting ATPase subunit a "F-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02127 ATPeF0B; F-type H+-transporting ATPase subunit b "F-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02128 ATPeF0C; F-type H+-transporting ATPase subunit c "F-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02138 ATPeFD; F-type H+-transporting ATPase subunit d "F-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02129 ATPeF0E; F-type H+-transporting ATPase subunit e "F-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K01549 TIM11; F-type H+-transporting ATP synthase subunit e "F-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02130 ATPeF0F; F-type H+-transporting ATPase subunit f "F-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02139 ATPeFF; F-type H+-transporting ATPase subunit f "F-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02140 ATPeFG; F-type H+-transporting ATPase subunit g "F-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02141 ATPeFH; F-type H+-transporting ATPase subunit h "F-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02131 ATPeF0F6; F-type H+-transporting ATPase subunit 6 "F-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02142 ATPeFJ; F-type H+-transporting ATPase subunit j "F-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02143 ATPeFK; F-type H+-transporting ATPase subunit k "F-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02125 ATPeF08; F-type H+-transporting ATPase subunit 8 "F-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02145 ATPeV1A; V-type H+-transporting ATPase subunit A [EC:3.6.3.14] "V-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02147 ATPeV1B; V-type H+-transporting ATPase subunit B "V-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02148 ATPeV1C; V-type H+-transporting ATPase subunit C "V-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02149 ATPeV1D; V-type H+-transporting ATPase subunit D "V-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02150 ATPeV1E; V-type H+-transporting ATPase subunit E "V-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02151 ATPeV1F; V-type H+-transporting ATPase subunit F "V-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02152 ATPeV1G; V-type H+-transporting ATPase subunit G "V-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02144 ATPeV1H; V-type H+-transporting ATPase subunit H "V-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02154 ATPeV0A; V-type H+-transporting ATPase subunit a "V-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K03661 ATPeV0B; V-type H+-transporting ATPase 21kDa proteolipid subunit "V-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02155 ATPeV0C; V-type H+-transporting ATPase 16kDa proteolipid subunit "V-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02146 ATPeV0D; V-type H+-transporting ATPase subunit d "V-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K02153 ATPeV0E; V-type H+-transporting ATPase subunit e "V-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+K03662 ATPeVS1; V-type H+-transporting ATPase S1 subunit "V-type ATPase, eukaryotes" Energy Electron transport Chain TRUE
+AA0 AA0 Auxiliary Activities carbon utilization CAZY TRUE
+AA10 "AA10 (formerly CBM33) proteins are copper-dependent lytic polysaccharide monooxygenases (LPMOs); some proteins have been shown to act on chitin, others on cellulose; lytic cellulose monooxygenase (C1-hydroxylating) (EC 1.14.99.54); lytic cellulose monooxygenase (C4-dehydrogenating)(EC 1.14.99.56); lytic chitin monooxygenase (EC 1.14.99.53)" Auxiliary Activities carbon utilization CAZY "Crystalline Cellulose Backbone Cleavage, Crystalline Cellulose Backbone Cleavage, Chitin Oligo Cleavage" FALSE
+AA11 AA11 proteins are copper-dependent lytic polysaccharide monooxygenases (LPMOs); cleavage of chitin chains with oxidation of C-1 has been demonstrated for a AA11 LPMO from Aspergillus oryzae; Auxiliary Activities carbon utilization CAZY "Crystalline Cellulose Backbone Cleavage, Chitin Oligo Cleavage" TRUE
+AA12 AA12 The pyrroloquinoline quinone-dependent oxidoreductase activity was demonstrated for the CC1G_09525 protein of Coprinopsis cinerea. Auxiliary Activities carbon utilization CAZY TRUE
+AA13 AA13 proteins are copper-dependent lytic polysaccharide monooxygenases (LPMOs); cleavage of starch with oxidation of C-1 at the site of cleavage has been demonstrated for the LPMO encoded by gene NCU08746 from Neurospora crassa; Auxiliary Activities carbon utilization CAZY "Crystalline Cellulose Backbone Cleavage, Starch Backbone Cleavage" TRUE
+AA14 AA14 proteins are copper-dependent lytic polysaccharide monooxygenases (LPMOs); cleavage of xylan with oxidation of C-1 has been demonstrated for two AA14 LPMOs from Trametes coccinea (Pycnoporus coccineus); lytic xylan monooxygenase / xylan oxidase (glycosidic bond-cleaving) (EC 1.-.-.-) Auxiliary Activities carbon utilization CAZY TRUE
+AA15 AA15 lytic cellulose monooxygenase (C1-hydroxylating) (EC 1.14.99.54); lytic chitin monooxygenase (EC 1.14.99.53) Auxiliary Activities carbon utilization CAZY "Crystalline Cellulose Backbone Cleavage, Chitin Oligo Cleavage" FALSE
+AA16 AA16 Lytic cellulose monooxygenase (C1-hydroxylating) (EC 1.14.99.54) Auxiliary Activities carbon utilization CAZY Crystalline Cellulose Backbone Cleavage TRUE
+AA1 AA1 Laccase / p-diphenol:oxygen oxidoreductase / ferroxidase (EC 1.10.3.2); ; ferroxidase (EC 1.10.3.-); Laccase-like multicopper oxidase (EC 1.10.3.-) Auxiliary Activities carbon utilization CAZY Polyphenolics Cleavage TRUE
+AA2 AA2 manganese peroxidase (EC 1.11.1.13); versatile peroxidase (EC 1.11.1.16); lignin peroxidase (EC 1.11.1.14); peroxidase (EC 1.11.1.-) Auxiliary Activities carbon utilization CAZY Polyphenolics Cleavage TRUE
+AA3 AA3 cellobiose dehydrogenase (EC 1.1.99.18); glucose 1-oxidase (EC 1.1.3.4); aryl alcohol oxidase (EC 1.1.3.7); alcohol oxidase (EC 1.1.3.13); pyranose oxidase (EC 1.1.3.10) Auxiliary Activities carbon utilization CAZY TRUE
+AA4 AA4 vanillyl-alcohol oxidase (EC 1.1.3.38) Auxiliary Activities carbon utilization CAZY Polyphenolics Cleavage TRUE
+AA5 AA5 Oxidase with oxygen as acceptor (EC 1.1.3.-); galactose oxidase (EC 1.1.3.9); glyoxal oxidase (EC 1.2.3.15); alcohol oxidase (EC 1.1.3.13) Auxiliary Activities carbon utilization CAZY TRUE
+AA6 "AA6 1,4-benzoquinone reductase (EC. 1.6.5.6)" Auxiliary Activities carbon utilization CAZY TRUE
+AA7 AA7 glucooligosaccharide oxidase (EC 1.1.3.-); chitooligosaccharide oxidase (EC 1.1.3.-) Auxiliary Activities carbon utilization CAZY TRUE
+AA8 AA8 Iron reductase domain Auxiliary Activities carbon utilization CAZY TRUE
+AA9 AA9 (formerly GH61) proteins are copper-dependent lytic polysaccharide monooxygenases (LPMOs); cleavage of cellulose chains with oxidation of carbons C1 and/or C4 and C-6); lytic cellulose monooxygenase (C1-hydroxylating) (EC 1.14.99.54); lytic cellulose monooxygenase (C4-dehydrogenating) (EC 1.14.99.56) Auxiliary Activities carbon utilization CAZY "Crystalline Cellulose Backbone Cleavage, Xyloglucan Backbone Cleavage (Hemicellulose)" TRUE
+CBM0 CBM0 Carbohydrate-binding modules not yet assigned to a family. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM10 CBM10 Modules of approx. 50 residues. The cellulose-binding function has been demonstrated in one case. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM11 "CBM11 Modules of approx. 180-200 residues. The CBM11 of Clotridium thermocellum Cel26A-Cel5E has been shown to bind both beta-1,4-glucan and beta-1,3-1,4-mixed linked glucans." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM12 CBM12 Modules of approx. 40-60 residues. The majority of these modules is found among chitinases where the function is chitin-binding. Distantly related to the CBM5 family. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM13 "CBM13 Modules of approx. 150 residues which always appear as a threefold internal repeat. The only apparent exception to this, xylanase II of Actinomadura sp. FC7 (GenBank U08894), is in fact not completely sequenced. These modules were first identified in several plant lectins such as ricin or agglutinin of Ricinus communis which bind galactose residues. The three-dimensional structure of a plant lectin has been determined and displays a pseudo-threefold symmetry in accord with the observed sequence threefold repeat. These modules have since been found in a number of other proteins of various functions including glycoside hydrolases and glycosyltransferases. While in the plant lectins this module binds mannose, binding to xylan has been demonstrated in the Streptomyces lividans xylanase A and arabinofuranosidase B. Binding to GalNAc has been shown for the corresponding module of GalNAc transferase 4. For the other proteins, the binding specificity of these modules has not been established. The pseudo three-fold symmetry of the CBM13 module has now been confirmed in the 3-D structure of the intact, two-domain, xylanase of Streptomyces olivaceoviridis." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM14 "CBM14 Modules of approx. 70 residues. The chitin-binding function has been demonstrated in several cases. These modules are found attached to a number of chitinase catalytic domains, but also in non-catalytic proteins either in isolation or as multiple repeats; chitin binding (EC IIa.chitin)" Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM15 CBM15 Binding to xylan and xylooligosaccharides has been demonstrated in the case of Xyn10C of Cellvibrio mixtus. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM16 CBM16 Carbohydrate-binding module 16. Binding to cellulose and glucomannan demonstrated [B. Bae et al (2008) J Biol Chem. 283:12415-25 (PMID: 18025086)] Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM17 "CBM17 Modules of approx. 200 residues. Binding to amorphous cellulose, cellooligosaccharides and derivatized cellulose has been demonstrated." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM18 "CBM18 Modules of approx. 40 residues. The chitin-binding function has been demonstrated in many cases. These modules are found attached to a number of chitinase catalytic domains, but also in non-catalytic proteins either in isolation or as multiple repeats." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM19 CBM19 Modules of 60-70 residues with chitin-binding function. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM1 "CBM1 Modules of approx. 40 residues found almost exclusively in fungi. The cellulose-binding function has been demonstrated in many cases, and appears to be mediated by three aromatic residues separated by about 10.4 angstrom and which form a flat surface. The only non-fungal occurence of CBM1 is in an algal non-hydrolytic polysaccharide-binding protein which is composed of four repeated CBM1 modules. Binding to chitin has been demonstrated in one case." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM20 CBM20 The granular starch-binding function has been demonstrated in several cases. Interact strongly with cyclodextrins. Often designated as starch-binding domains (SBD). Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM21 CBM21 Modules of approx. 100 residues. The granular starch-binding function has been demonstrated in one case. Sometimes designated as starch-binding domains (SBD). Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM22 "CBM22 A xylan binding function has been demonstrated in several cases and affinity with mixed beta-1,3/beta-1,4-glucans in one. In several cases a thermostabilizing effect has also been seen." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM23 CBM23 Mannan-binding function demonstrated in one case. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM24 "CBM24 alpha-1,3-glucan (mutan)-binding function demonstrated in two cases (PMID:10636904)" Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM25 CBM25 Starch-binding function demonstrated in one case. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM26 CBM26 Starch-binding function demonstrated in two cases. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM27 CBM27 Mannan-binding function demonstrated in two cases Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM28 "CBM28 The module from the endo-1,4-glucanase of Bacillus sp. 1139 binds to non-crystalline cellulose, cellooligosaccharides, and beta-(1,3)(1,4)-glucans" Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM29 CBM29 Binding to mannan/glucomannan has been demonstrated. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM2 CBM2 Modules of approx. 100 residues and which are found in a large number of bacterial enzymes. The cellulose-binding function has been demonstrated in many cases. Several of these modules have been shown to also bind chitin or xylan. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM30 CBM30 Binding to cellulose has been demonstrated for the N-terminal module of Fibrobacter succinogenes CelF. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM31 "CBM31 Binding to beta-1,3-xylan has been demonstrated for the C-terminal module of the beta-1,3-xylanase of Alcaligenes sp. XY234." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM32 "CBM32 Binding to galactose and lactose has been demonstrated for the module of Micromonospora viridifaciens sialidase (PMID: 16239725). Binding to polygalacturonic acid has been shown for a Yersinia member (PMID: 17292916). Binding to LacNAc (beta-D-galactosyl-1,4-beta-D-N-acetylglucosamine) has been shown for an N-acetylglucosaminidase from Clostridium perfingens (PMID: 16990278)." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM33 CBM33 Copper-dependent lytic polysaccharide monooxygenases now reclassified in family AA10 Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM34 CBM34 Modules of approx. 120 residues. Granular starch-binding function has been demonstrated in the case of Thermoactinomyces vulgaris R-47 α-amylase 1 (TVAI). Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM35 "CBM35 Modules of approx. 130 residues. A module that is conserved in three Cellvibrio xylan-degrading enzymes binds to xylan and the interaction is calcium dependent, while a module from a Cellvibrio mannanase binds to decorated soluble mannans and mannooligosaccharides. A module in a Phanerochaete chrysosporium galactan 1,3-beta-galactosidase binds to beta-galactan." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM36 "CBM36 Modules of approx. 120-130 residues displaying structural similarities to CBM6 modules. The only CBM36 currently characterised, that from Paenbacillus polymyxa xylanase 43A, shows calcium-dependent binding of xylans and xylooligosaccharides. X-ray crystallography shows that there is a direct interaction between calcium and ligand." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM37 "CBM37 Modules of approx. 100 residues, conserved in numerous R. albus polysaccharide-degrading enzymes and other proteins from this bacterium. Several members of CBM37 have been shown to exhibit rather broad binding specificity to xylan, chitin, microcrystalline and phosphoric-acid swollen cellulose, as well as more heterogeneous substrates, such as alfalfa cell walls, banana stem and wheat straw." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM38 CBM38 The inulin-binding function has been demonstrated in the case of the cycloinulo-oligosaccharide fructanotransferase from Paenibacillus macerans (Bacillus macerans) by Lee et al. (2004) FEMS Microbiol Lett 234:105-10. (PMID:15109727). Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM39 "CBM39 Modules generally found at the N-terminus of a GH16 module (itself frequently lacking a catalytic machinery) and more seldomly in isolation. The beta-1,3-glucan binding function has been demonstrated, along with binding to lipopolysaccharide and lipoteichoic acid." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM3 CBM3 Modules of approx. 150 residues found in bacterial enzymes. The cellulose-binding function has been demonstrated in many cases. In one instance binding to chitin has been reported. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM40 "CBM40 Modules of approx. 200 residues, found at the N-terminus of GH33 sialidases. Can also be found inserted in the beta-propeller of GH33 sialidases. The sialic acid binding function has been demonstrated for the N-terminal CBM40 of Vibrio cholerae sialidase (Moustafa et al. (2004) J Biol Chem 279:40819-26) (PMID: 15226294)." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM41 "CBM41 Modules of approx. 100 residues found in primarily in bacterial pullulanases. The N-terminal module from Thermotoga maritima Pul13 has been shown to bind to the alpha-glucans amylose, amylopectin, pullulan, and oligosaccharide fragments derived from these polysaccharides (Lammerts van Bueren et al. (2004) Biochemistry 43:15633-42) (PMID: 15581376)." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM42 CBM42 Modules of approx. 160 residues found mostly at the C-terminus of GH54 catalytic domains. Binding to arabinofuranose (present in arabinoxylan) has been demonstrated. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM43 "CBM43 Modules of approx. 90-100 residues found at the C-terminus of GH17 or GH72 enzymatic modules and also sometimes isolated. CBM43 modules sometimes carry a C-terminal membrane anchor. The beta-1,3-glucan binding function has been demonstrated with the olive pollen protein Ole e 10." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM44 CBM44 The C-terminal CBM44 module of the Clostridium thermocellum enzyme has been demonstrated to bind equally well cellulose and xyloglucan Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM45 "CBM45 Modules of approx. 100 residues, found at the N-terminus of plastidial alpha-amylases and of alpha-glucan, water dikinases. Starch-binding activity demonstrated in the case of potato alpha-glucan, water dikinase." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM46 "CBM46 Modules of approx. 100 residues, found at the C-terminus of several GH5 cellulases. Cellulose-binding function demonstrated in one case." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM47 CBM47 Modules of approx 150 residues. Fucose-binding activity demonstrated Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM48 "CBM48 Modules of approx. 100 residues with glycogen-binding function, appended to GH13 modules. Also found in the beta subunit (glycogen-binding) of AMP-activated protein kinases (AMPK)" Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM49 CBM49 Modules of approx. 100 residues found at the C-terminus of plant GH9 enzymes. Distantly related to CBM2 modules. Binding to crystalline cellulose demonstrated in the case of Solanum lycopersicum Cel8 enzyme (SlCel9C1). Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM4 "CBM4 Modules of approx. 150 residues found in bacterial enzymes. Binding of these modules has been demonstrated with xylan, beta-1,3-glucan, beta-1,3-1,4-glucan, beta-1,6-glucan and amorphous cellulose but not with crystalline cellulose." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM50 "CBM50 Modules of approx. 50 residues found attached to various enzymes from families GH18, GH19, GH23, GH24, GH25 and GH73, i.e. enzymes cleaving either chitin or peptidoglycan. Binding to chitopentaose demonstrated in the case of Pteris ryukyuensis chitinase A [Ohnuma T et al. (2008) J. Biol. Chem. 283:5178-87 (PMID: 18083709)]. CBM50 modules are also found in a multitude of other enzymes targeting the petidoglycan such as peptidases and amidases. These enzymes are not reported in the list below." Carbohydrate-Binding Modules carbon utilization CAZY FALSE
+CBM51 "CBM51 Modules of approx. 150 residues found attached to various enzymes from families GH2, GH27, GH31, GH95, GH98 and GH101 . Binding to galactose and to blood group A/B-antigens demonstrated in the case of C. perfringens GH95CBM51 and GH98CBM51 respectively [Gregg KJ et al. (2008) J. Biol. Chem. 283:12604-13 PMID: 18292090]." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM52 "CBM52 Modules of approx. 60 residues attached to a few GH81 enzymes but present in other proteins. Binding to beta-1,3-glucan demonstrated for Schizosaccharomyces pombe 972h- endo-1,3-beta-glucanase Eng1 [Martin-Quadrado et al., Mol. Microbiol. (2008) 69:188-200 PMID:18466295]" Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM53 CBM53 Starch-binding function demonstrated by Valdez et al. (2008) [PMID: 18260645] Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM54 "CBM54 Binding to xylan, yeast cell wall glucan and chitin shown in Dvortsov et al., Microbiology UK (2009) in press." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM55 CBM55 Binding to chitin demonstrated in the case of the CBM55 of Entamoeba histolytica chitinase (Van Dellen et al. (2002) Infect Immun. 70:3259–3263; PMID: 12011021). Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM56 "CBM56 beta-1,3-glucan binding function demonstrated by Yamamoto et al. (1998) FEBS Letters 433:41-43 [PMID: 9738929]" Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM57 CBM57 Created from reading Schallus et al (2008) Mol Biol Cell. 19:3404-3414 [PMID: 18524852] and finding related domains attached to various glycosidases. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM58 CBM58 The CBM58 module of the Bacteroides thetaiotaomicron SusG protein has been shown to bind maltoheptaose Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM59 "CBM59 Binding to mannan, xylan, and cellulose demonstrated for the CBM59 of ManF-X10 xylanase from an environmental genomic DNA library (Li et al. (2009) World Journal of Microbiology and Biotechnology 25:2071-2078; doi:10.1007/s11274-009-0111-6)" Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM5 CBM5 Modules of approx. 60 residues found in bacterial enzymes. Chitin-binding described in several cases. Distantly related to the CBM12 family. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM60 CBM60 Modules of approx 120 residues usually found appended to xylanases. The xylan-binding function and the relatedness (circular permutation) to family CBM36 has been demonstrated [PMID: 20659893]. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM61 "CBM61 Modules of approx. 150 residues found appended to GH16, GH30, GH31, GH43, GH53 and GH66 catalytic domains. A beta-1,4-galactan binding function has been demonstrated for the CBM61 of Thermotoga maritima GH53 galactanase [PMID: 20826814]." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM62 "CBM62 The CBM62 module of Clostridium thermocellum Cthe_2193 protein binds galactose moieties found on xyloglucan, arabinogalactan and galactomannan." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM63 CBM63 The CBM63 module of Bacillus subtilis expansin EXLX1 has been shown to bind cellulose. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM64 "CBM64 Module found at C-term of several Spirochaeta thermophila proteins. Binding to cellulose shown by Angelov, Loderer, Pompei Liebl (2011) AEM, 77:5483-5489 [PMID - 21685171]" Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM65 "CBM65 CBM65A and CBM65B, derived from Eubacterium cellulosolvens endoglucanase EcCel5A, bind to a range of beta-glucans but, uniquely, display significant preference for xyloglucan" Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM66 "CBM66 The CBM66 module, derived from the Bacillus subtilis exo-acting beta-fructosidase SacC, targets the terminal fructoside residue of fructans." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM67 CBM67 Fujimoto et al. [PMID : 23486481] disclosed the L-rhamnose binding activity and 3-D structure of the CBM67 of Streptomyces avermitilis alpha-L-rhamnosidase (SaRha78A); Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM68 "CBM68 Binding to maltotriose and maltotetraose shown for the pullulanase of Anoxybacillus sp. LM18-11. Binding function derived from crystal structure and deletion of the CBM, which showed reduced specific activity and increased Km value compared to the wild type enzyme." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM69 CBM69 starch-binding function demonstrated in one case; distantly related to families CBM20 and CBM48 Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM6 "CBM6 Modules of approx. 120 residues. The cellulose-binding function has been demonstrated in one case on amorphous cellulose and beta-1,4-xylan. Some of these modules also bind beta-1,3-glucan, beta-1,3-1,4-glucan, and beta-1,4-glucan." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM70 CBM70 The hyaluronan-specific binding function of the N-terminal CBM70 module of Streptococcus pneumoniae hyaluronate lyase has been demonstrated. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM71 CBM71 The two CBM71s of S. pneumoniae BgaA bind lactose and LacNAc. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM72 "CBM72 Modules of 130-180 residues found at the C-terminus glycoside hydrolases from various families, sometimes as tandem repeats. The CBM72 found on an endoglucanase from an uncultivated microorganism was found to bind a broad spectrum of polysaccharides including soluble and insoluble cellulose, beta-1,3/1,4-mixed linked glucans, xylan, and beta-mannan [PMID=26765840]." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM73 CBM73 Modules of approx 65 residues found on various enzymes active of chitin. Chitin-binding function demonstrated for the Cellvibrio japonicus CjLPMO10A protein. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM74 CBM74 Modules of approx. 300 residues appended to several alpha-amylases. The starch-binding function has been demonstrated for the CBM74 appended to the GH13 alpha-amylase of Microbacterium aureum B8.A Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM75 CBM75 Modules of 290 residues appended to GH43_16 enzymes. So far found exclusively in Ruminococci. The xyloglucan-binding function was demonstrated for the R. flavefaciens protein. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM76 "CBM76 Modules of approx. 170 residues appended to GH44 enzymes. So far found exclusively in Ruminococci. Broad specificity binding to beta-glucans demontsrated for the R. flavefaciens module, which binds xyloglucan, glucomannan, and barley beta-glucan." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM77 CBM77 Pectin binding modules of approx. 110 residues. The Ruminococcus flavefaciens CBM77 was shown to bind various pectins of low degree of esterification. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM78 "CBM78 Modules of approx. 150 residues appended to the C-terminus of GH5 and GH26 enzymes. So far found exclusively in Ruminococcal enzymes. The R. flavefaciens module has been shown to bind decorated beta-1,4-glucans with a preference for xyloglucan." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM79 CBM79 Modules of approx. 130 residues found so far only in ruminococcal proteins. Binding to various beta-glucans was shown for the R. flavefaciens GH9 enzyme. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM7 CBM7 Deleted entry Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM80 "CBM80 Modules of approx. 90 residues found so far only in ruminococcal enzymes of families GH5 or GH26. Broad specificity for beta-glycans (xyloglucan, glucomannan, galactomannan, barley beta-glucan)." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM81 "CBM81 Small family of modules of approx. 100 residues, appended to GH5_2 enzymes. So far found exclusively in a few gammaproteobacteria. The CBM81 from an uncultivated species was shown to have binding affinity for beta-1,4-, beta-1,3,-glucans, xyloglucan, avicel and cellooligosaccharides." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM82 "CBM82 The boundaries, structure and starch-binding function of the CBM82 module of Eubacterium rectale Amy13K have been reported by Cockburn and coworkers in Molec. Microbiol. (2017) (PMID=29139580)" Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM83 "CBM83 The boundaries, structure and starch-binding function of the CBM83 module of Eubacterium rectale Amy13K have been reported by Cockburn and coworkers in Molec. Microbiol. (2017) (PMID=29139580)" Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM84 "CBM84 Modules of approx. 140 aminoacids appended to enzymes of different families of CAZymes. A xanthan-binding function was reported for the GH9 xanthanase of Paenibacillus nanensis by Moroz et al. ACS Catal., 2018, 8 (7), pp 6021-6034." Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM85 CBM85 Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM8 CBM8 The cellulose-binding module from a cellulase of the slime mold Dictyostelium discoideum has been experimentally shown to bind cellulose. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM9 CBM9 Modules of approx. 170 residues found so far only in xylanases. The cellulose-binding function has been demonstrated in one case. Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CE0 CE0 See below. Carbohydrate Esterases carbon utilization CAZY TRUE
+CE10 CE10 arylesterase (EC 3.1.1.-); carboxyl esterase (EC 3.1.1.3); acetylcholinesterase (EC 3.1.1.7); cholinesterase (EC 3.1.1.8); sterol esterase (EC 3.1.1.13); brefeldin A esterase (EC 3.1.1.-). Carbohydrate Esterases carbon utilization CAZY TRUE
+CE11 CE11 UDP-3-0-acyl N-acetylglucosamine deacetylase (EC 3.5.1.108). Carbohydrate Esterases carbon utilization CAZY TRUE
+CE12 CE12 pectin acetylesterase (EC 3.1.1.-); rhamnogalacturonan acetylesterase (EC 3.1.1.-); acetyl xylan esterase (EC 3.1.1.72) Carbohydrate Esterases carbon utilization CAZY Pectin Oligo Cleavage TRUE
+CE13 CE13 pectin acetylesterase (EC 3.1.1.-) Carbohydrate Esterases carbon utilization CAZY TRUE
+CE14 CE14 N-acetyl-1-D-myo-inosityl-2-amino-2-deoxy-alpha-D-glucopyranoside deacetylase (EC 3.5.1.89); diacetylchitobiose deacetylase (EC 3.5.1.-); mycothiol S-conjugate amidase (EC 3.5.1.-) Carbohydrate Esterases carbon utilization CAZY TRUE
+CE15 CE15 4-O-methyl-glucuronoyl methylesterase (EC 3.1.1.-) Carbohydrate Esterases carbon utilization CAZY TRUE
+CE16 CE16 acetylesterase (EC 3.1.1.6) active on various carbohydrate acetyl esters Carbohydrate Esterases carbon utilization CAZY TRUE
+CE1 CE1 acetyl xylan esterase (EC 3.1.1.72); cinnamoyl esterase (EC 3.1.1.-); feruloyl esterase (EC 3.1.1.73); carboxylesterase (EC 3.1.1.1); S-formylglutathione hydrolase (EC 3.1.2.12); diacylglycerol O-acyltransferase (EC 2.3.1.20); trehalose 6-O-mycolyltransferase (EC 2.3.1.122) Carbohydrate Esterases carbon utilization CAZY TRUE
+CE2 CE2 acetyl xylan esterase (EC 3.1.1.72). Carbohydrate Esterases carbon utilization CAZY Beta-mannan Oligo Cleavage (Hemicellulose) TRUE
+CE3 CE3 acetyl xylan esterase (EC 3.1.1.72). Carbohydrate Esterases carbon utilization CAZY TRUE
+CE4 CE4 acetyl xylan esterase (EC 3.1.1.72); chitin deacetylase (EC 3.5.1.41); chitooligosaccharide deacetylase (EC 3.5.1.-); peptidoglycan GlcNAc deacetylase (EC 3.5.1.-); peptidoglycan N-acetylmuramic acid deacetylase (EC 3.5.1.-). Carbohydrate Esterases carbon utilization CAZY Chitin Oligo Cleavage TRUE
+CE5 CE5 acetyl xylan esterase (EC 3.1.1.72); cutinase (EC 3.1.1.74) Carbohydrate Esterases carbon utilization CAZY TRUE
+CE6 CE6 acetyl xylan esterase (EC 3.1.1.72). Carbohydrate Esterases carbon utilization CAZY TRUE
+CE7 CE7 acetyl xylan esterase (EC 3.1.1.72); cephalosporin-C deacetylase (EC 3.1.1.41). Carbohydrate Esterases carbon utilization CAZY TRUE
+CE8 CE8 pectin methylesterase (EC 3.1.1.11). Carbohydrate Esterases carbon utilization CAZY Pectin Oligo Cleavage TRUE
+CE9 CE9 N-acetylglucosamine 6-phosphate deacetylase (EC 3.5.1.25); N-acetylglucosamine 6-phosphate deacetylase (EC 3.5.1.80) Carbohydrate Esterases carbon utilization CAZY TRUE
+GH0 GH0 Glycoside hydrolases not yet assigned to a family. Glycoside Hydrolases carbon utilization CAZY TRUE
+GH100 GH100 alkaline and neutral invertase (EC 3.2.1.26) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH101 GH101 endo-alpha-N-acetylgalactosaminidase (EC 3.2.1.97) Glycoside Hydrolases carbon utilization CAZY Mucin Backbone Cleavage TRUE
+GH102 GH102 peptidoglycan lytic transglycosylase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY FALSE
+GH103 GH103 peptidoglycan lytic transglycosylase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY FALSE
+GH104 GH104 peptidoglycan lytic transglycosylase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY FALSE
+GH105 "GH105 unsaturated rhamnogalacturonyl hydrolase (EC 3.2.1.172); d-4,5-unsaturated beta-glucuronyl hydrolase (EC 3.2.1.-); d-4,5-unsaturated alpha-galacturonidase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY Pectin Oligo Cleavage TRUE
+GH106 GH106 alpha-L-rhamnosidase (EC 3.2.1.40); rhamnogalacturonan alpha-L-rhamnohydrolase (EC 3.2.1.174) Glycoside Hydrolases carbon utilization CAZY "Pectin Oligo Cleavage, Rhamnose Oligo cleavage" TRUE
+GH107 "GH107 sulfated fucan endo-1,4-fucanase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY Fucose Oligo Cleavage TRUE
+GH108 GH108 N-acetylmuramidase (EC 3.2.1.17) Glycoside Hydrolases carbon utilization CAZY FALSE
+GH109 GH109 alpha-N-acetylgalactosaminidase (EC 3.2.1.49) Glycoside Hydrolases carbon utilization CAZY Mucin Oligo Cleavage TRUE
+GH10 "GH10 endo-1,4-beta-xylanase (EC 3.2.1.8); endo-1,3-beta-xylanase (EC 3.2.1.32); tomatinase (EC 3.2.1.-); xylan endotransglycosylase (EC 2.4.2.-); endo-beta-1,4-glucanase (EC 3.2.1.4)" Glycoside Hydrolases carbon utilization CAZY "Amorphous Cellulose Backbone Cleavage, Xyloglucan Oligo Cleavage (Hemicellulose), Xylan Backbone Cleavage (Hemicellulose)" TRUE
+GH110 "GH110 alpha-galactosidase (EC 3.2.1.22); alpha-1,3-galactosidase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY Alpha-galactans Oligo Cleavage TRUE
+GH111 GH111 keratan sulfate hydrolase (endo-beta-N-acetylglucosaminidase) (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY Sulf-Polysachharides Backbone Cleavage TRUE
+GH112 "GH112 lacto-N-biose phosphorylase or galacto-N-biose phosphorylase (EC 2.4.1.211); D-galactosyl-beta-1,4-L-rhamnose phosphorylase (EC 2.4.1.247); galacto-N-biose/lacto-N-biose phosphorylase (EC 2.4.1.-)" Glycoside Hydrolases carbon utilization CAZY Mucin Oligo Cleavage TRUE
+GH113 GH113 beta-mannanase (EC 3.2.1.78) Glycoside Hydrolases carbon utilization CAZY "Beta-mannan Backbone Cleavage (Hemicellulose), Beta-mannan Oligo Cleavage (Hemicellulose)" TRUE
+GH114 "GH114 endo-alpha-1,4-polygalactosaminidase (EC 3.2.1.109)" Glycoside Hydrolases carbon utilization CAZY TRUE
+GH115 "GH115 xylan alpha-1,2-glucuronidase (3.2.1.131); alpha-(4-O-methyl)-glucuronidase (3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY Xylan Oligo Cleavage (Hemicellulose) TRUE
+GH116 GH116 beta-glucosidase (EC 3.2.1.21); beta-xylosidase (EC 3.2.1.37); acid beta-glucosidase/beta-glucosylceramidase (EC 3.2.1.45); beta-N-acetylglucosaminidase (EC 3.2.1.52) Glycoside Hydrolases carbon utilization CAZY "Amorphous Cellulose Oligo Cleavage, Chitin Oligo Cleavage" TRUE
+GH117 "GH117 alpha-1,3-L-neoagarooligosaccharide hydrolase (EC 3.2.1.-); alpha-1,3-L-neoagarobiase / neoagarobiose hydrolase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY Sulf-Polysachharides Oligo Cleavage TRUE
+GH118 GH118 beta-agarase (EC 3.2.1.81) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH119 GH119 alpha-amylase (EC 3.2.1.1) Glycoside Hydrolases carbon utilization CAZY Starch Backbone Cleavage TRUE
+GH11 "GH11 endo-beta-1,4-xylanase (EC 3.2.1.8); endo-beta-1,3-xylanase (EC 3.2.1.32)" Glycoside Hydrolases carbon utilization CAZY Xylan Backbone Cleavage (Hemicellulose) TRUE
+GH120 GH120 beta-xylosidase (EC 3.2.1.37) Glycoside Hydrolases carbon utilization CAZY Xylan Oligo Cleavage (Hemicellulose) TRUE
+GH121 GH121 beta-L-arabinobiosidase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY Arabinose Oligo cleavage TRUE
+GH122 GH122 alpha-glucosidase (EC 3.2.1.20) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH123 GH123 beta-N-acetylgalactosaminidase (EC 3.2.1.53); glycosphingolipid beta-N-acetylgalactosaminidase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH124 GH124 endoglucanase (EC 3.2.1.4) Glycoside Hydrolases carbon utilization CAZY Amorphous Cellulose Backbone Cleavage TRUE
+GH125 "GH125 exo-alpha-1,6-mannosidase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY Alpha-mannan Oligo Cleavage (Hemicellulose) TRUE
+GH126 GH126 alpha-amylase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY Starch Backbone Cleavage TRUE
+GH127 GH127 beta-L-arabinofuranosidase (EC 3.2.1.185); 3-C-carboxy-5-deoxy-L-xylose (aceric acid) hydrolase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY Arabinose Oligo cleavage TRUE
+GH128 "GH128 beta-1,3-glucanase (EC 3.2.1.39)" Glycoside Hydrolases carbon utilization CAZY "Mixed-Linkage glucans Backbone Cleavage (Hemicellulose), Rhamnose Oligo cleavage" TRUE
+GH129 GH129 alpha-N-acetylgalactosaminidase (EC 3.2.1.49); Glycoside Hydrolases carbon utilization CAZY Mucin Oligo Cleavage TRUE
+GH12 "GH12 endoglucanase (EC 3.2.1.4); xyloglucan hydrolase (EC 3.2.1.151); beta-1,3-1,4-glucanase (EC 3.2.1.73); xyloglucan endotransglycosylase (EC 2.4.1.207)" Glycoside Hydrolases carbon utilization CAZY "Amorphous Cellulose Backbone Cleavage, Xyloglucan Backbone Cleavage (Hemicellulose)" TRUE
+GH130 "GH130 beta-1,4-mannosylglucose phosphorylase (EC 2.4.1.281); beta-1,4-mannooligosaccharide phosphorylase (EC 2.4.1.319); beta-1,4-mannosyl-N-acetyl-glucosamine phosphorylase (EC 2.4.1.320); beta-1,2-mannobiose phosphorylase (EC 2.4.1.-); beta-1,2-oligomannan phosphorylase (EC 2.4.1.-); beta-1,2-mannosidase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY "Alpha-mannan Oligo Cleavage (Hemicellulose), Beta-mannan Oligo Cleavage (Hemicellulose)" TRUE
+GH131 "GH131 broad specificity exo-beta-1,3/1,6-glucanase with endo-beta-1,4-glucanase activity (EC 3.2.1.-);" Glycoside Hydrolases carbon utilization CAZY TRUE
+GH132 "GH132 Activity on beta-1,3-glucan (curdlan) shown for the Aspergillus fumigatus Sun4 protein; activity on laminarioligosaccharides shown for Aspergillus fumigatus Sun4 protein and Candida albicans Sun41 protein; transglycosylation activity reported in PMID 23508952." Glycoside Hydrolases carbon utilization CAZY TRUE
+GH133 "GH133 amylo-alpha-1,6-glucosidase (EC 3.2.1.33);" Glycoside Hydrolases carbon utilization CAZY Starch Oligo Cleavage TRUE
+GH134 "GH134 endo-beta-1,4-mannanase (EC 3.2.1.78);" Glycoside Hydrolases carbon utilization CAZY Beta-mannan Backbone Cleavage (Hemicellulose) TRUE
+GH135 "GH135 alpha-1,4-galactosaminogalactan hydrolase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY TRUE
+GH136 GH136 lacto-N-biosidase (EC 3.2.1.140) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH137 GH137 beta-L-arabinofuranosidase (EC 3.2.1.185) Glycoside Hydrolases carbon utilization CAZY Arabinose Oligo cleavage TRUE
+GH138 GH138 alpha-galacturonidase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY Pectin Oligo Cleavage TRUE
+GH139 GH139 alpha-2-O-Me-L-fucosidase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY "Pectin Oligo Cleavage, Fucose Oligo Cleavage" TRUE
+GH13 "GH13 alpha-amylase (EC 3.2.1.1); pullulanase (EC 3.2.1.41); cyclomaltodextrin glucanotransferase (EC 2.4.1.19); cyclomaltodextrinase (EC 3.2.1.54); trehalose-6-phosphate hydrolase (EC 3.2.1.93); oligo-alpha-glucosidase (EC 3.2.1.10); maltogenic amylase (EC 3.2.1.133); neopullulanase (EC 3.2.1.135); alpha-glucosidase (EC 3.2.1.20); maltotetraose-forming alpha-amylase (EC 3.2.1.60); isoamylase (EC 3.2.1.68); glucodextranase (EC 3.2.1.70); maltohexaose-forming alpha-amylase (EC 3.2.1.98); maltotriose-forming alpha-amylase (EC 3.2.1.116); branching enzyme (EC 2.4.1.18); trehalose synthase (EC 5.4.99.16); 4-alpha-glucanotransferase (EC 2.4.1.25); maltopentaose-forming alpha-amylase (EC 3.2.1.-) ; amylosucrase (EC 2.4.1.4) ; sucrose phosphorylase (EC 2.4.1.7); malto-oligosyltrehalose trehalohydrolase (EC 3.2.1.141); isomaltulose synthase (EC 5.4.99.11); malto-oligosyltrehalose synthase (EC 5.4.99.15); amylo-alpha-1,6-glucosidase (EC 3.2.1.33); alpha-1,4-glucan: phosphate alpha-maltosyltransferase (EC 2.4.99.16); 6'-P-sucrose phosphorylase (EC 2.4.1.-); amino acid transporter" Glycoside Hydrolases carbon utilization CAZY Starch Backbone Cleavage TRUE
+GH140 GH140 apiosidase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH141 GH141 alpha-L-fucosidase (EC 3.2.1.51); xylanase (EC 3.2.1.8) Glycoside Hydrolases carbon utilization CAZY "Xylan Backbone Cleavage (Hemicellulose), Fucose Oligo Cleavage" TRUE
+GH142 GH142 beta-L-arabinofuranosidase (EC 3.2.1.185) Glycoside Hydrolases carbon utilization CAZY Arabinose Oligo cleavage TRUE
+GH143 GH143 2-keto-3-deoxy-D-lyxo-heptulosaric acid hydrolase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY Pectin Oligo Cleavage TRUE
+GH144 "GH144 endo-beta-1,2-glucanase (EC 3.2.1.71); beta-1,2-glucooligosaccharide sophorohydrolase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY TRUE
+GH145 "GH145 L-Rhalpha-alpha-1,4-GlcA alpha-L-rhamnohydrolase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY Rhamnose Oligo cleavage TRUE
+GH146 GH146 beta-L-arabinofuranosidase (EC 3.2.1.185) Glycoside Hydrolases carbon utilization CAZY Arabinose Oligo cleavage TRUE
+GH147 GH147 beta-galactosidase (EC 3.2.1.23) Glycoside Hydrolases carbon utilization CAZY Beta-galactan (pectic galactan) Oligo Cleavage TRUE
+GH148 "GH148 beta-1,3-glucanase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY TRUE
+GH149 "GH149 beta-1,3-glucan phosphorylase (EC 2.4.1.-)" Glycoside Hydrolases carbon utilization CAZY TRUE
+GH14 GH14 beta-amylase (EC 3.2.1.2) Glycoside Hydrolases carbon utilization CAZY Starch Backbone Cleavage TRUE
+GH150 GH150 l-carrageenase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY Sulf-Polysachharides Backbone Cleavage TRUE
+GH151 GH151 alpha-L-fucosidase (EC 3.2.1.51) Glycoside Hydrolases carbon utilization CAZY Fucose Oligo Cleavage TRUE
+GH152 "GH152 beta-1,3-glucanase (EC 3.2.1.39)" Glycoside Hydrolases carbon utilization CAZY Mixed-Linkage glucans Backbone Cleavage (Hemicellulose) TRUE
+GH153 "GH153 poly-beta-1,6-D-glucosamine hydrolase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY TRUE
+GH154 GH154 beta-glucuronidase (3.2.1.31) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH155 GH155 Deleted family! Glycoside Hydrolases carbon utilization CAZY TRUE
+GH156 GH156 exo-alpha-sialidase (EC 3.2.1.18); Glycoside Hydrolases carbon utilization CAZY TRUE
+GH157 "GH157 endo-beta-1,3-glucanase (EC 3.2.1.39); endo-beta-1,3-glucanase / laminarinase (EC 3.2.1.39)" Glycoside Hydrolases carbon utilization CAZY Mixed-Linkage glucans Backbone Cleavage (Hemicellulose) TRUE
+GH158 "GH158 endo-beta-1,3-glucanase (EC 3.2.1.39)" Glycoside Hydrolases carbon utilization CAZY Mixed-Linkage glucans Backbone Cleavage (Hemicellulose) TRUE
+GH159 GH159 beta-D-galactofuranosidase (EC 3.2.1.146) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH15 "GH15 glucoamylase (EC 3.2.1.3); glucodextranase (EC 3.2.1.70); alpha,alpha-trehalase (EC 3.2.1.28); dextran dextrinase (EC 2.4.1.2)" Glycoside Hydrolases carbon utilization CAZY Starch Oligo Cleavage TRUE
+GH160 "GH160 endo-beta-1,4-galactosidase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY TRUE
+GH161 "GH161 beta-1,3-glucan phosphorylase (EC 2.4.1.-)" Glycoside Hydrolases carbon utilization CAZY TRUE
+GH162 "GH162 endo-beta-1,2-glucanase (EC 3.2.1.71)" Glycoside Hydrolases carbon utilization CAZY TRUE
+GH163 "GH163 endo-beta-N-acetylglucosaminidase cleaving GlcNAc-beta-1,2-Man (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY TRUE
+GH164 GH164 beta-mannosidase (EC 3.2.1.25); beta-mannosidase (EC 3.2.1.25) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH165 GH165 beta-galactosidase (EC 3.2.1.23) Glycoside Hydrolases carbon utilization CAZY Beta-galactan (pectic galactan) Oligo Cleavage TRUE
+GH16 "GH16 xyloglucan:xyloglucosyltransferase (EC 2.4.1.207); keratan-sulfate endo-1,4-beta-galactosidase (EC 3.2.1.103); endo-1,3-beta-glucanase / laminarinase (EC 3.2.1.39); endo-1,3(4)-beta-glucanase (EC 3.2.1.6); licheninase (EC 3.2.1.73); beta-agarase (EC 3.2.1.81); kappa;-carrageenase (EC 3.2.1.83); xyloglucanase (EC 3.2.1.151); endo-beta-1,3-galactanase (EC 3.2.1.181); [retaining] beta-porphyranase (EC 3.2.1.178); hyaluronidase (EC 3.2.1.35); endo-beta-1,4-galactosidase (EC 3.2.1.-); chitin beta-1,6-glucanosyltransferase (EC 2.4.1.-); beta-transglycosidase (EC 2.4.1.-); beta-glycosidase (EC 3.2.1.-); endo-beta-1,3-galactanase (EC 3.2.1.181)" Glycoside Hydrolases carbon utilization CAZY "Amorphous Cellulose Oligo Cleavage, Xyloglucan Backbone Cleavage (Hemicellulose), Mixed-Linkage glucans Backbone Cleavage (Hemicellulose), Mixed-Linkage glucans Oligo Cleavage (Hemicellulose), Sulf-Polysachharides Backbone Cleavage" TRUE
+GH17 "GH17 glucan endo-1,3-beta-glucosidase (EC 3.2.1.39); glucan 1,3-beta-glucosidase (EC 3.2.1.58); licheninase (EC 3.2.1.73); ABA-specific beta-glucosidase (EC 3.2.1.175); beta-1,3-glucanosyltransglycosylase (EC 2.4.1.-)" Glycoside Hydrolases carbon utilization CAZY "Mixed-Linkage glucans Backbone Cleavage (Hemicellulose), Mixed-Linkage glucans Oligo Cleavage (Hemicellulose)" TRUE
+GH18 GH18 chitinase (EC 3.2.1.14); lysozyme (EC 3.2.1.17); endo-beta-N-acetylglucosaminidase (EC 3.2.1.96); peptidoglycan hydrolase with endo-beta-N-acetylglucosaminidase specificity (EC 3.2.1.-); Nod factor hydrolase (EC 3.2.1.-); xylanase inhibitor; concanavalin B; narbonin Glycoside Hydrolases carbon utilization CAZY Chitin Backbone Cleavage FALSE
+GH19 GH19 chitinase (EC 3.2.1.14); lysozyme (EC 3.2.1.17) Glycoside Hydrolases carbon utilization CAZY Chitin Backbone Cleavage FALSE
+GH1 "GH1 beta-glucosidase (EC 3.2.1.21); beta-galactosidase (EC 3.2.1.23); beta-mannosidase (EC 3.2.1.25); beta-glucuronidase (EC 3.2.1.31); beta-xylosidase (EC 3.2.1.37); beta-D-fucosidase (EC 3.2.1.38); phlorizin hydrolase (EC 3.2.1.62); exo-beta-1,4-glucanase (EC 3.2.1.74); 6-phospho-beta-galactosidase (EC 3.2.1.85); 6-phospho-beta-glucosidase (EC 3.2.1.86); strictosidine beta-glucosidase (EC 3.2.1.105); lactase (EC 3.2.1.108); amygdalin beta-glucosidase (EC 3.2.1.117); prunasin beta-glucosidase (EC 3.2.1.118); vicianin hydrolase (EC 3.2.1.119); raucaffricine beta-glucosidase (EC 3.2.1.125); thioglucosidase (EC 3.2.1.147); beta-primeverosidase (EC 3.2.1.149); isoflavonoid 7-O-beta-apiosyl-beta-glucosidase (EC 3.2.1.161); ABA-specific beta-glucosidase (EC 3.2.1.175); DIMBOA beta-glucosidase (EC 3.2.1.182); beta-glycosidase (EC 3.2.1.-); hydroxyisourate hydrolase (EC 3.-.-.-)" Glycoside Hydrolases carbon utilization CAZY "Amorphous Cellulose Oligo Cleavage, Mixed-Linkage glucans Oligo Cleavage (Hemicellulose), Beta-galactan (pectic galactan) Oligo Cleavage" TRUE
+GH20 "GH20 beta-hexosaminidase (EC 3.2.1.52); lacto-N-biosidase (EC 3.2.1.140); beta-1,6-N-acetylglucosaminidase (EC 3.2.1.-); beta-6-SO3-N-acetylglucosaminidase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY Chitin Oligo Cleavage TRUE
+GH21 GH21 Deleted family! Glycoside Hydrolases carbon utilization CAZY TRUE
+GH22 GH22 lysozyme type C (EC 3.2.1.17); lysozyme type i (EC 3.2.1.17); alpha-lactalbumin Glycoside Hydrolases carbon utilization CAZY FALSE
+GH23 GH23 lysozyme type G (EC 3.2.1.17); peptidoglycan lyase (EC 4.2.2.n1) also known in the literature as peptidoglycan lytic transglycosylase; chitinase (EC 3.2.1.14) Glycoside Hydrolases carbon utilization CAZY Chitin Backbone Cleavage FALSE
+GH24 GH24 lysozyme (EC 3.2.1.17) Glycoside Hydrolases carbon utilization CAZY FALSE
+GH25 GH25 lysozyme (EC 3.2.1.17) Glycoside Hydrolases carbon utilization CAZY FALSE
+GH26 "GH26 beta-mannanase (EC 3.2.1.78); exo-beta-1,4-mannobiohydrolase (EC 3.2.1.100); beta-1,3-xylanase (EC 3.2.1.32); lichenase / endo-beta-1,3-1,4-glucanase (EC 3.2.1.73); mannobiose-producing exo-beta-mannanase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY "Xylan Backbone Cleavage (Hemicellulose), Beta-mannan Backbone Cleavage (Hemicellulose), Beta-mannan Oligo Cleavage (Hemicellulose)" TRUE
+GH27 GH27 alpha-galactosidase (EC 3.2.1.22); alpha-N-acetylgalactosaminidase (EC 3.2.1.49); isomalto-dextranase (EC 3.2.1.94); beta-L-arabinopyranosidase (EC 3.2.1.88); galactan:galactan galactosyltransferase (EC 2.4.1.-) Glycoside Hydrolases carbon utilization CAZY "Alpha-galactans Oligo Cleavage, Mucin Oligo Cleavage" TRUE
+GH28 "GH28 polygalacturonase (EC 3.2.1.15); alpha-L-rhamnosidase (EC 3.2.1.40); exo-polygalacturonase (EC 3.2.1.67); exo-polygalacturonosidase (EC 3.2.1.82); rhamnogalacturonase (EC 3.2.1.171); rhamnogalacturonan alpha-1,2-galacturonohydrolase (EC 3.2.1.173); endo-xylogalacturonan hydrolase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY Pectin Backbone Cleavage TRUE
+GH29 "GH29 alpha-L-fucosidase (EC 3.2.1.51); alpha-1,3/1,4-L-fucosidase (EC 3.2.1.111)" Glycoside Hydrolases carbon utilization CAZY Fucose Oligo Cleavage TRUE
+GH2 GH2 beta-galactosidase (EC 3.2.1.23) ; beta-mannosidase (EC 3.2.1.25); beta-glucuronidase (EC 3.2.1.31); alpha-L-arabinofuranosidase (EC 3.2.1.55); mannosylglycoprotein endo-beta-mannosidase (EC 3.2.1.152); exo-beta-glucosaminidase (EC 3.2.1.165); alpha-L-arabinopyranosidase (EC 3.2.1.-); beta-galacturonidase (EC 3.2.1.-); beta-xylosidase (EC 3.2.1.37); beta-D-galactofuranosidase (EC 3.2.1.146); Glycoside Hydrolases carbon utilization CAZY "Amorphous Cellulose Oligo Cleavage, Xyloglucan Oligo Cleavage (Hemicellulose), Beta-mannan Oligo Cleavage (Hemicellulose), Pectin Oligo Cleavage, Beta-galactan (pectic galactan) Oligo Cleavage, Arabinose Oligo cleavage" TRUE
+GH30 "GH30 endo-beta-1,4-xylanase (EC 3.2.1.8); beta-glucosidase (3.2.1.21); beta-glucuronidase (EC 3.2.1.31); beta-xylosidase (EC 3.2.1.37); beta-fucosidase (EC 3.2.1.38); glucosylceramidase (EC 3.2.1.45); beta-1,6-glucanase (EC 3.2.1.75); glucuronoarabinoxylan endo-beta-1,4-xylanase (EC 3.2.1.136); endo-beta-1,6-galactanase (EC:3.2.1.164); [reducing end] beta-xylosidase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY "Xylan Backbone Cleavage (Hemicellulose), Mixed-Linkage glucans Backbone Cleavage (Hemicellulose)" TRUE
+GH31 "GH31 alpha-glucosidase (EC 3.2.1.20); alpha-galactosidase (EC 3.2.1.22); alpha-mannosidase (EC 3.2.1.24); alpha-1,3-glucosidase (EC 3.2.1.84); sucrase-isomaltase (EC 3.2.1.48) (EC 3.2.1.10); alpha-xylosidase (EC 3.2.1.177); alpha-glucan lyase (EC 4.2.2.13); isomaltosyltransferase (EC 2.4.1.-); oligosaccharide alpha-1,4-glucosyltransferase (EC 2.4.1.161); sulfoquinovosidase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY "Xyloglucan Oligo Cleavage (Hemicellulose), Xylan Oligo Cleavage (Hemicellulose), Alpha-galactans Oligo Cleavage, Alpha-galactans Oligo Cleavage, Mucin Oligo Cleavage" TRUE
+GH32 "GH32 invertase (EC 3.2.1.26); endo-inulinase (EC 3.2.1.7); beta-2,6-fructan 6-levanbiohydrolase (EC 3.2.1.64); endo-levanase (EC 3.2.1.65); exo-inulinase (EC 3.2.1.80); fructan beta-(2,1)-fructosidase/1-exohydrolase (EC 3.2.1.153); fructan beta-(2,6)-fructosidase/6-exohydrolase (EC 3.2.1.154); sucrose:sucrose 1-fructosyltransferase (EC 2.4.1.99); fructan:fructan 1-fructosyltransferase (EC 2.4.1.100); sucrose:fructan 6-fructosyltransferase (EC 2.4.1.10); fructan:fructan 6G-fructosyltransferase (EC 2.4.1.243); levan fructosyltransferase (EC 2.4.1.-); [retaining] sucrose:sucrose 6-fructosyltransferase (6-SST) (EC 2.4.1.-); cycloinulo-oligosaccharide fructanotransferase (EC 2.4.1.-)" Glycoside Hydrolases carbon utilization CAZY FALSE
+GH33 GH33 sialidase or neuraminidase (EC 3.2.1.18); trans-sialidase (EC 2.4.1.-); anhydrosialidase (EC 4.2.2.15); Kdo hydrolase (EC 3.2.1.-); 2-keto-3-deoxynononic acid hydrolase / KDNase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH34 GH34 sialidase or neuraminidase (EC 3.2.1.18) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH35 "GH35 beta-galactosidase (EC 3.2.1.23); exo-beta-glucosaminidase (EC 3.2.1.165); exo-beta-1,4-galactanase (EC 3.2.1.-); beta-1,3-galactosidase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY Beta-galactan (pectic galactan) Oligo Cleavage TRUE
+GH36 GH36 alpha-galactosidase (EC 3.2.1.22); alpha-N-acetylgalactosaminidase (EC 3.2.1.49); stachyose synthase (EC 2.4.1.67); raffinose synthase (EC 2.4.1.82) Glycoside Hydrolases carbon utilization CAZY "Alpha-galactans Oligo Cleavage, Mucin Oligo Cleavage" TRUE
+GH37 "GH37 alpha,alpha-trehalase (EC 3.2.1.28)." Glycoside Hydrolases carbon utilization CAZY TRUE
+GH38 "GH38 alpha-mannosidase (EC 3.2.1.24); mannosyl-oligosaccharide alpha-1,2-mannosidase (EC 3.2.1.113); mannosyl-oligosaccharide alpha-1,3-1,6-mannosidase (EC 3.2.1.114); alpha-2-O-mannosylglycerate hydrolase (EC 3.2.1.170); mannosyl-oligosaccharide alpha-1,3-mannosidase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY Alpha-mannan Oligo Cleavage (Hemicellulose) TRUE
+GH39 GH39 alpha-L-iduronidase (EC 3.2.1.76); beta-xylosidase (EC 3.2.1.37). Glycoside Hydrolases carbon utilization CAZY Xylan Oligo Cleavage (Hemicellulose) TRUE
+GH3 "GH3 beta-glucosidase (EC 3.2.1.21); xylan 1,4-beta-xylosidase (EC 3.2.1.37); beta-glucosylceramidase (EC 3.2.1.45); beta-N-acetylhexosaminidase (EC 3.2.1.52); alpha-L-arabinofuranosidase (EC 3.2.1.55); glucan 1,3-beta-glucosidase (EC 3.2.1.58); glucan 1,4-beta-glucosidase (EC 3.2.1.74); isoprimeverose-producing oligoxyloglucan hydrolase (EC 3.2.1.120); coniferin beta-glucosidase (EC 3.2.1.126); exo-1,3-1,4-glucanase (EC 3.2.1.-); beta-N-acetylglucosaminide phosphorylases (EC 2.4.1.-)" Glycoside Hydrolases carbon utilization CAZY "Amorphous Cellulose Oligo Cleavage, Xylan Oligo Cleavage (Hemicellulose), Mixed-Linkage glucans Oligo Cleavage (Hemicellulose), Arabinan Oligo Cleavage, Chitin Oligo Cleavage" TRUE
+GH40 GH40 Deleted family! Glycoside Hydrolases carbon utilization CAZY TRUE
+GH41 GH41 Deleted family! Glycoside Hydrolases carbon utilization CAZY TRUE
+GH42 GH42 beta-galactosidase (EC 3.2.1.23); alpha-L-arabinopyranosidase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY Beta-galactan (pectic galactan) Oligo Cleavage TRUE
+GH43 "GH43 beta-xylosidase (EC 3.2.1.37); alpha-L-arabinofuranosidase (EC 3.2.1.55); xylanase (EC 3.2.1.8); alpha-1,2-L-arabinofuranosidase (EC 3.2.1.-); exo-alpha-1,5-L-arabinofuranosidase (EC 3.2.1.-); [inverting] exo-alpha-1,5-L-arabinanase (EC 3.2.1.-); beta-1,3-xylosidase (EC 3.2.1.-); [inverting] exo-alpha-1,5-L-arabinanase (EC 3.2.1.-); [inverting] endo-alpha-1,5-L-arabinanase (EC 3.2.1.99); exo-beta-1,3-galactanase (EC 3.2.1.145); beta-D-galactofuranosidase (EC 3.2.1.146)" Glycoside Hydrolases carbon utilization CAZY "Xyloglucan Oligo Cleavage (Hemicellulose), Arabinan Backbone Cleavage, Arabinan Oligo Cleavage" TRUE
+GH44 GH44 endoglucanase (EC 3.2.1.4); xyloglucanase (EC 3.2.1.151) Glycoside Hydrolases carbon utilization CAZY "Amorphous Cellulose Backbone Cleavage, Xyloglucan Backbone Cleavage (Hemicellulose)" TRUE
+GH45 "GH45 endoglucanase (EC 3.2.1.4); xyloglucan-specific endo-beta-1,4-glucanase / endo-xyloglucanase (EC 3.2.1.151); endo-beta-1,4-mannanase (EC 3.2.1.78)" Glycoside Hydrolases carbon utilization CAZY "Amorphous Cellulose Backbone Cleavage, Xyloglucan Backbone Cleavage (Hemicellulose)" TRUE
+GH46 GH46 chitosanase (EC 3.2.1.132) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH47 GH47 alpha-mannosidase (EC 3.2.1.113) Glycoside Hydrolases carbon utilization CAZY Alpha-mannan Oligo Cleavage (Hemicellulose) TRUE
+GH48 "GH48 reducing end-acting cellobiohydrolase (EC 3.2.1.176); endo-beta-1,4-glucanase (EC 3.2.1.4); chitinase (EC 3.2.1.14)" Glycoside Hydrolases carbon utilization CAZY "Crystalline Cellulose Backbone Cleavage, Xyloglucan Backbone Cleavage (Hemicellulose)" TRUE
+GH49 "GH49 dextranase (EC 3.2.1.11); isopullulanase (EC 3.2.1.57); dextran 1,6-alpha-isomaltotriosidase (EC 3.2.1.95); sulfated arabinan endo-1,4-beta-L-arabinanase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY Arabinan Backbone Cleavage TRUE
+GH4 GH4 maltose-6-phosphate glucosidase (EC 3.2.1.122); alpha-glucosidase (EC 3.2.1.20); alpha-galactosidase (EC 3.2.1.22); 6-phospho-beta-glucosidase (EC 3.2.1.86); alpha-glucuronidase (EC 3.2.1.139); alpha-galacturonase (EC 3.2.1.67); palatinase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY "Pectin Oligo Cleavage, Alpha-galactans Oligo Cleavage" TRUE
+GH50 GH50 beta-agarase (EC 3.2.1.81). Glycoside Hydrolases carbon utilization CAZY TRUE
+GH51 "GH51 endoglucanase (EC 3.2.1.4); endo-beta-1,4-xylanase (EC 3.2.1.8); beta-xylosidase (EC 3.2.1.37); alpha-L-arabinofuranosidase (EC 3.2.1.55); lichenase / endo-beta-1,3-1,4-glucanase (EC 3.2.1.73)" Glycoside Hydrolases carbon utilization CAZY Arabinan Oligo Cleavage TRUE
+GH52 GH52 beta-xylosidase (EC 3.2.1.37). Glycoside Hydrolases carbon utilization CAZY Xylan Oligo Cleavage (Hemicellulose) TRUE
+GH53 "GH53 endo-beta-1,4-galactanase (EC 3.2.1.89)." Glycoside Hydrolases carbon utilization CAZY Beta-galactan (pectic galactan) Backbone Cleavage TRUE
+GH54 GH54 alpha-L-arabinofuranosidase (EC 3.2.1.55); beta-xylosidase (EC 3.2.1.37). Glycoside Hydrolases carbon utilization CAZY Arabinan Oligo Cleavage TRUE
+GH55 "GH55 exo-beta-1,3-glucanase (EC 3.2.1.58); endo-beta-1,3-glucanase (EC 3.2.1.39)" Glycoside Hydrolases carbon utilization CAZY "Mixed-Linkage glucans Backbone Cleavage (Hemicellulose), Mixed-Linkage glucans Oligo Cleavage (Hemicellulose)" TRUE
+GH56 GH56 hyaluronidase (EC 3.2.1.35); chondroitin hydrolase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY Sulf-Polysachharides Backbone Cleavage TRUE
+GH57 GH57 alpha-amylase (EC 3.2.1.1); alpha-galactosidase (EC 3.2.1.22); amylopullulanase (EC 3.2.1.41); cyclomaltodextrinase (EC 3.2.1.54); branching enzyme (EC 2.4.1.18); 4-alpha-glucanotransferase (EC 2.4.1.25) Glycoside Hydrolases carbon utilization CAZY Starch Backbone Cleavage TRUE
+GH58 GH58 endo-N-acetylneuraminidase or endo-sialidase (EC 3.2.1.129) Glycoside Hydrolases carbon utilization CAZY FALSE
+GH59 GH59 beta-galactosidase (EC 3.2.1.23); galactocerebrosidase (EC 3.2.1.46) Glycoside Hydrolases carbon utilization CAZY Beta-galactan (pectic galactan) Oligo Cleavage TRUE
+GH5 "GH5 endo-beta-1,4-glucanase / cellulase (EC 3.2.1.4); endo-beta-1,4-xylanase (EC 3.2.1.8); beta-glucosidase (EC 3.2.1.21); beta-mannosidase (EC 3.2.1.25); beta-glucosylceramidase (EC 3.2.1.45); glucan beta-1,3-glucosidase (EC 3.2.1.58); licheninase (EC 3.2.1.73); exo-beta-1,4-glucanase / cellodextrinase (EC 3.2.1.74); glucan endo-1,6-beta-glucosidase (EC 3.2.1.75); mannan endo-beta-1,4-mannosidase (EC 3.2.1.78); cellulose beta-1,4-cellobiosidase (EC 3.2.1.91); steryl beta-glucosidase (EC 3.2.1.104); endoglycoceramidase (EC 3.2.1.123); chitosanase (EC 3.2.1.132); beta-primeverosidase (EC 3.2.1.149); xyloglucan-specific endo-beta-1,4-glucanase (EC 3.2.1.151); endo-beta-1,6-galactanase (EC 3.2.1.164); hesperidin 6-O-alpha-L-rhamnosyl-beta-glucosidase (EC 3.2.1.168); beta-1,3-mannanase (EC 3.2.1.-); arabinoxylan-specific endo-beta-1,4-xylanase (EC 3.2.1.-); mannan transglycosylase (EC 2.4.1.-); lichenase / endo-beta-1,3-1,4-glucanase (EC 3.2.1.73); beta-glycosidase (EC 3.2.1.-); endo-beta-1,3-glucanase / laminarinase (EC 3.2.1.39); beta-N-acetylhexosaminidase (EC 3.2.1.52); chitosanase (EC 3.2.1.132); beta-D-galactofuranosidase (EC 3.2.1.146);" Glycoside Hydrolases carbon utilization CAZY "Amorphous Cellulose Backbone Cleavage, Amorphous Cellulose Oligo Cleavage, Xyloglucan Backbone Cleavage (Hemicellulose), Xylan Backbone Cleavage (Hemicellulose), Beta-mannan Backbone Cleavage (Hemicellulose), Mixed-Linkage glucans Backbone Cleavage (Hemicellulose), Chitin Oligo Cleavage" TRUE
+GH60 GH60 Deleted family! Glycoside Hydrolases carbon utilization CAZY TRUE
+GH61 GH61 Copper-dependent lytic polysaccharide monooxygenases now reclassified in family AA9 Glycoside Hydrolases carbon utilization CAZY TRUE
+GH62 GH62 alpha-L-arabinofuranosidase (EC 3.2.1.55) Glycoside Hydrolases carbon utilization CAZY Arabinan Oligo Cleavage TRUE
+GH63 "GH63 processing alpha-glucosidase (EC 3.2.1.106); alpha-1,3-glucosidase (EC 3.2.1.84); alpha-glucosidase (EC 3.2.1.20); mannosylglycerate alpha-mannosidase / mannosylglycerate hydrolase (EC 3.2.1.170); glucosylglycerate hydrolase (EC 3.2.1.208)" Glycoside Hydrolases carbon utilization CAZY Alpha-mannan Oligo Cleavage (Hemicellulose) TRUE
+GH64 "GH64 beta-1,3-glucanase (EC 3.2.1.39)" Glycoside Hydrolases carbon utilization CAZY Mixed-Linkage glucans Backbone Cleavage (Hemicellulose) TRUE
+GH65 "GH65 alpha,alpha-trehalase (EC 3.2.1.28); maltose phosphorylase (EC 2.4.1.8); trehalose phosphorylase (EC 2.4.1.64); kojibiose phosphorylase (EC 2.4.1.230); trehalose-6-phosphate phosphorylase (EC 2.4.1.216); nigerose phosphorylase (EC 2.4.1.279); 3-O-alpha-glucopyranosyl-L-rhamnose phosphorylase (EC 2.4.1.282); 2-O-alpha-glucopyranosylglycerol: phosphate beta-glucosyltransferase (EC 2.4.1.-); alpha-glucosyl-1,2-beta-galactosyl-L-hydroxylysine alpha-glucosidase (EC 3.2.1.107)" Glycoside Hydrolases carbon utilization CAZY TRUE
+GH66 GH66 cycloisomaltooligosaccharide glucanotransferase (EC 2.4.1.248); dextranase (EC 3.2.1.11). Glycoside Hydrolases carbon utilization CAZY TRUE
+GH67 "GH67 alpha-glucuronidase (EC 3.2.1.139); xylan alpha-1,2-glucuronidase (EC 3.2.1.131)" Glycoside Hydrolases carbon utilization CAZY Xylan Oligo Cleavage (Hemicellulose) TRUE
+GH68 GH68 levansucrase (EC 2.4.1.10); beta-fructofuranosidase (EC 3.2.1.26); inulosucrase (EC 2.4.1.9). Glycoside Hydrolases carbon utilization CAZY TRUE
+GH69 GH69 Deleted: now family PL16 Glycoside Hydrolases carbon utilization CAZY TRUE
+GH6 GH6 endoglucanase (EC 3.2.1.4); cellobiohydrolase (EC 3.2.1.91) Glycoside Hydrolases carbon utilization CAZY Amorphous Cellulose Backbone Cleavage TRUE
+GH70 "GH70 dextransucrase (EC 2.4.1.5); alternansucrase (EC 2.4.1.140); reuteransucrase (EC 2.4.1.-); alpha-4,6-glucanotransferase (EC 2.4.1.-); alpha-1,2-branched dextransucrase (EC 2.4.1.-); alpha-4,3-glucanotransferase (EC 2.4.1.-)" Glycoside Hydrolases carbon utilization CAZY TRUE
+GH71 "GH71 alpha-1,3-glucanase (EC 3.2.1.59)." Glycoside Hydrolases carbon utilization CAZY TRUE
+GH72 "GH72 beta-1,3-glucanosyltransglycosylase (EC 2.4.1.-)" Glycoside Hydrolases carbon utilization CAZY TRUE
+GH73 GH73 lysozyme (EC 3.2.1.17); mannosyl-glycoprotein endo-beta-N-acetylglucosaminidase (EC 3.2.1.96); peptidoglycan hydrolase with endo-beta-N-acetylglucosaminidase specificity (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY Chitin Backbone Cleavage FALSE
+GH74 GH74 endoglucanase (EC 3.2.1.4); oligoxyloglucan reducing end-specific cellobiohydrolase (EC 3.2.1.150); xyloglucanase (EC 3.2.1.151) Glycoside Hydrolases carbon utilization CAZY Xyloglucan Backbone Cleavage (Hemicellulose) TRUE
+GH75 GH75 chitosanase (EC 3.2.1.132) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH76 "GH76 alpha-1,6-mannanase (EC 3.2.1.101); alpha-glucosidase (EC 3.2.1.20)" Glycoside Hydrolases carbon utilization CAZY "Alpha-mannan Backbone Cleavage (Hemicellulose), Alpha-mannan Oligo Cleavage (Hemicellulose)" TRUE
+GH77 GH77 amylomaltase or 4-alpha-glucanotransferase (EC 2.4.1.25) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH78 "GH78 alpha-L-rhamnosidase (EC 3.2.1.40); rhamnogalacturonan alpha-L-rhamnohydrolase (EC 3.2.1.174); L-Rhap-alpha-1,3-D-Apif -specific alpha-1,3-L-rhamnosidase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY "Pectin Oligo Cleavage, Rhamnose Oligo cleavage" TRUE
+GH79 GH79 beta-glucuronidase (EC 3.2.1.31); hyaluronoglucuronidase (EC 3.2.1.36); heparanase (EC 3.2.1.166); baicalin beta-glucuronidase (EC 3.2.1.167); beta-4-O-methyl-glucuronidase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY Sulf-Polysachharides Backbone Cleavage TRUE
+GH7 "GH7 endo-beta-1,4-glucanase (EC 3.2.1.4); reducing end-acting cellobiohydrolase (EC 3.2.1.176); chitosanase (EC 3.2.1.132); endo-beta-1,3-1,4-glucanase (EC 3.2.1.73)" Glycoside Hydrolases carbon utilization CAZY "Crystalline Cellulose Backbone Cleavage, Amorphous Cellulose Backbone Cleavage, Mixed-Linkage glucans Backbone Cleavage (Hemicellulose)" TRUE
+GH80 GH80 chitosanase (EC 3.2.1.132) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH81 "GH81 endo-beta-1,3-glucanase (EC 3.2.1.39)" Glycoside Hydrolases carbon utilization CAZY Mixed-Linkage glucans Backbone Cleavage (Hemicellulose) TRUE
+GH82 GH82 Iota;-carrageenase (EC 3.2.1.157) Glycoside Hydrolases carbon utilization CAZY Sulf-Polysachharides Backbone Cleavage TRUE
+GH83 GH83 neuraminidase (EC 3.2.1.18) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH84 GH84 N-acetyl beta-glucosaminidase (EC 3.2.1.52); hyaluronidase (EC 3.2.1.35); [protein]-3-O-(GlcNAc)-L-Ser/Thr beta-N-acetylglucosaminidase (EC 3.2.1.169) Glycoside Hydrolases carbon utilization CAZY Chitin Oligo Cleavage TRUE
+GH85 GH85 endo-beta-N-acetylglucosaminidase (EC 3.2.1.96) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH86 GH86 beta-agarase (EC 3.2.1.81); beta-porphyranase (EC 3.2.1.178) Glycoside Hydrolases carbon utilization CAZY Sulf-Polysachharides Backbone Cleavage TRUE
+GH87 "GH87 mycodextranase (EC 3.2.1.61); alpha-1,3-glucanase (EC 3.2.1.59)" Glycoside Hydrolases carbon utilization CAZY TRUE
+GH88 "GH88 d-4,5-unsaturated beta-glucuronyl hydrolase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY Sulf-Polysachharides Oligo Cleavage TRUE
+GH89 GH89 alpha-N-acetylglucosaminidase (EC 3.2.1.50) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH8 "GH8 chitosanase (EC 3.2.1.132); cellulase (EC 3.2.1.4); licheninase (EC 3.2.1.73); endo-1,4-beta-xylanase (EC 3.2.1.8); reducing-end-xylose releasing exo-oligoxylanase (EC 3.2.1.156)" Glycoside Hydrolases carbon utilization CAZY "Amorphous Cellulose Backbone Cleavage, Xylan Backbone Cleavage (Hemicellulose), Mixed-Linkage glucans Backbone Cleavage (Hemicellulose)" TRUE
+GH90 GH90 endorhamnosidase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH91 "GH91 inulin lyase [DFA-I-forming] (EC 4.2.2.17); inulin lyase [DFA-III-forming] (EC 4.2.2.18); difructofuranose 1,2':2,3' dianhydride hydrolase [DFA-IIIase] (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY TRUE
+GH92 "GH92 mannosyl-oligosaccharide alpha-1,2-mannosidase (EC 3.2.1.113); mannosyl-oligosaccharide alpha-1,3-mannosidase (EC 3.2.1.-); mannosyl-oligosaccharide alpha-1,6-mannosidase (EC 3.2.1.-); alpha-mannosidase (EC 3.2.1.24); alpha-1,2-mannosidase (EC 3.2.1.-); alpha-1,3-mannosidase (EC 3.2.1.-); alpha-1,4-mannosidase (EC 3.2.1.-); mannosyl-1-phosphodiester alpha-1,P-mannosidase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY Alpha-mannan Oligo Cleavage (Hemicellulose) TRUE
+GH93 "GH93 exo-alpha-L-1,5-arabinanase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY Arabinan Oligo Cleavage TRUE
+GH94 "GH94 cellobiose phosphorylase (EC 2.4.1.20); laminaribiose phosphorylase (EC 2.4.1.31); cellodextrin phosphorylase (EC 2.4.1.49); chitobiose phosphorylase (EC 2.4.1.-); cyclic beta-1,2-glucan synthase (EC 2.4.1.-); cellobionic acid phosphorylase (EC 2.4.1.321); beta-1,2-oligoglucan phosphorylase (EC 2.4.1.-)" Glycoside Hydrolases carbon utilization CAZY Amorphous Cellulose Oligo Cleavage TRUE
+GH95 "GH95 alpha-L-fucosidase (EC 3.2.1.51); alpha-1,2-L-fucosidase (EC 3.2.1.63); alpha-L-galactosidase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY Fucose Oligo Cleavage TRUE
+GH96 GH96 alpha-agarase (EC 3.2.1.158) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH97 GH97 glucoamylase (EC 3.2.1.3); alpha-glucosidase (EC 3.2.1.20); alpha-galactosidase (EC 3.2.1.22) Glycoside Hydrolases carbon utilization CAZY "Starch Oligo Cleavage, Alpha-galactans Oligo Cleavage" TRUE
+GH98 "GH98 blood-group endo-beta-1,4-galactosidase (EC 3.2.1.102); blood group A- and B-cleaving endo-beta-1,4-galactosidase (EC 3.2.1.-); endo-beta-1,4-xylanase (EC 3.2.1.8); endo-beta-1,4-xylanase (EC 3.2.1.8)" Glycoside Hydrolases carbon utilization CAZY Xylan Backbone Cleavage (Hemicellulose) TRUE
+GH99 "GH99 glycoprotein endo-alpha-1,2-mannosidase (EC 3.2.1.130); mannan endo-1,2-alpha-mannanase (3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY Alpha-mannan Backbone Cleavage (Hemicellulose) TRUE
+GH9 "GH9 endoglucanase (EC 3.2.1.4); endo-beta-1,3(4)-glucanase / lichenase-laminarinase (EC 3.2.1.6); beta-glucosidase (EC 3.2.1.21); lichenase / endo-beta-1,3-1,4-glucanase (EC 3.2.1.73); exo-beta-1,4-glucanase / cellodextrinase (EC 3.2.1.74); cellobiohydrolase (EC 3.2.1.91); xyloglucan-specific endo-beta-1,4-glucanase / endo-xyloglucanase (EC 3.2.1.151); exo-beta-glucosaminidase (EC 3.2.1.165)" Glycoside Hydrolases carbon utilization CAZY "Amorphous Cellulose Backbone Cleavage, Amorphous Cellulose Oligo Cleavage, Xyloglucan Backbone Cleavage (Hemicellulose), Mixed-Linkage glucans Backbone Cleavage (Hemicellulose)" TRUE
+GT0 GT0 Glycosyltransferases not yet assigned to a family GlycosylTransferases carbon utilization CAZY TRUE
+GT100 GT100 alpha-sialyltransferase (EC 2.4.99.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT101 GT101 glucosyltransferase (EC 2.4.1.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT102 "GT102 dTDP-beta-L-Rhap : O-antigen-polysaccharide alpha-1,3-L-rhamnosyltransferase (EC 2.4.1.289)" GlycosylTransferases carbon utilization CAZY TRUE
+GT103 "GT103 UDP-GlcpNAc: O-antigen-polysaccharide beta-1,4-N-acetylglucosaminyltransferase (EC 2.4.1.56)" GlycosylTransferases carbon utilization CAZY TRUE
+GT104 GT104 dTDP-beta-L-Rhap : arginine alpha-L-rhamnosyltransferase (EC 2.4.1.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT105 GT105 Dol-P-Man: protein alpha-mannosyltransferase (EC 2.4.1.109); Dol-P-Man:protein mannosyltransferase (EC 2.4.1.109) GlycosylTransferases carbon utilization CAZY TRUE
+GT106 GT106 UDP-beta-L-rhamnose:rhamnogalacturonan I 4-alpha-rhamnosyltransferase (EC 2.4.1.351) GlycosylTransferases carbon utilization CAZY TRUE
+GT107 "GT107 CMP-beta-KDO: beta-2,4-KDO transferase (EC 2.4.99.-); CMP-beta-KDO: beta-2,7-KDO transferase (EC 2.4.99.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT10 "GT10 galactoside alpha-1,3/1,4-L-fucosyltransferase (EC 2.4.1.65); galactoside alpha-1,3-L-fucosyltransferase (EC 2.4.1.152); glycoprotein alpha-1,3-L-fucosyltransferase (EC 2.4.1.214)" GlycosylTransferases carbon utilization CAZY TRUE
+GT11 "GT11 GDP-L-Fuc: galactoside alpha-1,2-L-fucosyltransferase (EC 2.4.1.69); GDP-L-Fuc: beta-LacNac alpha-1,3-L-fucosyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT12 GT12 [N-acetylneuraminyl]-galactosylglucosylceramide N-acetylgalactosaminyltransferase (EC 2.4.1.92). GlycosylTransferases carbon utilization CAZY TRUE
+GT13 "GT13 alpha-1,3-mannosyl-glycoprotein beta-1,2-N-acetylglucosaminyltransferase (EC 2.4.1.101)" GlycosylTransferases carbon utilization CAZY TRUE
+GT14 "GT14 beta-1,3-galactosyl-O-glycosyl-glycoprotein beta-1,6-N-acetylglucosaminyltransferase (EC 2.4.1.102); N-acetyllactosaminide beta-1,6-N-acetylglucosaminyltransferase (EC 2.4.1.150); protein O-beta-xylosyltransferase (EC 2.4.2.26); UDP-GlcA:arabinogalactan beta-glucuronosyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT15 "GT15 glycolipid 2-alpha-mannosyltransferase (EC 2.4.1.131); GDP-Man: alpha-1,2-mannosyltransferase (EC 2.4.1.-)." GlycosylTransferases carbon utilization CAZY TRUE
+GT16 "GT16 alpha-1,6-mannosyl-glycoprotein beta-1,2-N-acetylglucosaminyltransferase (EC 2.4.1.143)." GlycosylTransferases carbon utilization CAZY TRUE
+GT17 "GT17 beta-1,4-mannosyl-glycoprotein beta-1,4-N-acetylglucosaminyltransferase (EC 2.4.1.144)." GlycosylTransferases carbon utilization CAZY TRUE
+GT18 "GT18 alpha-1,3(6)-mannosylglycoprotein beta-1,6-N-acetyl-glucosaminyltransferase (EC 2.4.1.155)." GlycosylTransferases carbon utilization CAZY TRUE
+GT19 GT19 lipid-A-disaccharide synthase (EC 2.4.1.182). GlycosylTransferases carbon utilization CAZY TRUE
+GT1 GT1 UDP-glucuronosyltransferase (EC 2.4.1.17); zeatin O-beta-xylosyltransferase (EC 2.4.2.40); 2-hydroxyacylsphingosine 1-beta-galactosyltransferase (EC 2.4.1.45); N-acylsphingosine galactosyltransferase (EC 2.4.1.47); flavonol 3-O-glucosyltransferase (EC 2.4.1.91); anthocyanidin 3-O-glucosyltransferase (EC 2.4.1.115); sinapate 1-glucosyltransferase (EC 2.4.1.120); indole-3-acetate beta-glucosyltransferase (EC 2.4.1.121); flavonol L-rhamnosyltransferase (EC 2.4.1.159); sterol glucosyltransferase (EC 2.4.1.173); UDP-Glc: 4-hydroxybenzoate 4-O-beta-glucosyltransferase (EC 2.4.1.194); zeatin O-beta-glucosyltransferase (EC 2.4.1.203); limonoid glucosyltransferase (EC 2.4.1.210); UDP-GlcA: baicalein 7-O-beta-glucuronosyltransferase (EC 2.4.1.253); UDP-Glc: chalcone 4′-O-beta-glucosyltransferase (EC 2.4.1.286); ecdysteroid UDP-glucosyltransferase (EC 2.4.1.-); salicylic acid beta-glucosyltransferase (EC 2.4.1.-); anthocyanin 3-O-galactosyltransferase (EC 2.4.1.-); anthocyanin 5-O-glucosyltransferase (EC 2.4.1.-); dTDP-beta-2-deoxy-L-fucose: alpha-L-2-deoxyfucosyltransferase (EC 2.4.1.-); UDP-beta-L-rhamnose: alpha-L-rhamnosyltransferase (EC 2.4.1.-); zeaxanthin glucosyltransferase (EC 2.4.1.-); flavone 8-C-glycosyltransferase GlycosylTransferases carbon utilization CAZY TRUE
+GT20 "GT20 alpha,alpha-trehalose-phosphate synthase [UDP-forming] (EC 2.4.1.15); Glucosylglycerol-phosphate synthase (EC 2.4.1.213); trehalose-6-P phosphatase (EC 3.1.3.12); [retaining] GDP-valeniol: validamine 7-phosphate valeniolyltransferase (EC 2.-.-.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT21 GT21 UDP-Glc: ceramide beta-glucosyltransferase (EC 2.4.1.80). GlycosylTransferases carbon utilization CAZY TRUE
+GT22 "GT22 Dol-P-Man: Man6GlcNAc2-PP-Dol alpha-1,2-mannosyltransferase (EC 2.4.1.259); Dol-P-Man: Man8GlcNAc2-PP-Dol alpha-1,2-mannosyltransferase (EC 2.4.1.261); Dol-P-Man: Man2-GlcNAc-phosphatidylinositol alpha-1,2-mannosyltransferase (EC 2.4.1.-); Dol-P-Man: Man3-GlcNAc-phosphatidylinositol alpha-1,2-mannosyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT23 "GT23 N-acetyl-beta-D-glucosaminide alpha-1,6-L-fucosyltransferase (EC 2.4.1.68); chitin-oligosaccharide alpha-1,6-L-fucosyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT24 GT24 UDP-Glc: glycoprotein alpha-glucosyltransferase (EC 2.4.1.-). GlycosylTransferases carbon utilization CAZY TRUE
+GT25 "GT25 lipopolysaccharide beta-1,4-galactosyltransferase (EC 2.4.1.-); beta-1,3-glucosyltransferase (EC 2.4.1.-); beta-1,2-glucosyltransferase (EC 2.4.1.-); beta-1,2-galactosyltransferase (EC 2.4.1.-); LPS beta-1,4-galactosyltransferase (EC 2.4.1.-); occidiofungin beta-xylosyltransferase (EC 2.4.2.-); UDP-Gal:procollagen beta-galactosyltransferase (EC 2.4.1.50)" GlycosylTransferases carbon utilization CAZY TRUE
+GT26 "GT26 UDP-ManNAcA: beta-N-acetyl mannosaminuronyltransferase (EC 2.4.1.-); UDP-ManNAc: beta-N-acetyl-mannosaminyltransferase (EC 2.4.1.-); UDP-Glc: beta-1,4-glucosyltransferase (EC 2.4.1.-); beta-1,4-galactosyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT27 GT27 polypeptide alpha-N-acetylgalactosaminyltransferase (EC 2.4.1.41) GlycosylTransferases carbon utilization CAZY TRUE
+GT28 "GT28 1,2-diacylglycerol 3-beta-galactosyltransferase (EC 2.4.1.46); 1,2-diacylglycerol 3-beta-glucosyltransferase (EC 2.4.1.157); UDP-GlcNAc: Und-PP-MurAc-pentapeptide beta-N-acetylglucosaminyltransferase (EC 2.4.1.227); digalactosyldiacylglycerol synthase (EC 2.4.1.241)" GlycosylTransferases carbon utilization CAZY TRUE
+GT29 "GT29 sialyltransferase (EC 2.4.99.-); beta-galactoside alpha-2,6-sialyltransferase (EC 2.4.99.1); alpha-N-acetylgalactosaminide alpha-2,6-sialyltransferase (EC 2.4.99.3); beta-galactoside alpha-2,3-sialyltransferase (EC 2.4.99.4); N-acetyllactosaminide alpha-2,3-sialyltransferase (EC 2.4.99.6); (alpha-N-acetyl-neuraminyl-2,3-beta-galactosyl-1,3)-N-acetylgalactosaminide alpha-2,6-sialyltransferase (EC 2.4.99.7); alpha-N-acetyl-neuraminide alpha-2,8-sialyltransferase (EC 2.4.99.8); lactosylceramide alpha-2,3-sialyltransferase (EC 2.4.99.9)" GlycosylTransferases carbon utilization CAZY TRUE
+GT2 "GT2 cellulose synthase (EC 2.4.1.12); chitin synthase (EC 2.4.1.16); dolichyl-phosphate beta-D-mannosyltransferase (EC 2.4.1.83); dolichyl-phosphate beta-glucosyltransferase (EC 2.4.1.117); N-acetylglucosaminyltransferase (EC 2.4.1.-); N-acetylgalactosaminyltransferase (EC 2.4.1.-); hyaluronan synthase (EC 2.4.1.212); chitin oligosaccharide synthase (EC 2.4.1.-); beta-1,3-glucan synthase (EC 2.4.1.34); beta-1,4-mannan synthase (EC 2.4.1.-); beta-mannosylphosphodecaprenol-mannooligosaccharide alpha-1,6-mannosyltransferase (EC 2.4.1.199); UDP-Galf: rhamnopyranosyl-N-acetylglucosaminyl-PP-decaprenol beta-1,4/1,5-galactofuranosyltransferase (EC 2.4.1.287); UDP-Galf: galactofuranosyl-galactofuranosyl-rhamnosyl-N-acetylglucosaminyl-PP-decaprenol beta-1,5/1,6-galactofuranosyltransferase (EC 2.4.1.288); dTDP-L-Rha: N-acetylglucosaminyl-PP-decaprenol alpha-1,3-L-rhamnosyltransferase (EC 2.4.1.289)" GlycosylTransferases carbon utilization CAZY TRUE
+GT30 GT30 CMP-beta-KDO: alpha-3-deoxy-D-manno-octulosonic-acid (KDO) transferase (EC 2.4.99.-). GlycosylTransferases carbon utilization CAZY TRUE
+GT31 "GT31 N-acetyllactosaminide beta-1,3-N-acetylglucosaminyltransferase (EC 2.4.1.149); Glycoprotein-N-acetylgalactosamine 3-beta-galactosyltransferase (EC 2.4.1.122); fucose-specific beta-1,3-N-acetylglucosaminyltransferase (EC 2.4.1.-); globotriosylceramide beta-1,3-GalNAc transferase (EC 2.4.1.79); chondroitin synthase (beta-1,3-GlcUA and beta-1,4-GalNAc transferase (EC 2.4.1.175); chondroitin beta-1,3-glucuronyltransferase (EC 2.4.1.226); chondroitin beta-1,4-N-acetylgalactosaminyltransferase (EC 2.4.1.-); UDP-Gal: beta-galactosylxylosylprotein beta-1,3-galactosyltransferase (EC 2.4.1.134); UDP-GlcNAc: O-fucosylpeptide beta-1,3-N-acetylglucosaminyltransferase (EC 2.4.1.222)" GlycosylTransferases carbon utilization CAZY TRUE
+GT32 "GT32 alpha-1,6-mannosyltransferase (EC 2.4.1.-); alpha-1,4-N-acetylglucosaminyltransferase (EC 2.4.1.-); alpha-1,4-N-acetylgalactosaminyltransferase (EC 2.4.1.-); GDP-Man: inositol-phosphorylceramide transferase (EC 2.4.1.-); UDP-Gal: beta-galactoside alpha-1,4-galactosyltransferase (EC 2.4.1.-); UDP-Gal: lactose/N-acetyl-lactosamine alpha-1,4-galactosyltransferase (EC 2.4.1.-); UDP-Glc: protein alpha-glucosyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT33 GT33 GDP-Man: chitobiosyldiphosphodolichol beta-mannosyltransferase (EC 2.4.1.142). GlycosylTransferases carbon utilization CAZY TRUE
+GT34 "GT34 UDP-Gal: galactomannan alpha-1,6-galactosyltransferase (EC 2.4.1.-); UDP-Xyl: xyloglucan alpha-1,6-xylosyltransferase (EC 2.4.2.39); alpha-1,2-galactosyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT35 GT35 glycogen or starch phosphorylase (EC 2.4.1.1). GlycosylTransferases carbon utilization CAZY TRUE
+GT36 GT36 Deleted: now family GH94 GlycosylTransferases carbon utilization CAZY TRUE
+GT37 GT37 galactoside 2-L-fucosyltransferase (EC 2.4.1.69) GlycosylTransferases carbon utilization CAZY TRUE
+GT38 GT38 polysialyltransferase (EC 2.4.-.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT39 GT39 Dol-P-Man: protein alpha-mannosyltransferase (EC 2.4.1.109) GlycosylTransferases carbon utilization CAZY TRUE
+GT3 GT3 glycogen synthase (EC 2.4.1.11). GlycosylTransferases carbon utilization CAZY TRUE
+GT40 "GT40 beta-1,3-galactofuranosyltransferases (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT41 GT41 UDP-GlcNAc: peptide beta-N-acetylglucosaminyltransferase (EC 2.4.1.255); UDP-Glc: peptide N-beta-glucosyltransferase (EC 2.4.1.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT42 "GT42 CMP-NeuAc alpha-2,3-sialyltransferase (EC 2.4.99.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT43 "GT43 beta-glucuronyltransferase (EC 2.4.1.135); UDP-Xyl: xylan beta-1,4-xylosyltransferase (EC 2.4.2.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT44 GT44 UDP-Glc: alpha-glucosyltransferase (EC 2.4.1.-); UDP-GlcNAc: alpha-N-acetylglucosaminyltransferase (EC 2.4.1.-). GlycosylTransferases carbon utilization CAZY TRUE
+GT45 GT45 alpha-N-acteylglucosaminyltransferase (EC 2.4.1.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT46 GT46 Deleted GlycosylTransferases carbon utilization CAZY TRUE
+GT47 GT47 heparan beta-glucuronyltransferase (EC 2.4.1.225); xyloglucan beta-galactosyltransferase (EC 2.4.1.-); heparan synthase (EC 2.4.1.-); arabinan alpha-L-arabinosyltransferase (EC 2.4.2.-). GlycosylTransferases carbon utilization CAZY TRUE
+GT48 "GT48 1,3-beta-glucan synthase (EC 2.4.1.34)" GlycosylTransferases carbon utilization CAZY TRUE
+GT49 "GT49 beta-1,3-N-acetylglucosaminyltransferase (EC 2.4.1.-)." GlycosylTransferases carbon utilization CAZY TRUE
+GT4 "GT4 sucrose synthase (EC 2.4.1.13); sucrose-phosphate synthase (EC 2.4.1.14); alpha-glucosyltransferase (EC 2.4.1.52); lipopolysaccharide N-acetylglucosaminyltransferase (EC 2.4.1.56); phosphatidylinositol alpha-mannosyltransferase (EC 2.4.1.57); GDP-Man: Man1GlcNAc2-PP-dolichol alpha-1,3-mannosyltransferase (EC 2.4.1.132); GDP-Man: Man3GlcNAc2-PP-dolichol/Man4GlcNAc2-PP-dolichol alpha-1,2-mannosyltransferase (EC 2.4.1.131); digalactosyldiacylglycerol synthase (EC 2.4.1.141); 1,2-diacylglycerol 3-glucosyltransferase (EC 2.4.1.157); diglucosyl diacylglycerol synthase (EC 2.4.1.208); trehalose phosphorylase (EC 2.4.1.231); NDP-Glc: alpha-glucose alpha-glucosyltransferase / alpha,alpha-trehalose synthase (EC 2.4.1.245); GDP-Man: Man2GlcNAc2-PP-dolichol alpha-1,6-mannosyltransferase (EC 2.4.1.257); UDP-GlcNAc: 2-deoxystreptamine alpha-N-acetylglucosaminyltransferase (EC 2.4.1.283); UDP-GlcNAc: ribostamycin alpha-N-acetylglucosaminyltransferase (EC 2.4.1.285); UDP-Gal alpha-galactosyltransferase (EC 2.4.1.-); UDP-Xyl alpha-xylosyltransferase (EC 2.4.2.-); UDP-GlcA alpha-glucuronyltransferase (EC 2.4.1.-); UDP-Glc alpha-glucosyltransferase (EC 2.4.1.-); UDP-GalNAc: GalNAc-PP-Und alpha-1,3-N-acetylgalactosaminyltransferase (EC 2.4.1.306); UDP-GalNAc: N,N'-diacetylbacillosaminyl-PP-Und alpha-1,3-N-acetylgalactosaminyltransferase (EC 2.4.1.290); ADP-dependent alpha-maltose-1-phosphate synthase (2.4.1.342)" GlycosylTransferases carbon utilization CAZY TRUE
+GT50 "GT50 Dol-P-Man alpha-1,4-mannosyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT51 GT51 murein polymerase (EC 2.4.1.129). GlycosylTransferases carbon utilization CAZY TRUE
+GT52 "GT52 alpha-2,3-sialyltransferase (EC 2.4.99.4); alpha-glucosyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT53 GT53 UDP-L-Ara: alpha-L-arabinosyltransferase (EC 2.4.2.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT54 "GT54 UDP-GlcNAc: alpha-1,3-D-mannoside beta-1,4-N-acetylglucosaminyltransferase (EC 2.4.1.145)" GlycosylTransferases carbon utilization CAZY TRUE
+GT55 GT55 GDP-Man: mannosyl-3-phosphoglycerate synthase (EC 2.4.1.217) GlycosylTransferases carbon utilization CAZY TRUE
+GT56 GT56 TDP-Fuc4NAc: lipid II Fuc4NAc transferase (EC 2.4.1.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT57 "GT57 Dol-P-Glc: alpha-1,3-glucosyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT58 "GT58 Dol-P-Man: Man5GlcNAc2-PP-Dol alpha-1,3-mannosyltransferase (EC 2.4.1.258)" GlycosylTransferases carbon utilization CAZY TRUE
+GT59 "GT59 Dol-P-Glc: Glc2Man9GlcNAc2-PP-Dol alpha-1,2-glucosyltransferase (EC 2.4.1.256)" GlycosylTransferases carbon utilization CAZY TRUE
+GT5 "GT5 UDP-Glc: glycogen glucosyltransferase (EC 2.4.1.11); ADP-Glc: starch glucosyltransferase (EC 2.4.1.21); NDP-Glc: starch glucosyltransferase (EC 2.4.1.242); UDP-Glc: alpha-1,3-glucan synthase (EC 2.4.1.183) UDP-Glc: alpha-1,4-glucan synthase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT60 GT60 UDP-GlcNAc: polypeptide alpha-N-acetylglucosaminyltransferase (EC 2.4.1.-); UDP-GlcNAc: hydroxyproline polypeptide alpha-N-acetylglucosaminyltransferase (EC 2.4.1.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT61 "GT61 beta-1,2-xylosyltransferase (EC 2.4.2.38) ; protein O-beta-N-acetylglucosaminyltransferase (EC 2.4.1.94) ; xylan alpha-1,3-arabinofuranosyltransferase (EC 2.4.2.-) ;" GlycosylTransferases carbon utilization CAZY TRUE
+GT62 "GT62 alpha-1,2-mannosyltransferase (EC 2.4.1.-); alpha-1,6-mannosyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT63 GT63 UDP-Glc: DNA beta-glucosyltransferase (EC 2.4.1.27) GlycosylTransferases carbon utilization CAZY TRUE
+GT64 GT64 UDP-GlcNAc: heparan alpha-N-acetylhexosaminyltransferase (EC 2.4.1.224) GlycosylTransferases carbon utilization CAZY TRUE
+GT65 GT65 GDP-Fuc: protein O-alpha-fucosyltransferase (EC 2.4.1.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT66 GT66 dolichyl-diphosphooligosaccharide—protein glycotransferase (EC 2.4.99.18); undecaprenyl-diphosphooligosaccharide—protein glycotransferase (EC 2.4.99.19) GlycosylTransferases carbon utilization CAZY TRUE
+GT67 "GT67 UDP-Gal: phosphoglycan beta-1,3-galactosyltransferase 1 (SCG1) (EC 2.4.1.-); UDP-GlcNAc beta-1,2-N-acetylglucosaminyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT68 GT68 GDP-Fuc: protein O-alpha-fucosyltransferase (EC 2.4.1.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT69 "GT69 GDP-Man: alpha-1,3-mannosyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT6 "GT6 alpha-1,3-galactosyltransferase (EC 2.4.1.87); alpha-1,3 N-acetylgalactosaminyltransferase (EC 2.4.1.40); alpha-galactosyltransferase (EC 2.4.1.37); globoside alpha-N-acetylgalactosaminyltransferase (EC 2.4.1.88)." GlycosylTransferases carbon utilization CAZY TRUE
+GT70 GT70 UDP-GlcA: beta-glucuronosyltransferase (EC 2.4.1.17) GlycosylTransferases carbon utilization CAZY TRUE
+GT71 GT71 alpha-mannosyltransferase (EC 2.4.1.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT72 GT72 UDP-Glc: DNA alpha-glucosyltransferase (EC 2.4.1.26) GlycosylTransferases carbon utilization CAZY TRUE
+GT73 GT73 CMP-beta-KDO: alpha-3-deoxy-D-manno-octulosonic-acid (KDO) transferase (EC 2.4.99.-). GlycosylTransferases carbon utilization CAZY TRUE
+GT74 "GT74 alpha-1,2-L-fucosyltransferase (EC 2.4.1.69)" GlycosylTransferases carbon utilization CAZY TRUE
+GT75 GT75 UDP-Glc: self-glucosylating beta-glucosyltransferase (EC 2.4.1.-); UDP-L-arabinopyranose mutase (EC 5.4.99.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT76 "GT76 Dol-P-Man: alpha-1,6-mannosyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT77 "GT77 alpha-xylosyltransferase (EC 2.4.2.39); alpha-1,3-galactosyltransferase (EC 2.4.1.37); arabinosyltransferase (EC 2.4.2.-); arabinosyltransferase (EC 2.4.2.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT78 GT78 GDP-Man: alpha-mannosyltransferase (mannosylglycerate synthase) (EC 2.4.1.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT79 "GT79 GDP-D-Ara: phosphoglycan alpha-1,2-D-arabinopyranosyltransferase 1 (EC 2.4.2.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT7 "GT7 lactose synthase (EC 2.4.1.22); beta-N-acetylglucosaminyl-glycopeptide beta-1,4-galactosyltransferase (EC 2.4.1.38); N-acetyllactosamine synthase (EC 2.4.1.90); xylosylprotein beta-4-galactosyltransferase (EC 2.4.1.133); UDP-Gal: neolactotriaosylceramide beta-1,4-galactosyltransferase (EC 2.4.1.275); beta-1,4-N-acetylglucosaminyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT80 "GT80 beta-galactoside alpha-2,6-sialyltransferase (EC 2.4.99.1); beta-galactoside alpha-2,3-sialyltransferase (EC 2.4.99.4)" GlycosylTransferases carbon utilization CAZY TRUE
+GT81 GT81 NDP-Glc: glucosyl-3-phosphoglycerate synthase (EC 2.4.1.-); NDP-Man: mannosyl-3-phosphoglycerate synthase (EC 2.4.1.-); GlycosylTransferases carbon utilization CAZY TRUE
+GT82 "GT82 UDP-GalNAc: beta-1,4-N-acetylgalactosaminyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT83 GT83 undecaprenyl phosphate-alpha-L-Ara4N: 4-amino-4-deoxy-beta-L-arabinosyltransferase (EC 2.4.2.43); dodecaprenyl phosphate-beta-galacturonic acid: lipopolysaccharide core alpha-galacturonosyl transferase (EC 2.4.1.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT84 "GT84 cyclic beta-1,2-glucan synthase (EC 2.4.1.-);" GlycosylTransferases carbon utilization CAZY TRUE
+GT85 GT85 beta-D-arabinofuranosyl monophosphoryldecaprenol: galactan alpha-D-arabinofuranosyltransferase (EC 2.4.2.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT86 GT86 Deleted. GlycosylTransferases carbon utilization CAZY TRUE
+GT87 "GT87 polyprenol-P-Man: alpha-1,2-mannosyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT88 GT88 UDP-Glc: alpha-glucosyltransferase (EC 2.4.1.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT89 "GT89 beta-D-arabinofuranosyl-1-monophosphoryldecaprenol : arabinan beta-1,2-arabinofuranosyltransferase (EC 2.4.2.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT8 "GT8 lipopolysaccharide alpha-1,3-galactosyltransferase (EC 2.4.1.44); UDP-Glc: (glucosyl)lipopolysaccharide alpha-1,2-glucosyltransferase (EC 2.4.1.-); lipopolysaccharide glucosyltransferase 1 (EC 2.4.1.58); glycogenin glucosyltransferase (EC 2.4.1.186); inositol 1-alpha-galactosyltransferase (galactinol synthase) (EC 2.4.1.123); homogalacturonan alpha-1,4-galacturonosyltransferase (EC 2.4.1.43); UDP-GlcA: xylan alpha-glucuronyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT90 "GT90 UDP-Xyl: (mannosyl) glucuronoxylomannan/galactoxylomannan beta-1,2-xylosyltransferase (EC 2.4.2.-); UDP-Glc: protein O-beta-glucosyltransferase (EC 2.4.1.-); UDP-Xyl: protein O-beta-xylosyltransferase (EC 2.4.2.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT91 "GT91 beta-1,2-mannosyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT92 "GT92 UDP-Gal: N-glycan core alpha-1,6-fucoside beta-1,4-galactosyltransferase (EC 2.4.1.-); UDP-Gal: beta-galactoside beta-1,4-galactosyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT93 GT93 UDP-GluA : alpha-glucuronyltransferase (EC 2.4.1.-) involved in GAG polymerization GlycosylTransferases carbon utilization CAZY TRUE
+GT94 "GT94 GDP-Man: GlcA-beta-1,2-Man-alpha-1,3-Glc-beta-1,4-Glc-alpha-1-PP-undecaprenol beta-1,4-mannosyltransferase (2.4.1.251)" GlycosylTransferases carbon utilization CAZY TRUE
+GT95 GT95 UDP-beta-L-Araf:hydroxyproline beta-L-arabinofuranosyltransferase (EC 2.4.2.-); GlycosylTransferases carbon utilization CAZY TRUE
+GT96 GT96 UDP-Gal: peptidyl serine alpha-galactosyltransferase (EC 2.4.1.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT97 "GT97 CMP-Neu5Ac:alpha-galactoside alpha-2,6-sialyltransferase (EC 2.4.99.-); CMP-Neu5Ac:alpha-glucoside alpha-2,6-sialyltransferase (EC 2.4.99.-);" GlycosylTransferases carbon utilization CAZY TRUE
+GT98 GT98 Dol-P-Man : protein [tryptophan] alpha-C-mannosyltransferase (EC 2.4.1.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT99 GT99 CMP-beta-KDO 3-deoxy-beta-D-manno-oct-2-ulosonic acid transferase (EC 2.4.99.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT9 GT9 lipopolysaccharide N-acetylglucosaminyltransferase (EC 2.4.1.56); heptosyltransferase (EC 2.4.-.-). GlycosylTransferases carbon utilization CAZY TRUE
+PL0 PL0 Polysaccharide lyases not yet assigned to a family. Polysaccharide Lyases carbon utilization CAZY TRUE
+PL10 PL10 pectate lyase (EC 4.2.2.2) Polysaccharide Lyases carbon utilization CAZY Pectin Backbone Cleavage TRUE
+PL11 PL11 rhamnogalacturonan endolyase (EC 4.2.2.23); rhamnogalacturonan exolyase (EC 4.2.2.24) Polysaccharide Lyases carbon utilization CAZY Pectin Backbone Cleavage TRUE
+PL12 PL12 heparin-sulfate lyase (EC 4.2.2.8) Polysaccharide Lyases carbon utilization CAZY Sulf-Polysachharides Backbone Cleavage TRUE
+PL13 PL13 heparin lyase (EC 4.2.2.7) Polysaccharide Lyases carbon utilization CAZY Sulf-Polysachharides Backbone Cleavage TRUE
+PL14 "PL14 alginate lyase (EC 4.2.2.3); exo-oligoalginate lyase (EC 4.2.2.26); beta-1,4-glucuronan lyase (EC 4.2.2.14)" Polysaccharide Lyases carbon utilization CAZY TRUE
+PL15 PL15 oligo-alginate lyase (EC 4.2.2.-); alginate lyase (EC 4.2.2.3) Polysaccharide Lyases carbon utilization CAZY "Sulf-Polysachharides Backbone Cleavage, Sulf-Polysachharides Oligo Cleavage" TRUE
+PL16 PL16 hyaluronan lyase (EC 4.2.2.1). Polysaccharide Lyases carbon utilization CAZY FALSE
+PL17 PL17 alginate lyase (EC 4.2.2.3); oligoalginate lyase (EC 4.2.2.26) Polysaccharide Lyases carbon utilization CAZY TRUE
+PL18 PL18 alginate lyase (EC 4.2.2.3); poly(alpha-L-guluronate) lyase / G-specific alginate lyase (EC 4.2.2.11); MG-specific alginate lyase (EC 4.2.2.-) Polysaccharide Lyases carbon utilization CAZY TRUE
+PL19 PL19 Deleted: now family GH91 Polysaccharide Lyases carbon utilization CAZY TRUE
+PL1 PL1 pectate lyase (EC 4.2.2.2); exo-pectate lyase (EC 4.2.2.9); pectin lyase (EC 4.2.2.10). Polysaccharide Lyases carbon utilization CAZY Pectin Backbone Cleavage TRUE
+PL20 "PL20 endo-beta-1,4-glucuronan lyase (EC 4.2.2.14)" Polysaccharide Lyases carbon utilization CAZY TRUE
+PL21 PL21 heparin lyase (EC 4.2.2.7); heparin-sulfate lyase (EC 4.2.2.8); acharan-sulfate lyase (EC 4.2.2.-) Polysaccharide Lyases carbon utilization CAZY "Sulf-Polysachharides Backbone Cleavage, Sulf-Polysachharides Oligo Cleavage" TRUE
+PL22 PL22 oligogalacturonate lyase / oligogalacturonide lyase (EC 4.2.2.6) Polysaccharide Lyases carbon utilization CAZY Pectin Backbone Cleavage TRUE
+PL23 PL23 chondroitin lyase (EC 4.2.2.-); Polysaccharide Lyases carbon utilization CAZY Sulf-Polysachharides Oligo Cleavage TRUE
+PL24 PL24 ulvan lyase (EC 4.2.2.-). Polysaccharide Lyases carbon utilization CAZY "Sulf-Polysachharides Oligo Cleavage, Rhamnose Oligo cleavage" TRUE
+PL25 PL25 ulvan lyase (EC 4.2.2.-). Polysaccharide Lyases carbon utilization CAZY "Sulf-Polysachharides Oligo Cleavage, Rhamnose Oligo cleavage" TRUE
+PL26 PL26 rhamnogalacturonan exolyase (EC 4.2.2.24). Polysaccharide Lyases carbon utilization CAZY Pectin Backbone Cleavage TRUE
+PL27 "PL27 L-rhamnose-alpha-1,4-D-glucuronate lyase (EC 4.2.2.-)" Polysaccharide Lyases carbon utilization CAZY Rhamnose Oligo cleavage TRUE
+PL28 PL28 ulvan lyase (EC 4.2.2.-) Polysaccharide Lyases carbon utilization CAZY Rhamnose Oligo cleavage TRUE
+PL29 PL29 hyaluronate lyase (EC 4.2.2.1); chondroitin-sulfate ABC endolyase (EC 4.2.2.20); dermatan sulfate lyase (4.2.2.-); dermatan sulfate lyase (EC 4.2.2.-) Polysaccharide Lyases carbon utilization CAZY Sulf-Polysachharides Backbone Cleavage TRUE
+PL2 PL2 pectate lyase (EC 4.2.2.2); exo-polygalacturonate lyase (EC 4.2.2.9). Polysaccharide Lyases carbon utilization CAZY Pectin Backbone Cleavage TRUE
+PL30 PL30 hyaluronate lyase (EC 4.2.2.1) Polysaccharide Lyases carbon utilization CAZY Sulf-Polysachharides Backbone Cleavage TRUE
+PL31 "PL31 endo-beta-1,4-glucuronan lyase (EC 4.2.2.14)" Polysaccharide Lyases carbon utilization CAZY TRUE
+PL32 PL32 poly(beta-mannuronate) lyase / M-specific alginate lyase (EC 4.2.2.3) Polysaccharide Lyases carbon utilization CAZY TRUE
+PL33 PL33 hyaluronate lyase (EC 4.2.2.1); gellan lyase (EC 4.2.2.25); chondroitin sulfate lyase (EC 4.2.2.20) Polysaccharide Lyases carbon utilization CAZY Sulf-Polysachharides Backbone Cleavage TRUE
+PL34 PL34 alginate lyase (EC 4.2.2.-) Polysaccharide Lyases carbon utilization CAZY TRUE
+PL35 PL35 chondroitin lyase / chondroitinase (EC 4.2.2.-); chondroitin AC lyase (EC 4.2.2.5) Polysaccharide Lyases carbon utilization CAZY TRUE
+PL36 PL36 poly(beta-mannuronate) lyase / M-specific alginate lyase (EC 4.2.2.3) Polysaccharide Lyases carbon utilization CAZY TRUE
+PL37 PL37 chondroitin-sulfate ABC endolyase (EC 4.2.2.20); heparin-sulfate lyase / heparin lyase III (EC 4.2.2.8); ulvan lyase (EC 4.2.2.-) Polysaccharide Lyases carbon utilization CAZY Sulf-Polysachharides Backbone Cleavage TRUE
+PL3 PL3 pectate lyase (EC 4.2.2.2). Polysaccharide Lyases carbon utilization CAZY Pectin Backbone Cleavage TRUE
+PL4 PL4 rhamnogalacturonan endolyase (EC 4.2.2.23). Polysaccharide Lyases carbon utilization CAZY Pectin Backbone Cleavage TRUE
+PL5 PL5 alginate lyase (EC 4.2.2.3). Polysaccharide Lyases carbon utilization CAZY TRUE
+PL6 PL6 alginate lyase (EC 4.2.2.3); chondroitinase B (EC 4.2.2.19); MG-specific alginate lyase (EC 4.2.2.-); poly(alpha-L-guluronate) lyase / G-specific alginate lyase (EC 4.2.2.11); Polysaccharide Lyases carbon utilization CAZY "Sulf-Polysachharides Backbone Cleavage, Sulf-Polysachharides Oligo Cleavage" TRUE
+PL7 "PL7 poly(beta-mannuronate) lyase / M-specific alginate lyase (EC 4.2.2.3); alpha-L-guluronate lyase / G-specific alginate lyase (EC 4.2.2.11); poly-(MG)-lyase / MG-specific alginate lyase (EC 4.2.2.-); endo-beta-1,4-glucuronan lyase (EC 4.2.2.14)" Polysaccharide Lyases carbon utilization CAZY TRUE
+PL8 PL8 hyaluronate lyase (EC 4.2.2.1); chondroitin AC lyase (EC 4.2.2.5); xanthan lyase (EC 4.2.2.12); chondroitin ABC lyase (EC 4.2.2.20) Polysaccharide Lyases carbon utilization CAZY Sulf-Polysachharides Backbone Cleavage TRUE
+PL9 PL9 pectate lyase (EC 4.2.2.2); exopolygalacturonate lyase (EC 4.2.2.9); thiopeptidoglycan lyase (EC 4.2.2.-). Polysaccharide Lyases carbon utilization CAZY Pectin Backbone Cleavage FALSE
+K16954 mtsA; methylthiol:coenzyme M methyltransferase [EC:2.1.1.251] "Methanogenesis, methanethiol => methane" Energy C1-methane TRUE
+K14080 [methyl-Co(III) methanol-specific corrinoid protein]:coenzyme M methyltransferase [EC:2.1.1.246] [RN:R09098] "Methanogenesis, methanol => methane" Energy C1-methane TRUE
+K04480 methanol---5-hydroxybenzimidazolylcobamide Co-methyltransferase [EC:2.1.1.90] [RN:R09098] "Methanogenesis, methanol => methane" Energy C1-methane TRUE
+K14081 methanol corrinoid protein [RN:R09098] "Methanogenesis, methanol => methane" Energy C1-methane TRUE
+K00399 methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] "Methanogenesis, methanol => methane" Energy C1-methane TRUE
+K00401 methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] "Methanogenesis, methanol => methane" Energy C1-methane TRUE
+K00402 methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] "Methanogenesis, methanol => methane" Energy C1-methane TRUE
+K22480 heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] "Methanogenesis, methanol => methane" Energy C1-methane TRUE
+K22481 heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] "Methanogenesis, methanol => methane" Energy C1-methane TRUE
+K22482 heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] "Methanogenesis, methanol => methane" Energy C1-methane TRUE
+K03388 heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] "Methanogenesis, methanol => methane" Energy C1-methane TRUE
+K03389 heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] "Methanogenesis, methanol => methane" Energy C1-methane TRUE
+K03390 heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] "Methanogenesis, methanol => methane" Energy C1-methane TRUE
+K08264 heterodisulfide reductase [EC:1.8.98.1] [RN:R04540] "Methanogenesis, methanol => methane" Energy C1-methane TRUE
+K08265 heterodisulfide reductase [EC:1.8.98.1] [RN:R04540] "Methanogenesis, methanol => methane" Energy C1-methane TRUE
+K14127 F420-non-reducing hydrogenase iron-sulfur subunit [EC:1.8.98.5 1.8.98.6] [RN:R11943 R11944] "Methanogenesis, methanol => methane" Energy C1-methane TRUE
+K14126 F420-non-reducing hydrogenase [EC:1.8.98.5] [RN:R11943] "Methanogenesis, methanol => methane" Energy C1-methane TRUE
+K14128 F420-non-reducing hydrogenase [EC:1.8.98.5] [RN:R11943] "Methanogenesis, methanol => methane" Energy C1-methane TRUE
+K22516 formate dehydrogenase (coenzyme F420) [EC:1.8.98.6] [RN:R11944] "Methanogenesis, methanol => methane" Energy C1-methane TRUE
+K00125 formate dehydrogenase (coenzyme F420) [EC:1.8.98.6] [RN:R11944] "Methanogenesis, methanol => methane" Energy C1-methane TRUE
+K00925 acetate kinase [EC:2.7.2.1] [RN:R00315] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K00625 phosphate acetyltransferase [EC:2.3.1.8] [RN:R00230] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K13788 phosphate acetyltransferase [EC:2.3.1.8] [RN:R00230] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K01895 acetyl-CoA synthetase [EC:6.2.1.1] [RN:R00235] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K00193 acetyl-CoA decarbonylase/synthase complex [EC:2.3.1.-] [RN:R09096] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K00197 acetyl-CoA decarbonylase/synthase complex [EC:2.3.1.-] [RN:R09096] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K00194 acetyl-CoA decarbonylase/synthase complex [EC:2.3.1.-] [RN:R09096] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K00577 tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K00578 tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K00579 tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K00580 tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K00581 tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K00582 tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K00583 tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K00584 tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K00399 methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K00401 methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K00402 methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K22480 heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K22481 heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K22482 heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K03388 heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K03389 heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K03390 heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K08264 heterodisulfide reductase [EC:1.8.98.1] [RN:R04540] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K08265 heterodisulfide reductase [EC:1.8.98.1] [RN:R04540] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K14127 F420-non-reducing hydrogenase iron-sulfur subunit [EC:1.8.98.5 1.8.98.6] [RN:R11943 R11944] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K14126 F420-non-reducing hydrogenase [EC:1.8.98.5] [RN:R11943] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K14128 F420-non-reducing hydrogenase [EC:1.8.98.5] [RN:R11943] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K22516 formate dehydrogenase (coenzyme F420) [EC:1.8.98.6] [RN:R11944] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K00125 formate dehydrogenase (coenzyme F420) [EC:1.8.98.6] [RN:R11944] "Methanogenesis, acetate => methane" Energy C1-methane TRUE
+K14082 mtbA; [methyl-Co(III) methylamine-specific corrinoid protein]:coenzyme M methyltransferase [EC:2.1.1.247] [RN:R09998] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K16177 mtmC; monomethylamine corrinoid protein [RN:R09998] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K16176 mtmB; methylamine---corrinoid protein Co-methyltransferase [EC:2.1.1.248] [RN:R09998] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K16179 mtbC; dimethylamine corrinoid protein [RN:R09999] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K16178 mtbB; dimethylamine---corrinoid protein Co-methyltransferase [EC:2.1.1.249] [RN:R09999] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K14084 mttC; trimethylamine corrinoid protein [RN:R09124] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K14083 mttB; trimethylamine---corrinoid protein Co-methyltransferase [EC:2.1.1.250] [RN:R09124] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K00399 methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K00401 methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K00402 methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K22480 heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K22481 heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K22482 heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K03388 heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K03389 heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K03390 heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K08264 heterodisulfide reductase [EC:1.8.98.1] [RN:R04540] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K08265 heterodisulfide reductase [EC:1.8.98.1] [RN:R04540] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K14127 F420-non-reducing hydrogenase iron-sulfur subunit [EC:1.8.98.5 1.8.98.6] [RN:R11943 R11944] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K14126 F420-non-reducing hydrogenase [EC:1.8.98.5] [RN:R11943] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K14128 F420-non-reducing hydrogenase [EC:1.8.98.5] [RN:R11943] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K22516 formate dehydrogenase (coenzyme F420) [EC:1.8.98.6] [RN:R11944] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K00125 formate dehydrogenase (coenzyme F420) [EC:1.8.98.6] [RN:R11944] "Methanogenesis, methylamine/dimethylamine/trimethylamine => methane" Energy C1-methane TRUE
+K00200 formylmethanofuran dehydrogenase [EC:1.2.99.5] [RN:R03015] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K00201 formylmethanofuran dehydrogenase [EC:1.2.99.5] [RN:R03015] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K00202 formylmethanofuran dehydrogenase [EC:1.2.99.5] [RN:R03015] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K00203 formylmethanofuran dehydrogenase [EC:1.2.99.5] [RN:R03015] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K11261 formylmethanofuran dehydrogenase [EC:1.2.99.5] [RN:R03015] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K00205 4Fe-4S ferredoxin "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K11260 4Fe-4S ferredoxin "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K00204 4Fe-4S ferredoxin "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K00672 formylmethanofuran--tetrahydromethanopterin N-formyltransferase [EC:2.3.1.101] [RN:R03390] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K01499 methenyltetrahydromethanopterin cyclohydrolase [EC:3.5.4.27] [RN:R03464] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K00319 methylenetetrahydromethanopterin dehydrogenase [EC:1.5.99.9] [RN:R04456] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K13942 "5,10-methenyltetrahydromethanopterin hydrogenase [EC:1.12.98.2] [RN:R04455]" "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K00320 "coenzyme F420-dependent N5,N10-methenyltetrahydromethanopterin reductase [EC:1.5.99.11] [RN:R04464]" "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K00577 tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K00578 tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K00579 tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K00580 tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K00581 tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K00582 tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K00583 tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K00584 tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K00399 methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K00401 methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K00402 methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K22480 heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K22481 heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K22482 heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K03388 heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K03389 heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K03390 heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K08264 heterodisulfide reductase [EC:1.8.98.1] [RN:R04540] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K08265 heterodisulfide reductase [EC:1.8.98.1] [RN:R04540] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K14127 F420-non-reducing hydrogenase iron-sulfur subunit [EC:1.8.98.5 1.8.98.6] [RN:R11943 R11944] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K14126 F420-non-reducing hydrogenase [EC:1.8.98.5] [RN:R11943] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K14128 F420-non-reducing hydrogenase [EC:1.8.98.5] [RN:R11943] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K22516 formate dehydrogenase (coenzyme F420) [EC1.8.98.6] [RN:R11944] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K00125 formate dehydrogenase (coenzyme F420) [EC1.8.98.6] [RN:R11944] "Methanogenesis, CO2 => methane" Energy C1-methane TRUE
+K07811 trimethylamine-N-oxide reductase (cytochrome c) [EC:1.7.2.3] TMAO Energy C1 TRUE
+K00855 phosphoribulokinase [EC:2.7.1.19] [RN:R01523] Reductive pentose phosphate cycle (Calvin cycle) Energy C1 TRUE
+K01601 ribulose-bisphosphate carboxylase [EC:4.1.1.39] [RN:R00024] Reductive pentose phosphate cycle (Calvin cycle) Energy C1 TRUE
+K01602 ribulose-bisphosphate carboxylase [EC:4.1.1.39] [RN:R00024] Reductive pentose phosphate cycle (Calvin cycle) Energy C1 TRUE
+K00927 phosphoglycerate kinase [EC:2.7.2.3] [RN:R01512] Reductive pentose phosphate cycle (Calvin cycle) Energy C1 TRUE
+K05298 glyceraldehyde-3-phosphate dehydrogenase (phosphorylating) [EC:1.2.1.13 1.2.1.59 1.2.1.12] [RN:R01061 R01063] Reductive pentose phosphate cycle (Calvin cycle) Energy C1 TRUE
+K00150 glyceraldehyde-3-phosphate dehydrogenase (phosphorylating) [EC:1.2.1.13 1.2.1.59 1.2.1.12] [RN:R01061 R01063] Reductive pentose phosphate cycle (Calvin cycle) Energy C1 TRUE
+K00134 glyceraldehyde-3-phosphate dehydrogenase (phosphorylating) [EC:1.2.1.13 1.2.1.59 1.2.1.12] [RN:R01061 R01063] Reductive pentose phosphate cycle (Calvin cycle) Energy C1 TRUE
+K01623 fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01068 R01829] Reductive pentose phosphate cycle (Calvin cycle) Energy C1 TRUE
+K01624 fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01068 R01829] Reductive pentose phosphate cycle (Calvin cycle) Energy C1 TRUE
+K03841 "fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762]" Reductive pentose phosphate cycle (Calvin cycle) Energy C1 TRUE
+K02446 "fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762]" Reductive pentose phosphate cycle (Calvin cycle) Energy C1 TRUE
+K11532 "fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762]" Reductive pentose phosphate cycle (Calvin cycle) Energy C1 TRUE
+K01086 "fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762]" Reductive pentose phosphate cycle (Calvin cycle) Energy C1 TRUE
+K04041 "fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762]" Reductive pentose phosphate cycle (Calvin cycle) Energy C1 TRUE
+K00615 transketolase [EC:2.2.1.1] [RN:R01067 R01641] Reductive pentose phosphate cycle (Calvin cycle) Energy C1 TRUE
+K01100 sedoheptulose-bisphosphatase [EC:3.1.3.37] [RN:R01845] Reductive pentose phosphate cycle (Calvin cycle) Energy C1 TRUE
+K01807 ribose 5-phosphate isomerase [EC:5.3.1.6] [RN:R01056] Reductive pentose phosphate cycle (Calvin cycle) Energy C1 TRUE
+K01808 ribose 5-phosphate isomerase [EC:5.3.1.6] [RN:R01056] Reductive pentose phosphate cycle (Calvin cycle) Energy C1 TRUE
+K00855 phosphoribulokinase [EC:2.7.1.19] [RN:R01523] "Reductive pentose phosphate cycle, ribulose-5P => glyceraldehyde-3P" Energy C1 TRUE
+K01601 ribulose-bisphosphate carboxylase [EC:4.1.1.39] [RN:R00024] "Reductive pentose phosphate cycle, ribulose-5P => glyceraldehyde-3P" Energy C1 TRUE
+K01602 ribulose-bisphosphate carboxylase [EC:4.1.1.39] [RN:R00024] "Reductive pentose phosphate cycle, ribulose-5P => glyceraldehyde-3P" Energy C1 TRUE
+K00927 phosphoglycerate kinase [EC:2.7.2.3] [RN:R01512] "Reductive pentose phosphate cycle, ribulose-5P => glyceraldehyde-3P" Energy C1 TRUE
+K05298 glyceraldehyde-3-phosphate dehydrogenase (phosphorylating) [EC:1.2.1.13 1.2.1.59 1.2.1.12] [RN:R01061 R01063] "Reductive pentose phosphate cycle, ribulose-5P => glyceraldehyde-3P" Energy C1 TRUE
+K00150 glyceraldehyde-3-phosphate dehydrogenase (phosphorylating) [EC:1.2.1.13 1.2.1.59 1.2.1.12] [RN:R01061 R01063] "Reductive pentose phosphate cycle, ribulose-5P => glyceraldehyde-3P" Energy C1 TRUE
+K00134 glyceraldehyde-3-phosphate dehydrogenase (phosphorylating) [EC:1.2.1.13 1.2.1.59 1.2.1.12] [RN:R01061 R01063] "Reductive pentose phosphate cycle, ribulose-5P => glyceraldehyde-3P" Energy C1 TRUE
+K01623 fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01068 R01829] "Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P" Energy C1 TRUE
+K01624 fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01068 R01829] "Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P" Energy C1 TRUE
+K03841 "fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762]" "Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P" Energy C1 TRUE
+K02446 "fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762]" "Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P" Energy C1 TRUE
+K11532 "fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762]" "Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P" Energy C1 TRUE
+K01086 "fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762]" "Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P" Energy C1 TRUE
+K04041 "fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762]" "Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P" Energy C1 TRUE
+K00615 transketolase [EC:2.2.1.1] [RN:R01067 R01641] "Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P" Energy C1 TRUE
+K01100 sedoheptulose-bisphosphatase [EC:3.1.3.37] [RN:R01845] "Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P" Energy C1 TRUE
+K01807 ribose 5-phosphate isomerase [EC:5.3.1.6] [RN:R01056] "Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P" Energy C1 TRUE
+K01808 ribose 5-phosphate isomerase [EC:5.3.1.6] [RN:R01056] "Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P" Energy C1 TRUE
+K00169 pyruvate:ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K00170 pyruvate:ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K00171 pyruvate:ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K00172 pyruvate:ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K03737 pyruvate-ferredoxin/flavodoxin oxidoreductase [EC:1.2.7.1 1.2.7.-] [RN:R01196 R10866] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K01007 "pyruvate,water dikinase [EC:2.7.9.2] [RN:R00199]" Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K01006 "pyruvate,orthophosphate dikinase [EC:2.7.9.1] [RN:R00206]" Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K01595 phosphoenolpyruvate carboxylase [EC:4.1.1.31] [RN:R00345] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K01959 pyruvate carboxylase subunit A [EC:6.4.1.1] [RN:R00344] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K01960 pyruvate carboxylase subunit A [EC:6.4.1.1] [RN:R00344] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K01958 pyruvate carboxylase subunit A [EC:6.4.1.1] [RN:R00344] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K00024 malate dehydrogenase [EC:1.1.1.37] [RN:R00342] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K01676 fumarate hydratase [EC:4.2.1.2] [RN:R01082] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K01679 fumarate hydratase [EC:4.2.1.2] [RN:R01082] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K01677 fumarate hydratase [EC:4.2.1.2] [RN:R01082] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K01678 fumarate hydratase [EC:4.2.1.2] [RN:R01082] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K00239 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K00240 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K00241 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K00242 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K00244 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K00245 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K00246 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K00247 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K18556 NADH-dependent fumarate reductase [EC:1.3.1.6] [RN:R00402] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K18557 NADH-dependent fumarate reductase [EC:1.3.1.6] [RN:R00402] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K18558 NADH-dependent fumarate reductase [EC:1.3.1.6] [RN:R00402] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K18559 NADH-dependent fumarate reductase [EC:1.3.1.6] [RN:R00402] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K18560 NADH-dependent fumarate reductase [EC:1.3.1.6] [RN:R00402] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K01902 succinyl-CoA synthetase [EC:6.2.1.5] [RN:R00405] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K01903 succinyl-CoA synthetase [EC:6.2.1.5] [RN:R00405] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K00174 2-oxoglutarate:ferredoxin oxidoreductase [EC:1.2.7.3] [RN:R01197] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K00175 2-oxoglutarate:ferredoxin oxidoreductase [EC:1.2.7.3] [RN:R01197] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K00177 2-oxoglutarate:ferredoxin oxidoreductase [EC:1.2.7.3] [RN:R01197] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K00176 2-oxoglutarate:ferredoxin oxidoreductase [EC:1.2.7.3] [RN:R01197] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K00031 isocitrate dehydrogenase [EC:1.1.1.42] [RN:R00267] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K01681 aconitate hydratase [EC:4.2.1.3] [RN:R01900 R01325] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K01682 aconitate hydratase [EC:4.2.1.3] [RN:R01900 R01325] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K15230 ATP-citrate lyase [EC:2.3.3.8] [RN:R00352] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K15231 ATP-citrate lyase [EC:2.3.3.8] [RN:R00352] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K15232 citryl-CoA synthetase [EC:6.2.1.18] [RN:R01322] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K15233 citryl-CoA synthetase [EC:6.2.1.18] [RN:R01322] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K15234 citryl-CoA lyase [EC:4.1.3.34] [RN:R00354] Reductive citrate cycle (Arnon-Buchanan cycle) Energy C1 TRUE
+K10944 methane/ammonia monooxygenase [EC:1.14.18.3] [RN:R09518] "Methane oxidation, methanotroph, methane => formaldehyde" Energy C1 TRUE
+K10945 methane/ammonia monooxygenase [EC:1.14.18.3] [RN:R09518] "Methane oxidation, methanotroph, methane => formaldehyde" Energy C1 TRUE
+K10946 methane/ammonia monooxygenase [EC:1.14.18.3] [RN:R09518] "Methane oxidation, methanotroph, methane => formaldehyde" Energy C1 TRUE
+K16157 methane monooxygenase component A [EC:1.14.13.25] [RN:R01142] "Methane oxidation, methanotroph, methane => formaldehyde" Energy C1 TRUE
+K16158 methane monooxygenase component A [EC:1.14.13.25] [RN:R01142] "Methane oxidation, methanotroph, methane => formaldehyde" Energy C1 TRUE
+K16159 methane monooxygenase component A [EC:1.14.13.25] [RN:R01142] "Methane oxidation, methanotroph, methane => formaldehyde" Energy C1 TRUE
+K16160 methane monooxygenase regulatory protein B [RN:R01142] "Methane oxidation, methanotroph, methane => formaldehyde" Energy C1 TRUE
+K16161 methane monooxygenase component C [EC:1.14.13.25] [RN:R01142] "Methane oxidation, methanotroph, methane => formaldehyde" Energy C1 TRUE
+K16162 methane monooxygenase component D [RN:R01142] "Methane oxidation, methanotroph, methane => formaldehyde" Energy C1 TRUE
+K14028 methanol dehydrogenase [EC:1.1.2.7] [RN:R01146] "Methane oxidation, methanotroph, methane => formaldehyde" Energy C1 TRUE
+K14029 methanol dehydrogenase [EC:1.1.2.7] [RN:R01146] "Methane oxidation, methanotroph, methane => formaldehyde" Energy C1 TRUE
+K17066 alcohol oxidase [EC:1.1.3.13] [RN:R00608] "Methane oxidation, methanotroph, methane => formaldehyde" Energy C1 TRUE
+K08097 phosphosulfolactate synthase [EC:4.4.1.19] [RN:R07476] Coenzyme M biosynthesis Energy C1 TRUE
+K05979 2-phosphosulfolactate phosphatase [EC:3.1.3.71] [RN:R05789] Coenzyme M biosynthesis Energy C1 TRUE
+K05884 L-2-hydroxycarboxylate dehydrogenase (NAD+) [EC:1.1.1.337] [RN:R07136] Coenzyme M biosynthesis Energy C1 TRUE
+K13039 sulfopyruvate decarboxylase [EC:4.1.1.79] [RN:R05774] Coenzyme M biosynthesis Energy C1 TRUE
+K06034 sulfopyruvate decarboxylase [EC:4.1.1.79] [RN:R05774] Coenzyme M biosynthesis Energy C1 TRUE
+K00169 pyruvate ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K00170 pyruvate ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K00171 pyruvate ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K00172 pyruvate ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K01007 "pyruvate, water dikinase [EC:2.7.9.2] [RN:R00199]" Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K01595 phosphoenolpyruvate carboxylase [EC:4.1.1.31] [RN:R00345] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K00024 malate dehydrogenase [EC:1.1.1.37] [RN:R00342] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K01676 fumarate hydratase [EC:4.2.1.2] [RN:R01082] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K01677 fumarate hydratase [EC:4.2.1.2] [RN:R01082] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K01678 fumarate hydratase [EC:4.2.1.2] [RN:R01082] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K00239 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K00240 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K00241 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K18860 succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K01902 succinyl-CoA synthetase [EC:6.2.1.5] [RN:R00405] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K01903 succinyl-CoA synthetase [EC:6.2.1.5] [RN:R00405] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K15038 succinyl-CoA reductase [EC:1.2.1.76] [RN:R09280] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K15017 succinyl-CoA reductase [EC:1.2.1.76] [RN:R09280] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K14465 succinate semialdehyde reductase (NADPH) [EC:1.1.1.-] [RN:R09281] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K14467 4-hydroxybutyrate---CoA ligase (AMP-forming) [EC:6.2.1.40] [RN:R09279] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K18861 4-hydroxybutyrate---CoA ligase (AMP-forming) [EC:6.2.1.40] [RN:R09279] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K14534 4-hydroxybutyryl-CoA dehydratase [EC:4.2.1.120] [RN:R10782] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K15016 3-hydroxybutyryl-CoA dehydratase / 3-hydroxyacyl-CoA dehydrogenase [EC:4.2.1.17 1.1.1.35] [RN:R03026 R01975] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K00626 acetyl-CoA C-acetyltransferase [EC:2.3.1.9] [RN:R00238] Dicarboxylate-hydroxybutyrate cycle Energy C1 TRUE
+K01964 acetyl-CoA/propionyl-CoA carboxylase [EC:6.4.1.2 6.4.1.3] [RN:R00742 R01859] Hydroxypropionate-hydroxybutylate cycle Energy C1 TRUE
+K15037 biotin carboxyl carrier protein [RN:R00742 R01859] Hydroxypropionate-hydroxybutylate cycle Energy C1 TRUE
+K15036 acetyl-CoA/propionyl-CoA carboxylase [EC:6.4.1.2 6.4.1.3] [RN:R00742 R01859] Hydroxypropionate-hydroxybutylate cycle Energy C1 TRUE
+K15017 malonyl-CoA reductase (NADPH) [EC:1.2.1.75] [RN:R00740] Hydroxypropionate-hydroxybutylate cycle Energy C1 TRUE
+K15039 3-hydroxypropionate dehydrogenase (NADP+) [EC:1.1.1.298] [RN:R09289] Hydroxypropionate-hydroxybutylate cycle Energy C1 TRUE
+K15018 3-hydroxypropionyl-coenzyme A synthetase [EC:6.2.1.36] [RN:R09286] Hydroxypropionate-hydroxybutylate cycle Energy C1 TRUE
+K15019 3-hydroxypropionyl-coenzyme A dehydratase [EC:4.2.1.116] [RN:R03045] Hydroxypropionate-hydroxybutylate cycle Energy C1 TRUE
+K15020 acryloyl-coenzyme A reductase [EC:1.3.1.84] [RN:R00919] Hydroxypropionate-hydroxybutylate cycle Energy C1 TRUE
+K05606 methylmalonyl-CoA epimerase [EC:5.1.99.1] [RN:R02765] Hydroxypropionate-hydroxybutylate cycle Energy C1 TRUE
+K01848 methylmalonyl-CoA mutase [EC:5.4.99.2] [RN:R00833] Hydroxypropionate-hydroxybutylate cycle Energy C1 TRUE
+K01849 methylmalonyl-CoA mutase [EC:5.4.99.2] [RN:R00833] Hydroxypropionate-hydroxybutylate cycle Energy C1 TRUE
+K15038 succinyl-coA reductase [EC:1.2.1.76] [RN:R09280] Hydroxypropionate-hydroxybutylate cycle Energy C1 TRUE
+K14465 succinate semialdehyde reductase [EC:1.1.1.-] [RN:R09281] Hydroxypropionate-hydroxybutylate cycle Energy C1 TRUE
+K14466 4-hydroxybutyrate---CoA ligase (AMP-forming) [EC:6.2.1.40] [RN:R09279] Hydroxypropionate-hydroxybutylate cycle Energy C1 TRUE
+K18861 4-hydroxybutyrate---CoA ligase (AMP-forming) [EC:6.2.1.40] [RN:R09279] Hydroxypropionate-hydroxybutylate cycle Energy C1 TRUE
+K14534 4-hydroxybutyryl-CoA dehydratase / vinylacetyl-CoA-Delta-isomerase [EC:4.2.1.120 5.3.3.3] [RN:R10782] Hydroxypropionate-hydroxybutylate cycle Energy C1 TRUE
+K15016 3-hydroxybutyryl-CoA dehydratase / 3-hydroxyacyl-CoA dehydrogenase [EC:4.2.1.17 1.1.1.35] [RN:R03026 R01975] Hydroxypropionate-hydroxybutylate cycle Energy C1 TRUE
+K00626 acetyl-CoA C-acetyltransferase [EC:2.3.1.9] [RN:R00238] Hydroxypropionate-hydroxybutylate cycle Energy C1 TRUE
+K08691 malyl-CoA/(S)-citramalyl-CoA lyase [EC:4.1.3.24 4.1.3.25] [RN:R00473 R00934 R00237] 3-Hydroxypropionate bi-cycle Energy C1 TRUE
+K14449 2-methylfumaryl-CoA hydratase [EC:4.2.1.148] [RN:R05076] 3-Hydroxypropionate bi-cycle Energy C1 TRUE
+K14470 2-methylfumaryl-CoA isomerase [EC:5.4.1.3] [RN:R09283] 3-Hydroxypropionate bi-cycle Energy C1 TRUE
+K09709 3-methylfumaryl-CoA hydratase [EC:4.2.1.153] [RN:R09282] 3-Hydroxypropionate bi-cycle Energy C1 TRUE
+K00198 carbon-monoxide dehydrogenase [EC:1.2.7.4] [RN:R07157] Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) Energy C1 TRUE
+K05299 formate dehydrogenase [EC:1.17.1.10] [RN:R00134] Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) Energy C1 TRUE
+K15022 formate dehydrogenase [EC:1.17.1.10] [RN:R00134] Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) Energy C1 TRUE
+K01938 formate--tetrahydrofolate ligase [EC:6.3.4.3] [RN:R00943] Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) Energy C1 TRUE
+K01491 methylenetetrahydrofolate dehydrogenase (NADP+) / methenyltetrahydrofolate cyclohydrolase [EC:1.5.1.5 3.5.4.9] [RN:R01655 R01220] Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) Energy C1 TRUE
+K00297 methylenetetrahydrofolate reductase (NADPH) [EC:1.5.1.20] [RN:R07168] Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) Energy C1 TRUE
+K15023 5-methyltetrahydrofolate corrinoid/iron sulfur protein methyltransferase [EC:2.1.1.258] [RN:R02289] Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) Energy C1 TRUE
+K14138 acetyl-CoA synthase [EC:2.3.1.169] [RN:R08433] Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) Energy C1 TRUE
+K00197 acetyl-CoA decarbonylase/synthase complex [EC:2.3.1.-] [RN:R10243] Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) Energy C1 TRUE
+K00194 acetyl-CoA decarbonylase/synthase complex [EC:2.3.1.-] [RN:R10243] Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) Energy C1 TRUE
+K11212 LPPG:FO 2-phospho-L-lactate transferase [EC:2.7.8.28] [RN:R09398] F420 biosynthesis Energy C1 TRUE
+K12234 coenzyme F420-0:L-glutamate ligase / coenzyme F420-1:gamma-L-glutamate ligase [EC:6.3.2.31 6.3.2.34] [RN:R09399 R09400] F420 biosynthesis Energy C1 TRUE
+K00192 "cdhA; anaerobic carbon-monoxide dehydrogenase, CODH/ACS complex subunit alpha [EC:1.2.7.4] [RN:R07157]" "Acetyl-CoA pathway, CO2 => acetyl-CoA" Energy C1 TRUE
+K00195 "cdhB; anaerobic carbon-monoxide dehydrogenase, CODH/ACS complex subunit epsilon [RN:R07157]" "Acetyl-CoA pathway, CO2 => acetyl-CoA" Energy C1 TRUE
+K00193 "cdhC; acetyl-CoA decarbonylase/synthase, CODH/ACS complex subunit beta [EC:2.3.1.169] [RN:R09096 R10219]" "Acetyl-CoA pathway, CO2 => acetyl-CoA" Energy C1 TRUE
+K00197 "cdhE; acetyl-CoA decarbonylase/synthase, CODH/ACS complex subunit gamma [EC:2.1.1.245] [RN:R09096 R10219]" "Acetyl-CoA pathway, CO2 => acetyl-CoA" Energy C1 TRUE
+K00194 "cdhD; acetyl-CoA decarbonylase/synthase, CODH/ACS complex subunit delta [EC:2.1.1.245] [RN:R09096 R10219]" "Acetyl-CoA pathway, CO2 => acetyl-CoA" Energy C1 TRUE
+K00196 carbon-monoxide dehydrogenase iron sulfur subunit Acetyl-CoA pathway Energy C1 TRUE
+K03518 carbon-monoxide dehydrogenase small subunit Acetyl-CoA pathway Energy C1 TRUE
+K03519 carbon-monoxide dehydrogenase medium subunit Acetyl-CoA pathway Energy C1 TRUE
+K03520 carbon-monoxide dehydrogenase large subunit Acetyl-CoA pathway Energy C1 TRUE
+K10616 cymAa; p-cymene methyl-monooxygenase [EC:1.14.15.25] [RN:R05266] "Cymene degradation, p-cymene => p-cumate" MISC hydrocarbon degradation TRUE
+K18293 cymAb; p-cymene methyl-monooxygenase electron transfer component [EC:1.18.1.3] "Cymene degradation, p-cymene => p-cumate" MISC hydrocarbon degradation TRUE
+K10617 cymB; p-cumic alcohol dehydrogenase [RN:R05232] "Cymene degradation, p-cymene => p-cumate" MISC hydrocarbon degradation TRUE
+K10618 cymC; p-cumic aldehyde dehydrogenase [RN:R05235] "Cymene degradation, p-cymene => p-cumate" MISC hydrocarbon degradation TRUE
+K01885 glutamyl-tRNA synthetase [EC:6.1.1.17] [RN:R05578] "Siroheme biosynthesis, glutamate => siroheme" MISC Antibiotic Resistance TRUE
+K14163 glutamyl-tRNA synthetase [EC:6.1.1.17] [RN:R05578] "Siroheme biosynthesis, glutamate => siroheme" MISC Antibiotic Resistance TRUE
+K02492 glutamyl-tRNA reductase [EC:1.2.1.70] [RN:R04109] "Siroheme biosynthesis, glutamate => siroheme" MISC Antibiotic Resistance TRUE
+K01845 "glutamate-1-semialdehyde 2,1-aminomutase [EC:5.4.3.8] [RN:R02272]" "Siroheme biosynthesis, glutamate => siroheme" MISC Antibiotic Resistance TRUE
+K01698 porphobilinogen synthase [EC:4.2.1.24] [RN:R00036] "Siroheme biosynthesis, glutamate => siroheme" MISC Antibiotic Resistance TRUE
+K01749 hydroxymethylbilane synthase [EC:2.5.1.61] [RN:R00084] "Siroheme biosynthesis, glutamate => siroheme" MISC Antibiotic Resistance TRUE
+K01719 uroporphyrinogen-III synthase [EC:4.2.1.75] [RN:R03165] "Siroheme biosynthesis, glutamate => siroheme" MISC Antibiotic Resistance TRUE
+K13542 uroporphyrinogen-III synthase [EC:4.2.1.75] [RN:R03165] "Siroheme biosynthesis, glutamate => siroheme" MISC Antibiotic Resistance TRUE
+K13543 uroporphyrinogen-III synthase [EC:4.2.1.75] [RN:R03165] "Siroheme biosynthesis, glutamate => siroheme" MISC Antibiotic Resistance TRUE
+K02302 uroporphyrin-III C-methyltransferase [EC:2.1.1.107] [RN:R03194] "Siroheme biosynthesis, glutamate => siroheme" MISC Antibiotic Resistance TRUE
+K00589 uroporphyrin-III C-methyltransferase [EC:2.1.1.107] [RN:R03194] "Siroheme biosynthesis, glutamate => siroheme" MISC Antibiotic Resistance TRUE
+K02303 uroporphyrin-III C-methyltransferase [EC:2.1.1.107] [RN:R03194] "Siroheme biosynthesis, glutamate => siroheme" MISC Antibiotic Resistance TRUE
+K02496 uroporphyrin-III C-methyltransferase [EC:2.1.1.107] [RN:R03194] "Siroheme biosynthesis, glutamate => siroheme" MISC Antibiotic Resistance TRUE
+K02304 precorrin-2 dehydrogenase [EC:1.3.1.76] [RN:R03947] "Siroheme biosynthesis, glutamate => siroheme" MISC Antibiotic Resistance TRUE
+K03794 sirohydrochlorin ferrochelatase [EC:4.99.1.4] [RN:R02864] "Siroheme biosynthesis, glutamate => siroheme" MISC Antibiotic Resistance TRUE
+K05599 "anthranilate 1,2-dioxygenase [EC:1.14.12.1] [RN:R00823 R00825]" "Anthranilate degradation, anthranilate => catechol" MISC hydrocarbon degradation TRUE
+K05600 "anthranilate 1,2-dioxygenase [EC:1.14.12.1] [RN:R00823 R00825]" "Anthranilate degradation, anthranilate => catechol" MISC hydrocarbon degradation TRUE
+K11311 "anthranilate 1,2-dioxygenase [EC:1.14.12.1] [RN:R00823 R00825]" "Anthranilate degradation, anthranilate => catechol" MISC hydrocarbon degradation TRUE
+K16319 "anthranilate 1,2-dioxygenase [EC:1.14.12.1]" "Anthranilate degradation, anthranilate => catechol" MISC hydrocarbon degradation TRUE
+K16320 "anthranilate 1,2-dioxygenase [EC:1.14.12.1]" "Anthranilate degradation, anthranilate => catechol" MISC hydrocarbon degradation TRUE
+K18248 "anthranilate 1,2-dioxygenase [EC:1.14.12.1]" "Anthranilate degradation, anthranilate => catechol" MISC hydrocarbon degradation TRUE
+K18249 "anthranilate 1,2-dioxygenase [EC:1.14.12.1]" "Anthranilate degradation, anthranilate => catechol" MISC hydrocarbon degradation TRUE
+K18242 salicylate 5-hydroxylase [EC:1.14.13.172] [RN:R07709 R07710] "Salicylate degradation, salicylate => gentisate" MISC hydrocarbon degradation TRUE
+K18243 salicylate 5-hydroxylase [EC:1.14.13.172] [RN:R07709 R07710] "Salicylate degradation, salicylate => gentisate" MISC hydrocarbon degradation TRUE
+K14578 salicylate 5-hydroxylase [EC:1.14.13.172] [RN:R07709 R07710] "Salicylate degradation, salicylate => gentisate" MISC hydrocarbon degradation TRUE
+K14581 salicylate 5-hydroxylase [EC:1.14.13.172] [RN:R07709 R07710] "Salicylate degradation, salicylate => gentisate" MISC hydrocarbon degradation TRUE
+K02302 cysG; uroporphyrin-III C-methyltransferase / precorrin-2 dehydrogenase / sirohydrochlorin ferrochelatase [EC:2.1.1.107 1.3.1.76 4.99.1.4] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC anaerobic corrin ring synthesis TRUE
+K02304 MET8; precorrin-2 dehydrogenase / sirohydrochlorin ferrochelatase [EC:1.3.1.76 4.99.1.4] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC anaerobic corrin ring synthesis TRUE
+K02190 cbiK; sirohydrochlorin cobaltochelatase [EC:4.99.1.3] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC anaerobic corrin ring synthesis TRUE
+K03795 cbiX; sirohydrochlorin cobaltochelatase [EC:4.99.1.3] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC anaerobic corrin ring synthesis TRUE
+K22011 cfbA; sirohydrochlorin cobalto/nickelchelatase [EC:4.99.1.3 4.99.1.11] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC anaerobic corrin ring synthesis TRUE
+K03394 cobI-cbiL; precorrin-2/cobalt-factor-2 C20-methyltransferase [EC:2.1.1.130 2.1.1.151] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC anaerobic corrin ring synthesis TRUE
+K13540 cobIJ; precorrin-2 C20-methyltransferase / precorrin-3B C17-methyltransferase [EC:2.1.1.130 2.1.1.131] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC anaerobic corrin ring synthesis TRUE
+K05934 "E2.1.1.131, cobJ, cbiH; precorrin-3B C17-methyltransferase [EC:2.1.1.131]" "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC anaerobic corrin ring synthesis TRUE
+K13540 cobIJ; precorrin-2 C20-methyltransferase / precorrin-3B C17-methyltransferase [EC:2.1.1.130 2.1.1.131] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC anaerobic corrin ring synthesis TRUE
+K13541 cbiGH-cobJ; cobalt-precorrin 5A hydrolase / precorrin-3B C17-methyltransferase [EC:3.7.1.12 2.1.1.131] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC anaerobic corrin ring synthesis TRUE
+K21479 cbiH60; cobalt-factor III methyltransferase [EC:2.1.1.272] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC anaerobic corrin ring synthesis TRUE
+K05936 "cobM, cbiF; precorrin-4/cobalt-precorrin-4 C11-methyltransferase [EC:2.1.1.133 2.1.1.271]" "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC anaerobic corrin ring synthesis TRUE
+K02189 cbiG; cobalt-precorrin 5A hydrolase [EC:3.7.1.12] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC anaerobic corrin ring synthesis TRUE
+K13541 cbiGH-cobJ; cobalt-precorrin 5A hydrolase / precorrin-3B C17-methyltransferase [EC:3.7.1.12 2.1.1.131] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC anaerobic corrin ring synthesis TRUE
+K02188 cbiD; cobalt-precorrin-5B (C1)-methyltransferase [EC:2.1.1.195] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC anaerobic corrin ring synthesis TRUE
+K05895 cobK-cbiJ; precorrin-6A/cobalt-precorrin-6A reductase [EC:1.3.1.54 1.3.1.106] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC anaerobic corrin ring synthesis TRUE
+K02191 cbiT; cobalt-precorrin-6B (C15)-methyltransferase [EC:2.1.1.196] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC anaerobic corrin ring synthesis TRUE
+K03399 cbiE; cobalt-precorrin-7 (C5)-methyltransferase [EC:2.1.1.289] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC anaerobic corrin ring synthesis TRUE
+K06042 cobH-cbiC; precorrin-8X/cobalt-precorrin-8 methylmutase [EC:5.4.99.61 5.4.99.60] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC anaerobic corrin ring synthesis TRUE
+K02224 "cobB-cbiA; cobyrinic acid a,c-diamide synthase [EC:6.3.5.9 6.3.5.11]" "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC anaerobic corrin ring synthesis TRUE
+K00931 glutamate 5-kinase [EC:2.7.2.11] [RN:R00239] "Proline biosynthesis, glutamate => proline" Organic Nitrogen Amino Acid TRUE
+K00147 glutamate-5-semialdehyde dehydrogenase [EC:1.2.1.41] [RN:R03313] "Proline biosynthesis, glutamate => proline" Organic Nitrogen Amino Acid TRUE
+K12657 delta-1-pyrroline-5-carboxylate synthetase [EC:2.7.2.11 1.2.1.41] [RN:R00239 R03313] "Proline biosynthesis, glutamate => proline" Organic Nitrogen Amino Acid TRUE
+K00286 pyrroline-5-carboxylate reductase [EC:1.5.1.2] [RN:R01251] "Proline biosynthesis, glutamate => proline" Organic Nitrogen Amino Acid TRUE
+K00928 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K12524 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K12525 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K12526 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K00133 aspartate-semialdehyde dehydrogenase [EC:1.2.1.11] [RN:R02291] "Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K01714 4-hydroxy-tetrahydrodipicolinate synthase [EC:4.3.3.7] [RN:R10147] "Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K00215 4-hydroxy-tetrahydrodipicolinate reductase [EC:1.17.1.8] [RN:R04198 R04199] "Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K00674 "2,3,4,5-tetrahydropyridine-2-carboxylate N-succinyltransferase [EC:2.3.1.117] [RN:R04365]" "Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K00821 N-succinyldiaminopimelate aminotransferase [EC:2.6.1.17] [RN:R04475] "Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K14267 N-succinyldiaminopimelate aminotransferase [EC:2.6.1.17] [RN:R04475] "Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K01439 succinyl-diaminopimelate desuccinylase [EC:3.5.1.18] [RN:R02734] "Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K01778 diaminopimelate epimerase [EC:5.1.1.7] [RN:R02735] "Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K01586 diaminopimelate decarboxylase [EC:4.1.1.20] [RN:R00451] "Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K00928 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Methionine biosynthesis, apartate => homoserine => methionine" Organic Nitrogen Amino Acid TRUE
+K12524 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Methionine biosynthesis, apartate => homoserine => methionine" Organic Nitrogen Amino Acid TRUE
+K12525 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Methionine biosynthesis, apartate => homoserine => methionine" Organic Nitrogen Amino Acid TRUE
+K12526 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Methionine biosynthesis, apartate => homoserine => methionine" Organic Nitrogen Amino Acid TRUE
+K00133 aspartate-semialdehyde dehydrogenase [EC:1.2.1.11] [RN:R02291] "Methionine biosynthesis, apartate => homoserine => methionine" Organic Nitrogen Amino Acid TRUE
+K00003 homoserine dehydrogenase [EC:1.1.1.3] [RN:R01773 R01775] "Methionine biosynthesis, apartate => homoserine => methionine" Organic Nitrogen Amino Acid TRUE
+K00651 homoserine O-succinyltransferase [EC:2.3.1.46] [RN:R01777] "Methionine biosynthesis, apartate => homoserine => methionine" Organic Nitrogen Amino Acid TRUE
+K01739 cystathionine gamma-synthase [EC:2.5.1.48] [RN:R03260] "Methionine biosynthesis, apartate => homoserine => methionine" Organic Nitrogen Amino Acid TRUE
+K01760 cystathionine beta-lyase [EC:4.4.1.8] [RN:R01286] "Methionine biosynthesis, apartate => homoserine => methionine" Organic Nitrogen Amino Acid TRUE
+K00548 methionine synthase [EC:2.1.1.13 2.1.1.14] [RN:R00946 R04405] "Methionine biosynthesis, apartate => homoserine => methionine" Organic Nitrogen Amino Acid TRUE
+K00549 methionine synthase [EC:2.1.1.13 2.1.1.14] [RN:R00946 R04405] "Methionine biosynthesis, apartate => homoserine => methionine" Organic Nitrogen Amino Acid TRUE
+K00928 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Threonine biosynthesis, aspartate => homoserine => threonine" Organic Nitrogen Amino Acid TRUE
+K12524 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Threonine biosynthesis, aspartate => homoserine => threonine" Organic Nitrogen Amino Acid TRUE
+K12525 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Threonine biosynthesis, aspartate => homoserine => threonine" Organic Nitrogen Amino Acid TRUE
+K12526 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Threonine biosynthesis, aspartate => homoserine => threonine" Organic Nitrogen Amino Acid TRUE
+K00133 aspartate-semialdehyde dehydrogenase [EC:1.2.1.11] [RN:R02291] "Threonine biosynthesis, aspartate => homoserine => threonine" Organic Nitrogen Amino Acid TRUE
+K00003 homoserine dehydrogenase [EC:1.1.1.3] [RN:R01773 R01775] "Threonine biosynthesis, aspartate => homoserine => threonine" Organic Nitrogen Amino Acid TRUE
+K00872 homoserine kinase [EC:2.7.1.39] [RN:R01771] "Threonine biosynthesis, aspartate => homoserine => threonine" Organic Nitrogen Amino Acid TRUE
+K02204 homoserine kinase [EC:2.7.1.39] [RN:R01771] "Threonine biosynthesis, aspartate => homoserine => threonine" Organic Nitrogen Amino Acid TRUE
+K02203 homoserine kinase [EC:2.7.1.39] [RN:R01771] "Threonine biosynthesis, aspartate => homoserine => threonine" Organic Nitrogen Amino Acid TRUE
+K01733 threonine synthase [EC:4.2.3.1] [RN:R01466] "Threonine biosynthesis, aspartate => homoserine => threonine" Organic Nitrogen Amino Acid TRUE
+K01652 acetolactate synthase [EC:2.2.1.6] [RN:R00226 R08648] "Valine/isoleucine biosynthesis, pyruvate => valine / 2-oxobutanoate => isoleucine" Organic Nitrogen Amino Acid TRUE
+K01653 acetolactate synthase [EC:2.2.1.6] [RN:R00226 R08648] "Valine/isoleucine biosynthesis, pyruvate => valine / 2-oxobutanoate => isoleucine" Organic Nitrogen Amino Acid TRUE
+K11258 acetolactate synthase [EC:2.2.1.6] [RN:R00226 R08648] "Valine/isoleucine biosynthesis, pyruvate => valine / 2-oxobutanoate => isoleucine" Organic Nitrogen Amino Acid TRUE
+K00053 ketol-acid reductoisomerase [EC:1.1.1.86] [RN:R05071 R04440 R04439 R05069 R05068] "Valine/isoleucine biosynthesis, pyruvate => valine / 2-oxobutanoate => isoleucine" Organic Nitrogen Amino Acid TRUE
+K01687 dihydroxy-acid dehydratase [EC:4.2.1.9] [RN:R04441 R05070] "Valine/isoleucine biosynthesis, pyruvate => valine / 2-oxobutanoate => isoleucine" Organic Nitrogen Amino Acid TRUE
+K00826 branched-chain amino acid aminotransferase [EC:2.6.1.42] [RN:R01214 R02199] "Valine/isoleucine biosynthesis, pyruvate => valine / 2-oxobutanoate => isoleucine" Organic Nitrogen Amino Acid TRUE
+K00058 D-3-phosphoglycerate dehydrogenase [EC:1.1.1.95] [RN:R01513] "Serine biosynthesis, glycerate-3P => serine" Organic Nitrogen Amino Acid TRUE
+K00831 phosphoserine aminotransferase [EC:2.6.1.52] [RN:R04173] "Serine biosynthesis, glycerate-3P => serine" Organic Nitrogen Amino Acid TRUE
+K01079 phosphoserine phosphatase [EC:3.1.3.3] [RN:R00582] "Serine biosynthesis, glycerate-3P => serine" Organic Nitrogen Amino Acid TRUE
+K00640 serine O-acetyltransferase [EC:2.3.1.30] [RN:R00586] "Cysteine biosynthesis, serine => cysteine" Organic Nitrogen Amino Acid TRUE
+K01738 cysteine synthase [EC:2.5.1.47] [RN:R00897] "Cysteine biosynthesis, serine => cysteine" Organic Nitrogen Amino Acid TRUE
+K13034 cysteine synthase [EC:2.5.1.47] [RN:R00897] "Cysteine biosynthesis, serine => cysteine" Organic Nitrogen Amino Acid TRUE
+K17069 cysteine synthase [EC:2.5.1.47] [RN:R00897] "Cysteine biosynthesis, serine => cysteine" Organic Nitrogen Amino Acid TRUE
+K01626 3-deoxy-7-phosphoheptulonate synthase [EC:2.5.1.54] [RN:R01826] "Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate" Organic Nitrogen Amino Acid TRUE
+K03856 3-deoxy-7-phosphoheptulonate synthase [EC:2.5.1.54] [RN:R01826] "Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate" Organic Nitrogen Amino Acid TRUE
+K13853 3-deoxy-7-phosphoheptulonate synthase [EC:2.5.1.54] [RN:R01826] "Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate" Organic Nitrogen Amino Acid TRUE
+K01735 3-dehydroquinate synthase [EC:4.2.3.4] [RN:R03083] "Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate" Organic Nitrogen Amino Acid TRUE
+K13829 3-dehydroquinate synthase [EC:4.2.3.4] [RN:R03083] "Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate" Organic Nitrogen Amino Acid TRUE
+K03785 3-dehydroquinate dehydratase [EC:4.2.1.10] [RN:R03084] "Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate" Organic Nitrogen Amino Acid TRUE
+K03786 3-dehydroquinate dehydratase [EC:4.2.1.10] [RN:R03084] "Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate" Organic Nitrogen Amino Acid TRUE
+K00014 shikimate 5-dehydrogenase [EC:1.1.1.25] [RN:R02413] "Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate" Organic Nitrogen Amino Acid TRUE
+K13832 3-dehydroquinate dehydratase [EC:4.2.1.10] [RN:R03084] "Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate" Organic Nitrogen Amino Acid TRUE
+K13830 3-dehydroquinate synthase [EC:4.2.3.4] [RN:R03083] "Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate" Organic Nitrogen Amino Acid TRUE
+K00891 shikimate kinase [EC:2.7.1.71] [RN:R02412] "Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate" Organic Nitrogen Amino Acid TRUE
+K00800 3-phosphoshikimate 1-carboxyvinyltransferase [EC:2.5.1.19] [RN:R03460] "Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate" Organic Nitrogen Amino Acid TRUE
+K01736 chorismate synthase [EC:4.2.3.5] [RN:R01714] "Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate" Organic Nitrogen Amino Acid TRUE
+K01657 anthranilate synthase [EC:4.1.3.27] [RN:R00985 R00986] "Tryptophan biosynthesis, chorismate => tryptophan" Organic Nitrogen Amino Acid TRUE
+K01658 anthranilate synthase [EC:4.1.3.27] [RN:R00985 R00986] "Tryptophan biosynthesis, chorismate => tryptophan" Organic Nitrogen Amino Acid TRUE
+K13503 anthranilate synthase [EC:4.1.3.27] [RN:R00985 R00986] "Tryptophan biosynthesis, chorismate => tryptophan" Organic Nitrogen Amino Acid TRUE
+K13501 anthranilate synthase [EC:4.1.3.27] [RN:R00985 R00986] "Tryptophan biosynthesis, chorismate => tryptophan" Organic Nitrogen Amino Acid TRUE
+K01656 anthranilate synthase [EC:4.1.3.27] [RN:R00985 R00986] "Tryptophan biosynthesis, chorismate => tryptophan" Organic Nitrogen Amino Acid TRUE
+K00766 anthranilate phosphoribosyltransferase [EC:2.4.2.18] [RN:R01073] "Tryptophan biosynthesis, chorismate => tryptophan" Organic Nitrogen Amino Acid TRUE
+K13497 anthranilate synthase [EC:4.1.3.27] [RN:R00985 R00986] "Tryptophan biosynthesis, chorismate => tryptophan" Organic Nitrogen Amino Acid TRUE
+K01817 phosphoribosylanthranilate isomerase [EC:5.3.1.24] [RN:R03509] "Tryptophan biosynthesis, chorismate => tryptophan" Organic Nitrogen Amino Acid TRUE
+K01609 indole-3-glycerol phosphate synthase [EC:4.1.1.48] [RN:R03508] "Tryptophan biosynthesis, chorismate => tryptophan" Organic Nitrogen Amino Acid TRUE
+K13498 phosphoribosylanthranilate isomerase [EC:5.3.1.24] [RN:R03509] "Tryptophan biosynthesis, chorismate => tryptophan" Organic Nitrogen Amino Acid TRUE
+K01695 tryptophan synthase [EC:4.2.1.20] [RN:R02722] "Tryptophan biosynthesis, chorismate => tryptophan" Organic Nitrogen Amino Acid TRUE
+K01696 tryptophan synthase [EC:4.2.1.20] [RN:R02722] "Tryptophan biosynthesis, chorismate => tryptophan" Organic Nitrogen Amino Acid TRUE
+K06001 tryptophan synthase [EC:4.2.1.20] [RN:R02722] "Tryptophan biosynthesis, chorismate => tryptophan" Organic Nitrogen Amino Acid TRUE
+K01694 tryptophan synthase [EC:4.2.1.20] [RN:R02722] "Tryptophan biosynthesis, chorismate => tryptophan" Organic Nitrogen Amino Acid TRUE
+K01850 chorismate mutase [EC:5.4.99.5] [RN:R01715] "Phenylalanine biosynthesis, chorismate => phenylalanine" Organic Nitrogen Amino Acid TRUE
+K04092 chorismate mutase [EC:5.4.99.5] [RN:R01715] "Phenylalanine biosynthesis, chorismate => phenylalanine" Organic Nitrogen Amino Acid TRUE
+K14187 chorismate mutase [EC:5.4.99.5] [RN:R01715] "Phenylalanine biosynthesis, chorismate => phenylalanine" Organic Nitrogen Amino Acid TRUE
+K04093 chorismate mutase [EC:5.4.99.5] [RN:R01715] "Phenylalanine biosynthesis, chorismate => phenylalanine" Organic Nitrogen Amino Acid TRUE
+K04516 chorismate mutase [EC:5.4.99.5] [RN:R01715] "Phenylalanine biosynthesis, chorismate => phenylalanine" Organic Nitrogen Amino Acid TRUE
+K06208 chorismate mutase [EC:5.4.99.5] [RN:R01715] "Phenylalanine biosynthesis, chorismate => phenylalanine" Organic Nitrogen Amino Acid TRUE
+K06209 chorismate mutase [EC:5.4.99.5] [RN:R01715] "Phenylalanine biosynthesis, chorismate => phenylalanine" Organic Nitrogen Amino Acid TRUE
+K13853 chorismate mutase [EC:5.4.99.5] [RN:R01715] "Phenylalanine biosynthesis, chorismate => phenylalanine" Organic Nitrogen Amino Acid TRUE
+K01713 prephenate dehydratase [EC:4.2.1.51] [RN:R01373] "Phenylalanine biosynthesis, chorismate => phenylalanine" Organic Nitrogen Amino Acid TRUE
+K04518 prephenate dehydratase [EC:4.2.1.51] [RN:R01373] "Phenylalanine biosynthesis, chorismate => phenylalanine" Organic Nitrogen Amino Acid TRUE
+K05359 prephenate dehydratase [EC:4.2.1.51] [RN:R01373] "Phenylalanine biosynthesis, chorismate => phenylalanine" Organic Nitrogen Amino Acid TRUE
+K14170 chorismate mutase [EC:5.4.99.5] [RN:R01715] "Phenylalanine biosynthesis, chorismate => phenylalanine" Organic Nitrogen Amino Acid TRUE
+K00832 aromatic-amino-acid transaminase [EC:2.6.1.57] [RN:R00694] "Phenylalanine biosynthesis, chorismate => phenylalanine" Organic Nitrogen Amino Acid TRUE
+K00838 aromatic-amino-acid transaminase [EC:2.6.1.57] [RN:R00694] "Phenylalanine biosynthesis, chorismate => phenylalanine" Organic Nitrogen Amino Acid TRUE
+K01850 chorismate mutase [EC:5.4.99.5] [RN:R01715] "Tyrosine biosynthesis, chorismate => tyrosine" Organic Nitrogen Amino Acid TRUE
+K04092 chorismate mutase [EC:5.4.99.5] [RN:R01715] "Tyrosine biosynthesis, chorismate => tyrosine" Organic Nitrogen Amino Acid TRUE
+K14170 chorismate mutase [EC:5.4.99.5] [RN:R01715] "Tyrosine biosynthesis, chorismate => tyrosine" Organic Nitrogen Amino Acid TRUE
+K04093 chorismate mutase [EC:5.4.99.5] [RN:R01715] "Tyrosine biosynthesis, chorismate => tyrosine" Organic Nitrogen Amino Acid TRUE
+K04516 chorismate mutase [EC:5.4.99.5] [RN:R01715] "Tyrosine biosynthesis, chorismate => tyrosine" Organic Nitrogen Amino Acid TRUE
+K06208 chorismate mutase [EC:5.4.99.5] [RN:R01715] "Tyrosine biosynthesis, chorismate => tyrosine" Organic Nitrogen Amino Acid TRUE
+K06209 chorismate mutase [EC:5.4.99.5] [RN:R01715] "Tyrosine biosynthesis, chorismate => tyrosine" Organic Nitrogen Amino Acid TRUE
+K13853 chorismate mutase [EC:5.4.99.5] [RN:R01715] "Tyrosine biosynthesis, chorismate => tyrosine" Organic Nitrogen Amino Acid TRUE
+K00210 prephenate dehydrogenase [EC:1.3.1.12] [RN:R01728] "Tyrosine biosynthesis, chorismate => tyrosine" Organic Nitrogen Amino Acid TRUE
+K04517 prephenate dehydrogenase [EC:1.3.1.12] [RN:R01728] "Tyrosine biosynthesis, chorismate => tyrosine" Organic Nitrogen Amino Acid TRUE
+K14187 chorismate mutase [EC:5.4.99.5] [RN:R01715] "Tyrosine biosynthesis, chorismate => tyrosine" Organic Nitrogen Amino Acid TRUE
+K00815 tyrosine aminotransferase [EC:2.6.1.5] [RN:R00734] "Tyrosine biosynthesis, chorismate => tyrosine" Organic Nitrogen Amino Acid TRUE
+K00832 aromatic-amino-acid transaminase [EC:2.6.1.57] [RN:R00734] "Tyrosine biosynthesis, chorismate => tyrosine" Organic Nitrogen Amino Acid TRUE
+K00838 aromatic-amino-acid transaminase [EC:2.6.1.57] [RN:R00734] "Tyrosine biosynthesis, chorismate => tyrosine" Organic Nitrogen Amino Acid TRUE
+K00765 ATP phosphoribosyltransferase [EC:2.4.2.17] [RN:R01071] "Histidine biosynthesis, PRPP => histidine" Organic Nitrogen Amino Acid TRUE
+K02502 ATP phosphoribosyltransferase [EC:2.4.2.17] [RN:R01071] "Histidine biosynthesis, PRPP => histidine" Organic Nitrogen Amino Acid TRUE
+K01523 phosphoribosyl-ATP pyrophosphohydrolase [EC:3.6.1.31] [RN:R04035] "Histidine biosynthesis, PRPP => histidine" Organic Nitrogen Amino Acid TRUE
+K01496 phosphoribosyl-AMP cyclohydrolase [EC:3.5.4.19] [RN:R04037] "Histidine biosynthesis, PRPP => histidine" Organic Nitrogen Amino Acid TRUE
+K11755 phosphoribosyl-ATP pyrophosphohydrolase [EC:3.6.1.31] [RN:R04035] "Histidine biosynthesis, PRPP => histidine" Organic Nitrogen Amino Acid TRUE
+K14152 phosphoribosyl-ATP pyrophosphohydrolase [EC:3.6.1.31] [RN:R04035] "Histidine biosynthesis, PRPP => histidine" Organic Nitrogen Amino Acid TRUE
+K01814 phosphoribosylformimino-5-aminoimidazole carboxamide ribotide isomerase [EC:5.3.1.16] [RN:R04640] "Histidine biosynthesis, PRPP => histidine" Organic Nitrogen Amino Acid TRUE
+K02501 imidazole glycerol-phosphate synthase [EC:4.3.2.10] [RN:R04558] "Histidine biosynthesis, PRPP => histidine" Organic Nitrogen Amino Acid TRUE
+K02500 imidazole glycerol-phosphate synthase [EC:4.3.2.10] [RN:R04558] "Histidine biosynthesis, PRPP => histidine" Organic Nitrogen Amino Acid TRUE
+K01663 imidazole glycerol-phosphate synthase [EC:4.3.2.10] [RN:R04558] "Histidine biosynthesis, PRPP => histidine" Organic Nitrogen Amino Acid TRUE
+K01693 imidazoleglycerol-phosphate dehydratase [EC:4.2.1.19] [RN:R03457] "Histidine biosynthesis, PRPP => histidine" Organic Nitrogen Amino Acid TRUE
+K00817 histidinol-phosphate aminotransferase [EC:2.6.1.9] [RN:R03243] "Histidine biosynthesis, PRPP => histidine" Organic Nitrogen Amino Acid TRUE
+K04486 histidinol-phosphatase [EC:3.1.3.15] [RN:R03013] "Histidine biosynthesis, PRPP => histidine" Organic Nitrogen Amino Acid TRUE
+K05602 histidinol-phosphatase [EC:3.1.3.15] [RN:R03013] "Histidine biosynthesis, PRPP => histidine" Organic Nitrogen Amino Acid TRUE
+K18649 histidinol-phosphatase [EC:3.1.3.15] [RN:R03013] "Histidine biosynthesis, PRPP => histidine" Organic Nitrogen Amino Acid TRUE
+K01089 imidazoleglycerol-phosphate dehydratase / histidinol-phosphatase [EC:4.2.1.19 3.1.3.15] [RN:R03457 R03013] "Histidine biosynthesis, PRPP => histidine" Organic Nitrogen Amino Acid TRUE
+K00013 histidinol dehydrogenase [EC:1.1.1.23] [RN:R03012 R01163] "Histidine biosynthesis, PRPP => histidine" Organic Nitrogen Amino Acid TRUE
+K00618 amino-acid N-acetyltransferase [EC:2.3.1.1] [RN:R00259] "Ornithine biosynthesis, glutamate => ornithine" Organic Nitrogen Amino Acid TRUE
+K00619 amino-acid N-acetyltransferase [EC:2.3.1.1] [RN:R00259] "Ornithine biosynthesis, glutamate => ornithine" Organic Nitrogen Amino Acid TRUE
+K14681 amino-acid N-acetyltransferase [EC:2.3.1.1] [RN:R00259] "Ornithine biosynthesis, glutamate => ornithine" Organic Nitrogen Amino Acid TRUE
+K14682 amino-acid N-acetyltransferase [EC:2.3.1.1] [RN:R00259] "Ornithine biosynthesis, glutamate => ornithine" Organic Nitrogen Amino Acid TRUE
+K00620 glutamate N-acetyltransferase / amino-acid N-acetyltransferase [EC:2.3.1.35 2.3.1.1] [RN:R00259 R02282] "Ornithine biosynthesis, glutamate => ornithine" Organic Nitrogen Amino Acid TRUE
+K22477 amino-acid N-acetyltransferase [EC:2.3.1.1] [RN:R00259] "Ornithine biosynthesis, glutamate => ornithine" Organic Nitrogen Amino Acid TRUE
+K22478 bifunctional N-acetylglutamate synthase/kinase [EC:2.3.1.1 2.7.2.8] [RN:R00259 R02649] "Ornithine biosynthesis, glutamate => ornithine" Organic Nitrogen Amino Acid TRUE
+K00930 acetylglutamate kinase [EC:2.7.2.8] [RN:R02649] "Ornithine biosynthesis, glutamate => ornithine" Organic Nitrogen Amino Acid TRUE
+K00145 N-acetyl-gamma-glutamyl-phosphate reductase [EC:1.2.1.38] [RN:R03443] "Ornithine biosynthesis, glutamate => ornithine" Organic Nitrogen Amino Acid TRUE
+K12659 N-acetyl-gamma-glutamyl-phosphate reductase / acetylglutamate kinase [EC:1.2.1.38 2.7.2.8] [RN:R02649 R03443] "Ornithine biosynthesis, glutamate => ornithine" Organic Nitrogen Amino Acid TRUE
+K00818 acetylornithine aminotransferase [EC:2.6.1.11] [RN:R02283] "Ornithine biosynthesis, glutamate => ornithine" Organic Nitrogen Amino Acid TRUE
+K00821 acetylornithine aminotransferase [EC:2.6.1.11] [RN:R02283] "Ornithine biosynthesis, glutamate => ornithine" Organic Nitrogen Amino Acid TRUE
+K01438 acetylornithine deacetylase [EC:3.5.1.16] [RN:R00669] "Ornithine biosynthesis, glutamate => ornithine" Organic Nitrogen Amino Acid TRUE
+K14677 aminoacylase [EC:3.5.1.14] [RN:R00669] "Ornithine biosynthesis, glutamate => ornithine" Organic Nitrogen Amino Acid TRUE
+K01948 carbamoyl-phosphate synthase (ammonia) [EC:6.3.4.16] [RN:R00149] Urea cycle Organic Nitrogen Amino Acid TRUE
+K00611 ornithine carbamoyltransferase [EC:2.1.3.3] [RN:R01398] Urea cycle Organic Nitrogen Amino Acid TRUE
+K01940 argininosuccinate synthase [EC:6.3.4.5] [RN:R01954] Urea cycle Organic Nitrogen Amino Acid TRUE
+K01755 argininosuccinate lyase [EC:4.3.2.1] [RN:R01086] Urea cycle Organic Nitrogen Amino Acid TRUE
+K14681 argininosuccinate lyase [EC:4.3.2.1] [RN:R01086] Urea cycle Organic Nitrogen Amino Acid TRUE
+K01476 arginase [EC:3.5.3.1] [RN:R00551] Urea cycle Organic Nitrogen Amino Acid TRUE
+K01655 homocitrate synthase [EC:2.3.3.14] [RN:R00271] "Lysine biosynthesis, AAA pathway, 2-oxoglutarate => 2-aminoadipate => lysine" Organic Nitrogen Amino Acid TRUE
+K17450 homoaconitase [EC:4.2.1.-] [RN:R03444] "Lysine biosynthesis, AAA pathway, 2-oxoglutarate => 2-aminoadipate => lysine" Organic Nitrogen Amino Acid TRUE
+K01705 homoaconitate hydratase [EC:4.2.1.36] [RN:R04371] "Lysine biosynthesis, AAA pathway, 2-oxoglutarate => 2-aminoadipate => lysine" Organic Nitrogen Amino Acid TRUE
+K05824 homoisocitrate dehydrogenase [EC:1.1.1.87] [RN:R01934] "Lysine biosynthesis, AAA pathway, 2-oxoglutarate => 2-aminoadipate => lysine" Organic Nitrogen Amino Acid TRUE
+K00838 2-aminoadipate transaminase [EC:2.6.1.39] [RN:R01939] "Lysine biosynthesis, AAA pathway, 2-oxoglutarate => 2-aminoadipate => lysine" Organic Nitrogen Amino Acid TRUE
+K00143 L-2-aminoadipate reductase [EC:1.2.1.95] [RN:R03098 R04863 R04390] "Lysine biosynthesis, AAA pathway, 2-oxoglutarate => 2-aminoadipate => lysine" Organic Nitrogen Amino Acid TRUE
+K00293 "saccharopine dehydrogenase (NADP+, L-glutamate forming) [EC:1.5.1.10] [RN:R02315]" "Lysine biosynthesis, AAA pathway, 2-oxoglutarate => 2-aminoadipate => lysine" Organic Nitrogen Amino Acid TRUE
+K00290 "saccharopine dehydrogenase, L-lysine forming [EC:1.5.1.7] [RN:R00715]" "Lysine biosynthesis, AAA pathway, 2-oxoglutarate => 2-aminoadipate => lysine" Organic Nitrogen Amino Acid TRUE
+K05827 [lysine-biosynthesis-protein LysW]---L-2-aminoadipate ligase [EC:6.3.2.43] [RN:R09775] "Lysine biosynthesis, mediated by LysW, 2-aminoadipate => lysine" Organic Nitrogen Amino Acid TRUE
+K05828 LysW-gamma-L-alpha-aminoadipate kinase [EC:2.7.2.-] [RN:R09776] "Lysine biosynthesis, mediated by LysW, 2-aminoadipate => lysine" Organic Nitrogen Amino Acid TRUE
+K05829 LysW-gamma-L-alpha-aminoadipyl-6-phosphate reductase [EC:1.2.1.-] [RN:R09777] "Lysine biosynthesis, mediated by LysW, 2-aminoadipate => lysine" Organic Nitrogen Amino Acid TRUE
+K05830 LysW-gamma-L-lysine aminotransferase [EC:2.6.1.-] [RN:R09778] "Lysine biosynthesis, mediated by LysW, 2-aminoadipate => lysine" Organic Nitrogen Amino Acid TRUE
+K05831 LysW-gamma-L-lysine carboxypeptidase [RN:R09779] "Lysine biosynthesis, mediated by LysW, 2-aminoadipate => lysine" Organic Nitrogen Amino Acid TRUE
+K00290 saccharopine dehydrogenase [EC:1.5.1.7] [RN:R00715] "Lysine degradation, lysine => saccharopine => acetoacetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K00293 saccharopine dehydrogenase [EC:1.5.1.10] [RN:R02315] "Lysine degradation, lysine => saccharopine => acetoacetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K14157 alpha-aminoadipic semialdehyde synthase [EC:1.5.1.8 1.5.1.9] [RN:R00716 R02313] "Lysine degradation, lysine => saccharopine => acetoacetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K14085 aminoadipate-semialdehyde dehydrogenase [EC:1.2.1.31] [RN:R03102 R03103] "Lysine degradation, lysine => saccharopine => acetoacetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K00825 2-aminoadipate transaminase [EC:2.6.1.39] [RN:R01939] "Lysine degradation, lysine => saccharopine => acetoacetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K15791 probable 2-oxoglutarate dehydrogenase E1 component DHKTD1 [EC:1.2.4.2] [RN:R01933] "Lysine degradation, lysine => saccharopine => acetoacetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K00658 2-oxoglutarate dehydrogenase E2 component (dihydrolipoamide [EC:2.3.1.61] [RN:R01933] "Lysine degradation, lysine => saccharopine => acetoacetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K00382 dihydrolipoamide dehydrogenase [EC:1.8.1.4] [RN:R01933] "Lysine degradation, lysine => saccharopine => acetoacetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K00252 glutaryl-CoA dehydrogenase [EC:1.3.8.6] [RN:R02488] "Lysine degradation, lysine => saccharopine => acetoacetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K01825 enoyl-CoA hydratase / 3-hydroxyacyl-CoA dehydrogenase [EC:4.2.1.17 1.1.1.35] [RN:R03026 R01975] "Lysine degradation, lysine => saccharopine => acetoacetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K01782 enoyl-CoA hydratase / 3-hydroxyacyl-CoA dehydrogenase [EC:4.2.1.17 1.1.1.35] [RN:R03026 R01975] "Lysine degradation, lysine => saccharopine => acetoacetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K07514 enoyl-CoA hydratase / 3-hydroxyacyl-CoA dehydrogenase [EC:4.2.1.17 1.1.1.35] [RN:R03026 R01975] "Lysine degradation, lysine => saccharopine => acetoacetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K01692 enoyl-CoA hydratase [EC:4.2.1.17] [RN:R03026] "Lysine degradation, lysine => saccharopine => acetoacetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K07515 enoyl-CoA hydratase [EC:4.2.1.17] [RN:R03026] "Lysine degradation, lysine => saccharopine => acetoacetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K07511 enoyl-CoA hydratase [EC:4.2.1.17] [RN:R03026] "Lysine degradation, lysine => saccharopine => acetoacetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K00022 3-hydroxyacyl-CoA dehydrogenase [EC:1.1.1.35] [RN:R01975] "Lysine degradation, lysine => saccharopine => acetoacetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K00789 S-adenosylmethionine synthetase [EC:2.5.1.6] [RN:R00177] Methionine degradation Organic Nitrogen Amino Acid TRUE
+K00558 DNA (cytosine-5-)-methyltransferase [EC:2.1.1.37] [RN:R04858] Methionine degradation Organic Nitrogen Amino Acid TRUE
+K17398 DNA (cytosine-5-)-methyltransferase [EC:2.1.1.37] [RN:R04858] Methionine degradation Organic Nitrogen Amino Acid TRUE
+K17399 DNA (cytosine-5-)-methyltransferase [EC:2.1.1.37] [RN:R04858] Methionine degradation Organic Nitrogen Amino Acid TRUE
+K01251 adenosylhomocysteinase [EC:3.3.1.1] [RN:R00192] Methionine degradation Organic Nitrogen Amino Acid TRUE
+K01697 cystathionine beta-synthase [EC:4.2.1.22] [RN:R01290] Methionine degradation Organic Nitrogen Amino Acid TRUE
+K10150 cystathionine beta-synthase [EC:4.2.1.22] [RN:R01290] Methionine degradation Organic Nitrogen Amino Acid TRUE
+K00826 branched-chain amino acid aminotransferase [EC:2.6.1.42] [RN:R01090] "Leucine degradation, leucine => acetoacetate + acetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K00166 2-oxoisovalerate dehydrogenase [EC:1.2.4.4] [RN:R07601 R07602] "Leucine degradation, leucine => acetoacetate + acetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K00167 2-oxoisovalerate dehydrogenase [EC:1.2.4.4] [RN:R07601 R07602] "Leucine degradation, leucine => acetoacetate + acetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K11381 2-oxoisovalerate dehydrogenase [EC:1.2.4.4] [RN:R07601 R07602] "Leucine degradation, leucine => acetoacetate + acetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K09699 2-oxoisovalerate dehydrogenase [EC:2.3.1.168] [RN:R04097] "Leucine degradation, leucine => acetoacetate + acetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K00382 dihydrolipoamide dehydrogenase [EC:1.8.1.4] [RN:R07618] "Leucine degradation, leucine => acetoacetate + acetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K00253 isovaleryl-CoA dehydrogenase [EC:1.3.99.10] [RN:R04095] "Leucine degradation, leucine => acetoacetate + acetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K00249 acyl-CoA dehydrogenase [EC:1.3.8.7] [RN:R04095] "Leucine degradation, leucine => acetoacetate + acetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K01968 3-methylcrotonyl-CoA carboxylase [EC:6.4.1.4] [RN:R04138] "Leucine degradation, leucine => acetoacetate + acetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K01969 3-methylcrotonyl-CoA carboxylase [EC:6.4.1.4] [RN:R04138] "Leucine degradation, leucine => acetoacetate + acetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K05607 methylglutaconyl-CoA hydratase [EC:4.2.1.18] [RN:R02085] "Leucine degradation, leucine => acetoacetate + acetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K13766 methylglutaconyl-CoA hydratase [EC:4.2.1.18] [RN:R02085] "Leucine degradation, leucine => acetoacetate + acetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K01640 hydroxymethylglutaryl-CoA lyase [EC:4.1.3.4] [RN:R01360] "Leucine degradation, leucine => acetoacetate + acetyl-CoA" Organic Nitrogen Amino Acid TRUE
+K00832 aromatic-amino-acid transaminase [EC:2.6.1.57] [RN:R01731] "Tyrosine biosynthesis, prephanate => pretyrosine => tyrosine" Organic Nitrogen Amino Acid TRUE
+K15849 aspartate-prephenate aminotransferase [EC:2.6.1.78] [RN:R01731] "Tyrosine biosynthesis, prephanate => pretyrosine => tyrosine" Organic Nitrogen Amino Acid TRUE
+K00220 cyclohexadienyl dehydrogenase [EC:1.3.1.43] [RN:R00732] "Tyrosine biosynthesis, prephanate => pretyrosine => tyrosine" Organic Nitrogen Amino Acid TRUE
+K15226 arogenate dehydrogenase (NADP+) [EC:1.3.1.78] [RN:R00733] "Tyrosine biosynthesis, prephanate => pretyrosine => tyrosine" Organic Nitrogen Amino Acid TRUE
+K15227 arogenate dehydrogenase (NADP+) [EC:1.3.1.78] [RN:R00733] "Tyrosine biosynthesis, prephanate => pretyrosine => tyrosine" Organic Nitrogen Amino Acid TRUE
+K03334 L-amino-acid oxidase [EC:1.4.3.2] [RN:R00729] "Tyrosine degradation, tyrosine => homogentisate" Organic Nitrogen Amino Acid TRUE
+K00457 4-hydroxyphenylpyruvate dioxygenase [EC:1.13.11.27] [RN:R02521] "Tyrosine degradation, tyrosine => homogentisate" Organic Nitrogen Amino Acid TRUE
+K00451 "homogentisate 1,2-dioxygenase [EC:1.13.11.5] [RN:R02519]" "Tyrosine degradation, tyrosine => homogentisate" Organic Nitrogen Amino Acid TRUE
+K01800 maleylacetoacetate isomerase [EC:5.2.1.2] [RN:R03181] "Tyrosine degradation, tyrosine => homogentisate" Organic Nitrogen Amino Acid TRUE
+K01555 fumarylacetoacetase [EC:3.7.1.2] [RN:R01364] "Tyrosine degradation, tyrosine => homogentisate" Organic Nitrogen Amino Acid TRUE
+K16171 fumarylacetoacetate (FAA) hydrolase [EC:3.7.1.2] [RN:R01364] "Tyrosine degradation, tyrosine => homogentisate" Organic Nitrogen Amino Acid TRUE
+K01745 histidine ammonia-lyase [EC:4.3.1.3] [RN:R01168] "Histidine degradation, histidine => N-formiminoglutamate => glutamate" Organic Nitrogen Amino Acid TRUE
+K01712 urocanate hydratase [EC:4.2.1.49] [RN:R02914] "Histidine degradation, histidine => N-formiminoglutamate => glutamate" Organic Nitrogen Amino Acid TRUE
+K01468 imidazolonepropionase [EC:3.5.2.7] [RN:R02288] "Histidine degradation, histidine => N-formiminoglutamate => glutamate" Organic Nitrogen Amino Acid TRUE
+K01479 formiminoglutamase [EC:3.5.3.8] [RN:R02285] "Histidine degradation, histidine => N-formiminoglutamate => glutamate" Organic Nitrogen Amino Acid TRUE
+K00603 glutamate formiminotransferase [EC:2.1.2.5] [RN:R02287] "Histidine degradation, histidine => N-formiminoglutamate => glutamate" Organic Nitrogen Amino Acid TRUE
+K13990 glutamate formiminotransferase [EC:2.1.2.5] [RN:R02287] "Histidine degradation, histidine => N-formiminoglutamate => glutamate" Organic Nitrogen Amino Acid TRUE
+K05603 formimidoylglutamate deiminase [EC:3.5.3.13] [RN:R02286] "Histidine degradation, histidine => N-formiminoglutamate => glutamate" Organic Nitrogen Amino Acid TRUE
+K01458 N-formylglutamate deformylase [EC:3.5.1.68] [RN:R00525] "Histidine degradation, histidine => N-formiminoglutamate => glutamate" Organic Nitrogen Amino Acid TRUE
+K00207 dihydropyrimidine dehydrogenase (NADP+) [EC:1.3.1.2] [RN:R00978 R01415] "Pyrimidine degradation, uracil => beta-alanine, thymine => 3-aminoisobutanoate" Organic Nitrogen Amino Acid TRUE
+K17722 dihydropyrimidine dehydrogenase (NAD+) [EC:1.3.1.1] [RN:R00977 R11026] "Pyrimidine degradation, uracil => beta-alanine, thymine => 3-aminoisobutanoate" Organic Nitrogen Amino Acid TRUE
+K17723 dihydropyrimidine dehydrogenase (NAD+) [EC:1.3.1.1] [RN:R00977 R11026] "Pyrimidine degradation, uracil => beta-alanine, thymine => 3-aminoisobutanoate" Organic Nitrogen Amino Acid TRUE
+K01464 dihydropyrimidinase [EC:3.5.2.2] [RN:R02269 R03055] "Pyrimidine degradation, uracil => beta-alanine, thymine => 3-aminoisobutanoate" Organic Nitrogen Amino Acid TRUE
+K01431 beta-ureidopropionase [EC:3.5.1.6] [RN:R00905 R04666] "Pyrimidine degradation, uracil => beta-alanine, thymine => 3-aminoisobutanoate" Organic Nitrogen Amino Acid TRUE
+K06016 beta-ureidopropionase [EC:3.5.1.6] [RN:R00905 R04666] "Pyrimidine degradation, uracil => beta-alanine, thymine => 3-aminoisobutanoate" Organic Nitrogen Amino Acid TRUE
+K01649 2-isopropylmalate synthase [EC:2.3.3.13] [RN:R01213] "Leucine biosynthesis, 2-oxoisovalerate => 2-oxoisocaproate" Organic Nitrogen Amino Acid TRUE
+K01702 3-isopropylmalate dehydratase [EC:4.2.1.33] [RN:R03968 R04001] "Leucine biosynthesis, 2-oxoisovalerate => 2-oxoisocaproate" Organic Nitrogen Amino Acid TRUE
+K01703 3-isopropylmalate dehydratase [EC:4.2.1.33] [RN:R03968 R04001] "Leucine biosynthesis, 2-oxoisovalerate => 2-oxoisocaproate" Organic Nitrogen Amino Acid TRUE
+K01704 3-isopropylmalate dehydratase [EC:4.2.1.33] [RN:R03968 R04001] "Leucine biosynthesis, 2-oxoisovalerate => 2-oxoisocaproate" Organic Nitrogen Amino Acid TRUE
+K00052 3-isopropylmalate dehydrogenase [EC:1.1.1.85] [RN:R04426] "Leucine biosynthesis, 2-oxoisovalerate => 2-oxoisocaproate" Organic Nitrogen Amino Acid TRUE
+K01655 homocitrate synthase [EC:2.3.3.14] [RN:R00271] "Lysine biosynthesis, 2-oxoglutarate => 2-oxoadipate" Organic Nitrogen Amino Acid TRUE
+K17450 homoaconitase [EC:4.2.1.- 4.2.1.36 4.2.1.114] [RN:R03444 R04371 R09720] "Lysine biosynthesis, 2-oxoglutarate => 2-oxoadipate" Organic Nitrogen Amino Acid TRUE
+K01705 homoaconitase [EC:4.2.1.- 4.2.1.36 4.2.1.114] [RN:R03444 R04371 R09720] "Lysine biosynthesis, 2-oxoglutarate => 2-oxoadipate" Organic Nitrogen Amino Acid TRUE
+K16792 homoaconitase [EC:4.2.1.- 4.2.1.36 4.2.1.114] [RN:R03444 R04371 R09720] "Lysine biosynthesis, 2-oxoglutarate => 2-oxoadipate" Organic Nitrogen Amino Acid TRUE
+K16793 homoaconitase [EC:4.2.1.- 4.2.1.36 4.2.1.114] [RN:R03444 R04371 R09720] "Lysine biosynthesis, 2-oxoglutarate => 2-oxoadipate" Organic Nitrogen Amino Acid TRUE
+K05824 homoisocitrate dehydrogenase [EC:1.1.1.87] [RN:R01934] "Lysine biosynthesis, 2-oxoglutarate => 2-oxoadipate" Organic Nitrogen Amino Acid TRUE
+K00928 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Lysine biosynthesis, acetyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K00133 aspartate-semialdehyde dehydrogenase [EC:1.2.1.11] [RN:R02291] "Lysine biosynthesis, acetyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K01714 4-hydroxy-tetrahydrodipicolinate synthase [EC:4.3.3.7] [RN:R10147] "Lysine biosynthesis, acetyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K00215 4-hydroxy-tetrahydrodipicolinate reductase [EC:1.17.1.8] [RN:R04198 R04199] "Lysine biosynthesis, acetyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K05822 tetrahydrodipicolinate N-acetyltransferase [EC:2.3.1.89] [RN:R04364] "Lysine biosynthesis, acetyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K00841 aminotransferase [EC:2.6.1.-] [RN:R04467] "Lysine biosynthesis, acetyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K05823 N-acetyldiaminopimelate deacetylase [EC:3.5.1.47] [RN:R02733] "Lysine biosynthesis, acetyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K01778 diaminopimelate epimerase [EC:5.1.1.7] [RN:R02735] "Lysine biosynthesis, acetyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K01586 diaminopimelate decarboxylase [EC:4.1.1.20] [RN:R00451] "Lysine biosynthesis, acetyl-DAP pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K00928 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Lysine biosynthesis, DAP dehydrogenase pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K12524 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Lysine biosynthesis, DAP dehydrogenase pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K12525 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Lysine biosynthesis, DAP dehydrogenase pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K12526 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Lysine biosynthesis, DAP dehydrogenase pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K00133 aspartate-semialdehyde dehydrogenase [EC:1.2.1.11] [RN:R02291] "Lysine biosynthesis, DAP dehydrogenase pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K01714 4-hydroxy-tetrahydrodipicolinate synthase [EC:4.3.3.7] [RN:R10147] "Lysine biosynthesis, DAP dehydrogenase pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K00215 4-hydroxy-tetrahydrodipicolinate reductase [EC:1.17.1.8] [RN:R04198 R04199] "Lysine biosynthesis, DAP dehydrogenase pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K03340 diaminopimelate dehydrogenase [EC:1.4.1.16] [RN:R02755] "Lysine biosynthesis, DAP dehydrogenase pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K01586 diaminopimelate decarboxylase [EC:4.1.1.20] [RN:R00451] "Lysine biosynthesis, DAP dehydrogenase pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K00928 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K12524 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K12525 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K12526 aspartate kinase [EC:2.7.2.4] [RN:R00480] "Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K00133 aspartate-semialdehyde dehydrogenase [EC:1.2.1.11] [RN:R02291] "Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K01714 4-hydroxy-tetrahydrodipicolinate synthase [EC:4.3.3.7] [RN:R10147] "Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K00215 4-hydroxy-tetrahydrodipicolinate reductase [EC:1.17.1.8] [RN:R04198 R04199] "Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K10206 LL-diaminopimelate aminotransferase [EC:2.6.1.83] [RN:R07613] "Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K01778 diaminopimelate epimerase [EC:5.1.1.7] [RN:R02735] "Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K01586 diaminopimelate decarboxylase [EC:4.1.1.20] [RN:R00451] "Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine" Organic Nitrogen Amino Acid TRUE
+K09011 cimA; D-citramalate synthase [EC:2.3.1.182] [RN:R07399] "Isoleucine biosynthesis, pyruvate => 2-oxobutanoate" Organic Nitrogen Amino Acid TRUE
+K01703 leuCD; 3-isopropylmalate/(R)-2-methylmalate dehydratase [EC:4.2.1.33 4.2.1.35] [RN:R03896 R03898] "Isoleucine biosynthesis, pyruvate => 2-oxobutanoate" Organic Nitrogen Amino Acid TRUE
+K01704 leuCD; 3-isopropylmalate/(R)-2-methylmalate dehydratase [EC:4.2.1.33 4.2.1.35] [RN:R03896 R03898] "Isoleucine biosynthesis, pyruvate => 2-oxobutanoate" Organic Nitrogen Amino Acid TRUE
+K00052 leuB; 3-isopropylmalate dehydrogenase [EC:1.1.1.85] [RN:R00994] "Isoleucine biosynthesis, pyruvate => 2-oxobutanoate" Organic Nitrogen Amino Acid TRUE
+K17755 choline oxidase [EC:1.1.3.17] [R01022 R08211] "Betaine biosynthesis, choline => betaine" Organic Nitrogen Amino Acid TRUE
+K00108 choline dehydrogenase [EC:1.1.99.1] [RN:R01025 R08557 R08558] "Betaine biosynthesis, choline => betaine" Organic Nitrogen Amino Acid TRUE
+K11440 choline dehydrogenase [EC:1.1.99.1] [RN:R01025 R08557 R08558] "Betaine biosynthesis, choline => betaine" Organic Nitrogen Amino Acid TRUE
+K00130 betaine-aldehyde dehydrogenase [EC:1.2.1.8] [R02565 R02566] "Betaine biosynthesis, choline => betaine" Organic Nitrogen Amino Acid TRUE
+K17989 threonine dehydratase [EC:4.3.1.19] [RN:R00996] "Isoleucine biosynthesis, threonine => 2-oxobutanoate => isoleucine" Organic Nitrogen Amino Acid TRUE
+K01754 threonine dehydratase [EC:4.3.1.19] [RN:R00996] "Isoleucine biosynthesis, threonine => 2-oxobutanoate => isoleucine" Organic Nitrogen Amino Acid TRUE
+K01652 acetolactate synthase [EC:2.2.1.6] [RN:R08648] "Isoleucine biosynthesis, threonine => 2-oxobutanoate => isoleucine" Organic Nitrogen Amino Acid TRUE
+K01653 acetolactate synthase [EC:2.2.1.6] [RN:R08648] "Isoleucine biosynthesis, threonine => 2-oxobutanoate => isoleucine" Organic Nitrogen Amino Acid TRUE
+K11258 acetolactate synthase [EC:2.2.1.6] [RN:R08648] "Isoleucine biosynthesis, threonine => 2-oxobutanoate => isoleucine" Organic Nitrogen Amino Acid TRUE
+K00053 ketol-acid reductoisomerase [EC:1.1.1.86] [RN:R05069 R05068] "Isoleucine biosynthesis, threonine => 2-oxobutanoate => isoleucine" Organic Nitrogen Amino Acid TRUE
+K01687 dihydroxy-acid dehydratase [EC:4.2.1.9] [RN:R05070] "Isoleucine biosynthesis, threonine => 2-oxobutanoate => isoleucine" Organic Nitrogen Amino Acid TRUE
+K00826 branched-chain amino acid aminotransferase [EC:2.6.1.42] [RN:R02199] "Isoleucine biosynthesis, threonine => 2-oxobutanoate => isoleucine" Organic Nitrogen Amino Acid TRUE
+K01647 citrate synthase [EC:2.3.3.1] [RN:R00351] Methylaspartate cycle Organic Nitrogen Amino Acid TRUE
+K01681 aconitate hydratase [EC:4.2.1.3] [RN:R01325 R01900] Methylaspartate cycle Organic Nitrogen Amino Acid TRUE
+K00031 isocitrate dehydrogenase [EC:1.1.1.42] [RN:R01899 R00268] Methylaspartate cycle Organic Nitrogen Amino Acid TRUE
+K00261 glutamate dehydrogenase (NAD(P)+) [EC:1.4.1.3] [RN:R00248] Methylaspartate cycle Organic Nitrogen Amino Acid TRUE
+K19268 methylaspartate mutase epsilon subunit [EC:5.4.99.1] [RN:R00262] Methylaspartate cycle Organic Nitrogen Amino Acid TRUE
+K01846 methylaspartate mutase epsilon subunit [EC:5.4.99.1] [RN:R00262] Methylaspartate cycle Organic Nitrogen Amino Acid TRUE
+K04835 methylaspartate ammonia-lyase [EC:4.3.1.2] [RN:R03696] Methylaspartate cycle Organic Nitrogen Amino Acid TRUE
+K19280 succinyl-CoA:mesaconate CoA transferase [EC:2.8.3.-] [RN:R10904] Methylaspartate cycle Organic Nitrogen Amino Acid TRUE
+K14449 2-methylfumaryl-CoA hydratase [EC:4.2.1.148] [RN:R05076] Methylaspartate cycle Organic Nitrogen Amino Acid TRUE
+K19281 beta-methylmalyl-CoA/(S)-malyl-CoA lyase [EC:4.1.3.24] [RN:R00934] Methylaspartate cycle Organic Nitrogen Amino Acid TRUE
+K19282 bifunctional (S)-malyl-CoA lyase/thioesterase [EC:4.1.3.24 3.1.2.30] [RN:R00473 R10612] Methylaspartate cycle Organic Nitrogen Amino Acid TRUE
+K00024 malate dehydrogenase [EC:1.1.1.37] [RN:R00342] Methylaspartate cycle Organic Nitrogen Amino Acid TRUE
+K19412 glutamate--LysW ligase ArgX [EC:6.3.2.-] [RN:R10929] "Ornithine biosynthesis, mediated by LysW, glutamate => ornithine" Organic Nitrogen Amino Acid TRUE
+K05828 LysW-L-glutamate kinase [EC:2.7.2.-] [RN:R10930] "Ornithine biosynthesis, mediated by LysW, glutamate => ornithine" Organic Nitrogen Amino Acid TRUE
+K05829 LysW-L-glutamyl-5-phosphate reductase [EC:1.2.1.-] [RN:R10931] "Ornithine biosynthesis, mediated by LysW, glutamate => ornithine" Organic Nitrogen Amino Acid TRUE
+K05830 LysW-L-ornithine aminotransferase [EC:2.6.1.-] [RN:R10932] "Ornithine biosynthesis, mediated by LysW, glutamate => ornithine" Organic Nitrogen Amino Acid TRUE
+K05831 LysW-L-ornithine carboxypeptidase [RN:R10933] "Ornithine biosynthesis, mediated by LysW, glutamate => ornithine" Organic Nitrogen Amino Acid TRUE
+K03394 cobI-cbiL; precorrin-2/cobalt-factor-2 C20-methyltransferase [EC:2.1.1.130 2.1.1.151] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC aerobic corrin ring synthesis TRUE
+K13540 cobIJ; precorrin-2 C20-methyltransferase / precorrin-3B C17-methyltransferase [EC:2.1.1.130 2.1.1.131] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC aerobic corrin ring synthesis TRUE
+K02229 cobG; precorrin-3B synthase [EC:1.14.13.83] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC aerobic corrin ring synthesis TRUE
+K13540 cobIJ; precorrin-2 C20-methyltransferase / precorrin-3B C17-methyltransferase [EC:2.1.1.130 2.1.1.131] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC aerobic corrin ring synthesis TRUE
+K05934 "E2.1.1.131, cobJ, cbiH; precorrin-3B C17-methyltransferase [EC:2.1.1.131]" "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC aerobic corrin ring synthesis TRUE
+K13541 cbiGH-cobJ; cobalt-precorrin 5A hydrolase / precorrin-3B C17-methyltransferase [EC:3.7.1.12 2.1.1.131] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC aerobic corrin ring synthesis TRUE
+K05936 "cobM, cbiF; precorrin-4/cobalt-precorrin-4 C11-methyltransferase [EC:2.1.1.133 2.1.1.271]" "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC aerobic corrin ring synthesis TRUE
+K02228 cobF; precorrin-6A synthase [EC:2.1.1.152] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC aerobic corrin ring synthesis TRUE
+K05895 cobK-cbiJ; precorrin-6A/cobalt-precorrin-6A reductase [EC:1.3.1.54 1.3.1.106] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC aerobic corrin ring synthesis TRUE
+K00595 "cobL; precorrin-6Y C5,15-methyltransferase (decarboxylating) [EC:2.1.1.132]" "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC aerobic corrin ring synthesis TRUE
+K06042 cobH-cbiC; precorrin-8X/cobalt-precorrin-8 methylmutase [EC:5.4.99.61 5.4.99.60] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC aerobic corrin ring synthesis TRUE
+K02224 "cobB-cbiA; cobyrinic acid a,c-diamide synthase [EC:6.3.5.9 6.3.5.11]" "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC aerobic corrin ring synthesis TRUE
+K02230 cobN; cobaltochelatase CobN [EC:6.6.1.2] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC aerobic corrin ring synthesis TRUE
+K09882 cobS; cobaltochelatase CobS [EC:6.6.1.2] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC aerobic corrin ring synthesis TRUE
+K09883 cobT; cobaltochelatase CobT [EC:6.6.1.2] "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC aerobic corrin ring synthesis TRUE
+K13786 "cobR; cob(II)yrinic acid a,c-diamide reductase [EC:1.16.8.1]" "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC ADO-CBL synthesis TRUE
+K00798 "MMAB, pduO; cob(I)alamin adenosyltransferase [EC:2.5.1.17]" "Cobalamin biosynthesis, cobinamide => cobalamin" MISC ADO-CBL synthesis TRUE
+K19221 "cobA, btuR; cob(I)alamin adenosyltransferase [EC:2.5.1.17]" "Cobalamin biosynthesis, cobinamide => cobalamin" MISC ADO-CBL synthesis TRUE
+K02232 "cobQ, cbiP; adenosylcobyric acid synthase [EC:6.3.5.10]" "Cobalamin biosynthesis, cobinamide => cobalamin" MISC ADO-CBL synthesis TRUE
+K02225 "cobC1, cobC; cobalamin biosynthetic protein" "Cobalamin biosynthesis, cobinamide => cobalamin" MISC ADO-CBL synthesis TRUE
+K02227 "cbiB, cobD; adenosylcobinamide-phosphate synthase [EC:6.3.1.10]" "Cobalamin biosynthesis, cobinamide => cobalamin" MISC ADO-CBL synthesis TRUE
+K02227 "cbiB, cobD; adenosylcobinamide-phosphate synthase [EC:6.3.1.10]" "Cobalamin biosynthesis, cobinamide => cobalamin" MISC ADO-CBL synthesis TRUE
+K02231 "cobP, cobU; adenosylcobinamide kinase / adenosylcobinamide-phosphate guanylyltransferase [EC:2.7.1.156 2.7.7.62]" "Cobalamin biosynthesis, cobinamide => cobalamin" MISC ADO-CBL synthesis TRUE
+K19712 cobY; adenosylcobinamide-phosphate guanylyltransferase [EC:2.7.7.62] "Cobalamin biosynthesis, cobinamide => cobalamin" MISC ADO-CBL synthesis TRUE
+K02233 "E2.7.8.26, cobS, cobV; adenosylcobinamide-GDP ribazoletransferase [EC:2.7.8.26]" "Cobalamin biosynthesis, cobinamide => cobalamin" MISC ADO-CBL synthesis TRUE
+K13786 "cobR; cob(II)yrinic acid a,c-diamide reductase [EC:1.16.8.1]" "Cobalamin biosynthesis, precorrin2 => cobinamide" MISC ADO-CBL synthesis TRUE
+K00798 "MMAB, pduO; cob(I)alamin adenosyltransferase [EC:2.5.1.17]" "Cobalamin biosynthesis, cobinamide => cobalamin" MISC ADO-CBL synthesis TRUE
+K19221 "cobA, btuR; cob(I)alamin adenosyltransferase [EC:2.5.1.17]" "Cobalamin biosynthesis, cobinamide => cobalamin" MISC ADO-CBL synthesis TRUE
+K02232 "cobQ, cbiP; adenosylcobyric acid synthase [EC:6.3.5.10]" "Cobalamin biosynthesis, cobinamide => cobalamin" MISC ADO-CBL synthesis TRUE
+K02225 "cobC1, cobC; cobalamin biosynthetic protein CobC" "Cobalamin biosynthesis, cobinamide => cobalamin" MISC ADO-CBL synthesis TRUE
+K02227 "cbiB, cobD; adenosylcobinamide-phosphate synthase [EC:6.3.1.10]" "Cobalamin biosynthesis, cobinamide => cobalamin" MISC ADO-CBL synthesis TRUE
+K02231 "cobP, cobU; adenosylcobinamide kinase / adenosylcobinamide-phosphate guanylyltransferase [EC:2.7.1.156 2.7.7.62]" "Cobalamin biosynthesis, cobinamide => cobalamin" MISC ADO-CBL synthesis TRUE
+K02231 "cobP, cobU; adenosylcobinamide kinase / adenosylcobinamide-phosphate guanylyltransferase [EC:2.7.1.156 2.7.7.62]" "Cobalamin biosynthesis, cobinamide => cobalamin" MISC ADO-CBL synthesis TRUE
+K19712 cobY; adenosylcobinamide-phosphate guanylyltransferase [EC:2.7.7.62] "Cobalamin biosynthesis, cobinamide => cobalamin" MISC ADO-CBL synthesis TRUE
+K02233 "E2.7.8.26, cobS, cobV; adenosylcobinamide-GDP ribazoletransferase [EC:2.7.8.26]" "Cobalamin biosynthesis, cobinamide => cobalamin" MISC ADO-CBL synthesis TRUE
+K02048 cysP; sulfate/thiosulfate transport system substrate-binding protein Sulfate/thiosulfate transport system Transporters TRUE
+K23163 sbp; sulfate/thiosulfate transport system substrate-binding protein Sulfate/thiosulfate transport system Transporters TRUE
+K02046 cysU; sulfate/thiosulfate transport system permease protein Sulfate/thiosulfate transport system Transporters TRUE
+K02047 cysW; sulfate/thiosulfate transport system permease protein Sulfate/thiosulfate transport system Transporters TRUE
+K02045 cysA; sulfate/thiosulfate transport system ATP-binding protein [EC:7.3.2.3] Sulfate/thiosulfate transport system Transporters TRUE
+K10013 ABC.ARG.S; lysine/arginine/ornithine transport system substrate-binding protein Lysine/arginine/ornithine transport system Transporters TRUE
+K10015 hisM; histidine transport system permease protein Lysine/arginine/ornithine transport system Transporters TRUE
+K10016 hisQ; histidine transport system permease protein Lysine/arginine/ornithine transport system Transporters TRUE
+K10017 hisP; histidine transport system ATP-binding protein [EC:7.4.2.1] Lysine/arginine/ornithine transport system Transporters TRUE
+K10014 hisJ; histidine transport system substrate-binding protein Histidine transport system Transporters TRUE
+K10015 hisM; histidine transport system permease protein Histidine transport system Transporters TRUE
+K10016 hisQ; histidine transport system permease protein Histidine transport system Transporters TRUE
+K10017 hisP; histidine transport system ATP-binding protein [EC:7.4.2.1] Histidine transport system Transporters TRUE
+K10036 glnH; glutamine transport system substrate-binding protein Glutamine transport system Transporters TRUE
+K10037 glnP; glutamine transport system permease protein Glutamine transport system Transporters TRUE
+K10038 glnQ; glutamine transport system ATP-binding protein [EC:7.4.2.1] Glutamine transport system Transporters TRUE
+K10039 "peb1A, glnH; aspartate/glutamate/glutamine transport system substrate-binding protein" Aspartate/glutamate/glutamine transport system Transporters TRUE
+K10040 "peb1B, glnP, glnM; aspartate/glutamate/glutamine transport system permease protein" Aspartate/glutamate/glutamine transport system Transporters TRUE
+K10041 "peb1C, glnQ; aspartate/glutamate/glutamine transport system ATP-binding protein [EC:7.4.2.1]" Aspartate/glutamate/glutamine transport system Transporters TRUE
+K09996 artJ; arginine transport system substrate-binding protein Arginine transport system Transporters TRUE
+K09997 artI; arginine transport system substrate-binding protein Arginine transport system Transporters TRUE
+K09998 artM; arginine transport system permease protein Arginine transport system Transporters TRUE
+K09999 artQ; arginine transport system permease protein Arginine transport system Transporters TRUE
+K10000 artP; arginine transport system ATP-binding protein [EC:7.4.2.1] Arginine transport system Transporters TRUE
+K10001 gltI; glutamate/aspartate transport system substrate-binding protein Glutamate/aspartate transport system Transporters TRUE
+K10002 gltK; glutamate/aspartate transport system permease protein Glutamate/aspartate transport system Transporters TRUE
+K10003 gltJ; glutamate/aspartate transport system permease protein Glutamate/aspartate transport system Transporters TRUE
+K10004 gltL; glutamate/aspartate transport system ATP-binding protein [EC:7.4.2.1] Glutamate/aspartate transport system Transporters TRUE
+K10018 occT; octopine/nopaline transport system substrate-binding protein Octopine/nopaline transport system Transporters TRUE
+K10019 occM; octopine/nopaline transport system permease protein Octopine/nopaline transport system Transporters TRUE
+K10020 occQ; octopine/nopaline transport system permease protein Octopine/nopaline transport system Transporters TRUE
+K10021 occP; octopine/nopaline transport system ATP-binding protein [EC:7.4.2.1] Octopine/nopaline transport system Transporters TRUE
+K09969 aapJ; general L-amino acid transport system substrate-binding protein General L-amino acid transport system Transporters TRUE
+K09970 aapQ; general L-amino acid transport system permease protein General L-amino acid transport system Transporters TRUE
+K09971 aapM; general L-amino acid transport system permease protein General L-amino acid transport system Transporters TRUE
+K09972 aapP; general L-amino acid transport system ATP-binding protein [EC:3.6.3.-] General L-amino acid transport system Transporters TRUE
+K10005 gluB; glutamate transport system substrate-binding protein Glutamate transport system Transporters TRUE
+K10006 gluC; glutamate transport system permease protein Glutamate transport system Transporters TRUE
+K10007 gluD; glutamate transport system permease protein Glutamate transport system Transporters TRUE
+K10008 gluA; glutamate transport system ATP-binding protein [EC:7.4.2.1] Glutamate transport system Transporters TRUE
+K02424 "fliY, tcyA; L-cystine transport system substrate-binding protein" L-Cystine transport system Transporters TRUE
+K10009 "tcyB, yecS; L-cystine transport system permease protein" L-Cystine transport system Transporters TRUE
+K10010 "tcyC, yecC; L-cystine transport system ATP-binding protein [EC:7.4.2.1]" L-Cystine transport system Transporters TRUE
+K10022 aotJ; arginine/ornithine transport system substrate-binding protein Arginine/ornithine transport system Transporters TRUE
+K10023 aotM; arginine/ornithine transport system permease protein Arginine/ornithine transport system Transporters TRUE
+K10024 aotQ; arginine/ornithine transport system permease protein Arginine/ornithine transport system Transporters TRUE
+K10025 aotP; arginine/ornithine transport system ATP-binding protein [EC:7.4.2.1] Arginine/ornithine transport system Transporters TRUE
+K02030 ABC.PA.S; polar amino acid transport system substrate-binding protein Putative polar amino acid transport system Transporters TRUE
+K02029 ABC.PA.P; polar amino acid transport system permease protein Putative polar amino acid transport system Transporters TRUE
+K02028 ABC.PA.A; polar amino acid transport system ATP-binding protein [EC:7.4.2.1] Putative polar amino acid transport system Transporters TRUE
+K01999 livK; branched-chain amino acid transport system substrate-binding protein Branched-chain amino acid transport system Transporters TRUE
+K01997 livH; branched-chain amino acid transport system permease protein Branched-chain amino acid transport system Transporters TRUE
+K01998 livM; branched-chain amino acid transport system permease protein Branched-chain amino acid transport system Transporters TRUE
+K01995 livG; branched-chain amino acid transport system ATP-binding protein Branched-chain amino acid transport system Transporters TRUE
+K01996 livF; branched-chain amino acid transport system ATP-binding protein Branched-chain amino acid transport system Transporters TRUE
+K02073 ABC.MET.S; D-methionine transport system substrate-binding protein D-Methionine transport system Transporters TRUE
+K02072 ABC.MET.P; D-methionine transport system permease protein D-Methionine transport system Transporters TRUE
+K02071 ABC.MET.A; D-methionine transport system ATP-binding protein D-Methionine transport system Transporters TRUE
+K02048 cysP; sulfate/thiosulfate transport system substrate-binding protein Sulfate/thiosulfate transport system Transporters TRUE
+K23163 sbp; sulfate/thiosulfate transport system substrate-binding protein Sulfate/thiosulfate transport system Transporters TRUE
+K02046 cysU; sulfate/thiosulfate transport system permease protein Sulfate/thiosulfate transport system Transporters TRUE
+K02047 cysW; sulfate/thiosulfate transport system permease protein Sulfate/thiosulfate transport system Transporters TRUE
+K02045 cysA; sulfate/thiosulfate transport system ATP-binding protein [EC:7.3.2.3] Sulfate/thiosulfate transport system Transporters TRUE
+K05772 tupA; tungstate transport system substrate-binding protein Tungstate transport system Transporters TRUE
+K05773 tupB; tungstate transport system permease protein Tungstate transport system Transporters TRUE
+K06857 tupC; tungstate transport system ATP-binding protein Tungstate transport system Transporters TRUE
+K02051 ABC.SN.S; sulfonate/nitrate/taurine transport system substrate-binding protein NitT/TauT family transport system Transporters TRUE
+K02050 ABC.SN.P; sulfonate/nitrate/taurine transport system permease protein NitT/TauT family transport system Transporters TRUE
+K02049 ABC.SN.A; sulfonate/nitrate/taurine transport system ATP-binding protein NitT/TauT family transport system Transporters TRUE
+K02020 modA; molybdate transport system substrate-binding protein Molybdate transport system Transporters TRUE
+K02018 modB; molybdate transport system permease protein Molybdate transport system Transporters TRUE
+K02017 modC; molybdate transport system ATP-binding protein [EC:3.6.3.29] Molybdate transport system Transporters TRUE
+K05776 modF; molybdate transport system ATP-binding protein Molybdate transport system Transporters TRUE
+K02012 ABC.FE.S; iron(III) transport system substrate-binding protein Iron(III) transport system Transporters TRUE
+K02011 ABC.FE.P; iron(III) transport system permease protein Iron(III) transport system Transporters TRUE
+K02010 ABC.FE.A; iron(III) transport system ATP-binding protein [EC:3.6.3.30] Iron(III) transport system Transporters TRUE
+K02064 ABC.VB1.S; thiamine transport system substrate-binding protein Thiamine transport system Transporters TRUE
+K02063 ABC.VB1.P; thiamine transport system permease protein Thiamine transport system Transporters TRUE
+K02062 ABC.VB1.A; thiamine transport system ATP-binding protein Thiamine transport system Transporters TRUE
+K05777 ABC.VB1X.S; putative thiamine transport system substrate-binding protein Putative thiamine transport system Transporters TRUE
+K05778 ABC.VB1X.P; putative thiamine transport system permease protein Putative thiamine transport system Transporters TRUE
+K05779 ABC.VB1X.A; putative thiamine transport system ATP-binding protein Putative thiamine transport system Transporters TRUE
+K02055 ABC.SP.S; putative spermidine/putrescine transport system substrate-binding protein Putative spermidine/putrescine transport system Transporters TRUE
+K02053 ABC.SP.P; putative spermidine/putrescine transport system permease protein Putative spermidine/putrescine transport system Transporters TRUE
+K02054 ABC.SP.P1; putative spermidine/putrescine transport system permease protein Putative spermidine/putrescine transport system Transporters TRUE
+K02052 ABC.SP.A; putative spermidine/putrescine transport system ATP-binding protein Putative spermidine/putrescine transport system Transporters TRUE
+K10108 malE; maltose/maltodextrin transport system substrate-binding protein Maltose/maltodextrin transport system Transporters TRUE
+K10109 malF; maltose/maltodextrin transport system permease protein Maltose/maltodextrin transport system Transporters TRUE
+K10110 malG; maltose/maltodextrin transport system permease protein Maltose/maltodextrin transport system Transporters TRUE
+K10111 malK; maltose/maltodextrin transport system ATP-binding protein [EC:3.6.3.19] Maltose/maltodextrin transport system Transporters TRUE
+K10112 msmX; maltose/maltodextrin transport system ATP-binding protein Maltose/maltodextrin transport system Transporters TRUE
+K10117 msmE; raffinose/stachyose/melibiose transport system substrate-binding protein Raffinose/stachyose/melibiose transport system Transporters TRUE
+K10118 msmF; raffinose/stachyose/melibiose transport system permease protein Raffinose/stachyose/melibiose transport system Transporters TRUE
+K10119 msmG; raffinose/stachyose/melibiose transport system permease protein Raffinose/stachyose/melibiose transport system Transporters TRUE
+K10112 msmX; multiple sugar transport system ATP-binding protein Raffinose/stachyose/melibiose transport system Transporters TRUE
+K10120 K10120; fructooligosaccharide transport system substrate-binding protein Putative fructooligosaccharide transport system Transporters TRUE
+K10121 K10121; fructooligosaccharide transport system permease protein Putative fructooligosaccharide transport system Transporters TRUE
+K10122 K10122; fructooligosaccharide transport system permease protein Putative fructooligosaccharide transport system Transporters TRUE
+K10112 msmX; multiple sugar transport system ATP-binding protein Putative fructooligosaccharide transport system Transporters TRUE
+K05813 ugpB; sn-glycerol 3-phosphate transport system substrate-binding protein Putative sn-glycerol-phosphate transport system Transporters TRUE
+K05814 ugpA; sn-glycerol 3-phosphate transport system permease protein Putative sn-glycerol-phosphate transport system Transporters TRUE
+K05815 ugpE; sn-glycerol 3-phosphate transport system permease protein Putative sn-glycerol-phosphate transport system Transporters TRUE
+K05816 ugpC; sn-glycerol 3-phosphate transport system ATP-binding protein [EC:3.6.3.20] Putative sn-glycerol-phosphate transport system Transporters TRUE
+K10188 lacE; lactose/L-arabinose transport system substrate-binding protein L-Arabinose/lactose transport system Transporters TRUE
+K10189 lacF; lactose/L-arabinose transport system permease protein L-Arabinose/lactose transport system Transporters TRUE
+K10190 lacG; lactose/L-arabinose transport system permease protein L-Arabinose/lactose transport system Transporters TRUE
+K10191 lacK; lactose/L-arabinose transport system ATP-binding protein L-Arabinose/lactose transport system Transporters TRUE
+K10227 smoE; sorbitol/mannitol transport system substrate-binding protein Putative sorbitol/mannitol transport system Transporters TRUE
+K10228 smoF; sorbitol/mannitol transport system permease protein Putative sorbitol/mannitol transport system Transporters TRUE
+K10229 smoG; sorbitol/mannitol transport system permease protein Putative sorbitol/mannitol transport system Transporters TRUE
+K10111 malK; multiple sugar transport system ATP-binding protein [EC:3.6.3.-] Putative sorbitol/mannitol transport system Transporters TRUE
+K10112 msmX; multiple sugar transport system ATP-binding protein Putative sorbitol/mannitol transport system Transporters TRUE
+K10232 aglE; alpha-glucoside transport system substrate-binding protein alpha-Glucoside transport system Transporters TRUE
+K10233 aglF; alpha-glucoside transport system permease protein alpha-Glucoside transport system Transporters TRUE
+K10234 aglG; alpha-glucoside transport system permease protein alpha-Glucoside transport system Transporters TRUE
+K10235 aglK; alpha-glucoside transport system ATP-binding protein alpha-Glucoside transport system Transporters TRUE
+K10112 msmX; multiple sugar transport system ATP-binding protein alpha-Glucoside transport system Transporters TRUE
+K10192 togB; oligogalacturonide transport system substrate-binding protein Oligogalacturonide transport system Transporters TRUE
+K10193 togM; oligogalacturonide transport system permease protein Oligogalacturonide transport system Transporters TRUE
+K10194 togN; oligogalacturonide transport system permease protein Oligogalacturonide transport system Transporters TRUE
+K10195 togA; oligogalacturonide transport system ATP-binding protein Oligogalacturonide transport system Transporters TRUE
+K10196 ABC.GLC.S; glucose/arabinose transport system substrate-binding protein Glucose/arabinose transport system Transporters TRUE
+K10197 ABC.GLC.P; glucose/arabinose transport system permease protein Glucose/arabinose transport system Transporters TRUE
+K10198 ABC.GLC.P1; glucose/arabinose transport system permease protein Glucose/arabinose transport system Transporters TRUE
+K10199 ABC.GLC.A; glucose/arabinose transport system ATP-binding protein Glucose/arabinose transport system Transporters TRUE
+K10236 thuE; trehalose/maltose transport system substrate-binding protein Trehalose/maltose transport system Transporters TRUE
+K10237 thuF; trehalose/maltose transport system permease protein Trehalose/maltose transport system Transporters TRUE
+K10238 thuG; trehalose/maltose transport system permease protein Trehalose/maltose transport system Transporters TRUE
+K10111 malK; multiple sugar transport system ATP-binding protein [EC:3.6.3.-] Trehalose/maltose transport system Transporters TRUE
+K10200 ABC.NGC.S; N-acetylglucosamine transport system substrate-binding protein N-Acetylglucosamine transport system Transporters TRUE
+K10201 ABC.NGC.P; N-acetylglucosamine transport system permease protein N-Acetylglucosamine transport system Transporters TRUE
+K10202 ABC.NGC.P1; N-acetylglucosamine transport system permease protein N-Acetylglucosamine transport system Transporters TRUE
+K10240 cebE; cellobiose transport system substrate-binding protein Cellobiose transport system Transporters TRUE
+K10241 cebF; cellobiose transport system permease protein Cellobiose transport system Transporters TRUE
+K10242 cebG; cellobiose transport system permease protein Cellobiose transport system Transporters TRUE
+K10112 msmX; multiple sugar transport system ATP-binding protein Cellobiose transport system Transporters TRUE
+K02027 ABC.MS.S; multiple sugar transport system substrate-binding protein Putative multiple sugar transport system Transporters TRUE
+K02025 ABC.MS.P; multiple sugar transport system permease protein Putative multiple sugar transport system Transporters TRUE
+K02026 ABC.MS.P1; multiple sugar transport system permease protein Putative multiple sugar transport system Transporters TRUE
+K10111 malK; multiple sugar transport system ATP-binding protein [EC:3.6.3.-] Putative multiple sugar transport system Transporters TRUE
+K10112 msmX; multiple sugar transport system ATP-binding protein Putative multiple sugar transport system Transporters TRUE
+K02002 proX; glycine betaine/proline transport system substrate-binding protein Glycine betaine/proline transport system Transporters TRUE
+K02001 proW; glycine betaine/proline transport system permease protein Glycine betaine/proline transport system Transporters TRUE
+K02000 proV; glycine betaine/proline transport system ATP-binding protein [EC:3.6.3.32] Glycine betaine/proline transport system Transporters TRUE
+K05845 ABC.BCP1.S; osmoprotectant transport system substrate-binding protein Osmoprotectant transport system Transporters TRUE
+K05846 ABC.BCP1.P; osmoprotectant transport system permease protein Osmoprotectant transport system Transporters TRUE
+K05847 ABC.BCP1.A; osmoprotectant transport system ATP-binding protein Osmoprotectant transport system Transporters TRUE
+K07323 mlaC; phospholipid transport system substrate-binding protein Phospholipid transport system Transporters TRUE
+K02067 "mlaD, linM; phospholipid/cholesterol/gamma-HCH transport system substrate-binding protein" Phospholipid transport system Transporters TRUE
+K02066 "mlaE, linK; phospholipid/cholesterol/gamma-HCH transport system permease protein" Phospholipid transport system Transporters TRUE
+K02065 "mlaF, linL, mkl; phospholipid/cholesterol/gamma-HCH transport system ATP-binding protein" Phospholipid transport system Transporters TRUE
+K07122 mlaB; phospholipid transport system transporter-binding protein Phospholipid transport system Transporters TRUE
+K02069 ABC.X2.P; putative ABC transport system permease protein Putative ABC transport system Transporters TRUE
+K02068 ABC.X2.A; putative ABC transport system ATP-binding protein Putative ABC transport system Transporters TRUE
+K10439 rbsB; ribose transport system substrate-binding protein Ribose transport system Transporters TRUE
+K10440 rbsC; ribose transport system permease protein Ribose transport system Transporters TRUE
+K10441 rbsA; ribose transport system ATP-binding protein [EC:3.6.3.17] Ribose transport system Transporters TRUE
+K10537 araF; L-arabinose transport system substrate-binding protein L-Arabinose transport system Transporters TRUE
+K10538 araH; L-arabinose transport system permease protein L-Arabinose transport system Transporters TRUE
+K10539 araG; L-arabinose transport system ATP-binding protein [EC:3.6.3.17] L-Arabinose transport system Transporters TRUE
+K10540 mglB; methyl-galactoside transport system substrate-binding protein Methyl-galactoside transport system Transporters TRUE
+K10541 mglC; methyl-galactoside transport system permease protein Methyl-galactoside transport system Transporters TRUE
+K10542 mglA; methyl-galactoside transport system ATP-binding protein [EC:3.6.3.17] Methyl-galactoside transport system Transporters TRUE
+K10543 xylF; D-xylose transport system substrate-binding protein D-Xylose transport system Transporters TRUE
+K10544 xylH; D-xylose transport system permease protein D-Xylose transport system Transporters TRUE
+K10545 xylG; D-xylose transport system ATP-binding protein [EC:3.6.3.17] D-Xylose transport system Transporters TRUE
+K10546 ABC.GGU.S; putative multiple sugar transport system substrate-binding protein Multiple sugar transport system Transporters TRUE
+K10547 ABC.GGU.P; putative multiple sugar transport system permease protein Multiple sugar transport system Transporters TRUE
+K10548 ABC.GGU.A; putative multiple sugar transport system ATP-binding protein Multiple sugar transport system Transporters TRUE
+K10549 alsB; D-allose transport system substrate-binding protein D-Allose transport system Transporters TRUE
+K10550 alsC; D-allose transport system permease protein D-Allose transport system Transporters TRUE
+K10551 alsA; D-allose transport system ATP-binding protein [EC:3.6.3.17] D-Allose transport system Transporters TRUE
+K10552 frcB; fructose transport system substrate-binding protein Fructose transport system Transporters TRUE
+K10553 frcC; fructose transport system permease protein Fructose transport system Transporters TRUE
+K10554 frcA; fructose transport system ATP-binding protein Fructose transport system Transporters TRUE
+K10555 lsrB; AI-2 transport system substrate-binding protein AI-2 transport system Transporters TRUE
+K10556 lsrC; AI-2 transport system permease protein AI-2 transport system Transporters TRUE
+K10557 lsrD; AI-2 transport system permease protein AI-2 transport system Transporters TRUE
+K10558 lsrA; AI-2 transport system ATP-binding protein AI-2 transport system Transporters TRUE
+K10559 rhaS1; rhamnose transport system substrate-binding protein Rhamnose transport system Transporters TRUE
+K10560 rhaP; rhamnose transport system permease protein Rhamnose transport system Transporters TRUE
+K10561 rhaQ; rhamnose transport system permease protein Rhamnose transport system Transporters TRUE
+K10562 rhaT; rhamnose transport system ATP-binding protein [EC:3.6.3.17] Rhamnose transport system Transporters TRUE
+K02058 ABC.SS.S; simple sugar transport system substrate-binding protein Putative simple sugar transport system Transporters TRUE
+K02057 ABC.SS.P; simple sugar transport system permease protein Putative simple sugar transport system Transporters TRUE
+K02056 ABC.SS.A; simple sugar transport system ATP-binding protein [EC:3.6.3.17] Putative simple sugar transport system Transporters TRUE
+K02040 pstS; phosphate transport system substrate-binding protein Phosphate transport system Transporters TRUE
+K02037 pstC; phosphate transport system permease protein Phosphate transport system Transporters TRUE
+K02038 pstA; phosphate transport system permease protein Phosphate transport system Transporters TRUE
+K02036 pstB; phosphate transport system ATP-binding protein [EC:7.3.2.1] Phosphate transport system Transporters TRUE
+K02044 phnD; phosphonate transport system substrate-binding protein Phosphonate transport system Transporters TRUE
+K02042 phnE; phosphonate transport system permease protein Phosphonate transport system Transporters TRUE
+K02041 phnC; phosphonate transport system ATP-binding protein [EC:7.3.2.2] Phosphonate transport system Transporters TRUE
+K16905 K16905; fluoroquinolone transport system permease protein Fluoroquinolone transport system Transporters TRUE
+K16906 K16906; fluoroquinolone transport system permease protein Fluoroquinolone transport system Transporters TRUE
+K16907 K16907; fluoroquinolone transport system ATP-binding protein [EC:3.6.3.-] Fluoroquinolone transport system Transporters TRUE
+K10013 ABC.ARG.S; lysine/arginine/ornithine transport system substrate-binding protein Lysine/arginine/ornithine transport system Transporters TRUE
+K10015 hisM; histidine transport system permease protein Lysine/arginine/ornithine transport system Transporters TRUE
+K10016 hisQ; histidine transport system permease protein Lysine/arginine/ornithine transport system Transporters TRUE
+K10017 hisP; histidine transport system ATP-binding protein [EC:7.4.2.1] Lysine/arginine/ornithine transport system Transporters TRUE
+K10014 hisJ; histidine transport system substrate-binding protein Histidine transport system Transporters TRUE
+K10015 hisM; histidine transport system permease protein Histidine transport system Transporters TRUE
+K10016 hisQ; histidine transport system permease protein Histidine transport system Transporters TRUE
+K10017 hisP; histidine transport system ATP-binding protein [EC:7.4.2.1] Histidine transport system Transporters TRUE
+K10036 glnH; glutamine transport system substrate-binding protein Glutamine transport system Transporters TRUE
+K10037 glnP; glutamine transport system permease protein Glutamine transport system Transporters TRUE
+K10038 glnQ; glutamine transport system ATP-binding protein [EC:7.4.2.1] Glutamine transport system Transporters TRUE
+K10039 "peb1A, glnH; aspartate/glutamate/glutamine transport system substrate-binding protein" Aspartate/glutamate/glutamine transport system Transporters TRUE
+K10040 "peb1B, glnP, glnM; aspartate/glutamate/glutamine transport system permease protein" Aspartate/glutamate/glutamine transport system Transporters TRUE
+K10041 "peb1C, glnQ; aspartate/glutamate/glutamine transport system ATP-binding protein [EC:7.4.2.1]" Aspartate/glutamate/glutamine transport system Transporters TRUE
+K09996 artJ; arginine transport system substrate-binding protein Arginine transport system Transporters TRUE
+K09997 artI; arginine transport system substrate-binding protein Arginine transport system Transporters TRUE
+K09998 artM; arginine transport system permease protein Arginine transport system Transporters TRUE
+K09999 artQ; arginine transport system permease protein Arginine transport system Transporters TRUE
+K10000 artP; arginine transport system ATP-binding protein [EC:7.4.2.1] Arginine transport system Transporters TRUE
+K10001 gltI; glutamate/aspartate transport system substrate-binding protein Glutamate/aspartate transport system Transporters TRUE
+K10002 gltK; glutamate/aspartate transport system permease protein Glutamate/aspartate transport system Transporters TRUE
+K10003 gltJ; glutamate/aspartate transport system permease protein Glutamate/aspartate transport system Transporters TRUE
+K10004 gltL; glutamate/aspartate transport system ATP-binding protein [EC:7.4.2.1] Glutamate/aspartate transport system Transporters TRUE
+K10018 occT; octopine/nopaline transport system substrate-binding protein Octopine/nopaline transport system Transporters TRUE
+K10019 occM; octopine/nopaline transport system permease protein Octopine/nopaline transport system Transporters TRUE
+K10020 occQ; octopine/nopaline transport system permease protein Octopine/nopaline transport system Transporters TRUE
+K10021 occP; octopine/nopaline transport system ATP-binding protein [EC:7.4.2.1] Octopine/nopaline transport system Transporters TRUE
+K09969 aapJ; general L-amino acid transport system substrate-binding protein General L-amino acid transport system Transporters TRUE
+K09970 aapQ; general L-amino acid transport system permease protein General L-amino acid transport system Transporters TRUE
+K09971 aapM; general L-amino acid transport system permease protein General L-amino acid transport system Transporters TRUE
+K09972 aapP; general L-amino acid transport system ATP-binding protein [EC:3.6.3.-] General L-amino acid transport system Transporters TRUE
+K10005 gluB; glutamate transport system substrate-binding protein Glutamate transport system Transporters TRUE
+K10006 gluC; glutamate transport system permease protein Glutamate transport system Transporters TRUE
+K10007 gluD; glutamate transport system permease protein Glutamate transport system Transporters TRUE
+K10008 gluA; glutamate transport system ATP-binding protein [EC:7.4.2.1] Glutamate transport system Transporters TRUE
+K02424 "fliY, tcyA; L-cystine transport system substrate-binding protein" L-Cystine transport system Transporters TRUE
+K10009 "tcyB, yecS; L-cystine transport system permease protein" L-Cystine transport system Transporters TRUE
+K10010 "tcyC, yecC; L-cystine transport system ATP-binding protein [EC:7.4.2.1]" L-Cystine transport system Transporters TRUE
+K10022 aotJ; arginine/ornithine transport system substrate-binding protein Arginine/ornithine transport system Transporters TRUE
+K10023 aotM; arginine/ornithine transport system permease protein Arginine/ornithine transport system Transporters TRUE
+K10024 aotQ; arginine/ornithine transport system permease protein Arginine/ornithine transport system Transporters TRUE
+K10025 aotP; arginine/ornithine transport system ATP-binding protein [EC:7.4.2.1] Arginine/ornithine transport system Transporters TRUE
+K02030 ABC.PA.S; polar amino acid transport system substrate-binding protein Putative polar amino acid transport system Transporters TRUE
+K02029 ABC.PA.P; polar amino acid transport system permease protein Putative polar amino acid transport system Transporters TRUE
+K02028 ABC.PA.A; polar amino acid transport system ATP-binding protein [EC:7.4.2.1] Putative polar amino acid transport system Transporters TRUE
+K01999 livK; branched-chain amino acid transport system substrate-binding protein Branched-chain amino acid transport system Transporters TRUE
+K01997 livH; branched-chain amino acid transport system permease protein Branched-chain amino acid transport system Transporters TRUE
+K01998 livM; branched-chain amino acid transport system permease protein Branched-chain amino acid transport system Transporters TRUE
+K01995 livG; branched-chain amino acid transport system ATP-binding protein Branched-chain amino acid transport system Transporters TRUE
+K01996 livF; branched-chain amino acid transport system ATP-binding protein Branched-chain amino acid transport system Transporters TRUE
+K02073 ABC.MET.S; D-methionine transport system substrate-binding protein D-Methionine transport system Transporters TRUE
+K02072 ABC.MET.P; D-methionine transport system permease protein D-Methionine transport system Transporters TRUE
+K02071 ABC.MET.A; D-methionine transport system ATP-binding protein D-Methionine transport system Transporters TRUE
+K02035 ABC.PE.S; peptide/nickel transport system substrate-binding protein Peptides/nickel transport system Transporters TRUE
+K02033 ABC.PE.P; peptide/nickel transport system permease protein Peptides/nickel transport system Transporters TRUE
+K02034 ABC.PE.P1; peptide/nickel transport system permease protein Peptides/nickel transport system Transporters TRUE
+K02031 ABC.PE.A; peptide/nickel transport system ATP-binding protein Peptides/nickel transport system Transporters TRUE
+K02032 ABC.PE.A1; peptide/nickel transport system ATP-binding protein Peptides/nickel transport system Transporters TRUE
+K02016 ABC.FEV.S; iron complex transport system substrate-binding protein Iron complex transport system Transporters TRUE
+K02015 ABC.FEV.P; iron complex transport system permease protein Iron complex transport system Transporters TRUE
+K02013 ABC.FEV.A; iron complex transport system ATP-binding protein [EC:3.6.3.34] Iron complex transport system Transporters TRUE
+K06858 ABC.VB12.S1; vitamin B12 transport system substrate-binding protein Vitamin B12 transport system Transporters TRUE
+K06073 ABC.VB12.P; vitamin B12 transport system permease protein Vitamin B12 transport system Transporters TRUE
+K06074 ABC.VB12.A; vitamin B12 transport system ATP-binding protein [EC:3.6.3.33] Vitamin B12 transport system Transporters TRUE
+K09815 znuA; zinc transport system substrate-binding protein Zinc transport system Transporters TRUE
+K09816 znuB; zinc transport system permease protein Zinc transport system Transporters TRUE
+K09817 znuC; zinc transport system ATP-binding protein [EC:3.6.3.-] Zinc transport system Transporters TRUE
+K09818 ABC.MN.S; manganese/iron transport system substrate-binding protein Manganese/iron transport system Transporters TRUE
+K09819 ABC.MN.P; manganese/iron transport system permease protein Manganese/iron transport system Transporters TRUE
+K09820 ABC.MN.A; manganese/iron transport system ATP-binding protein Manganese/iron transport system Transporters TRUE
+K02077 ABC.ZM.S; zinc/manganese transport system substrate-binding protein Putative zinc/manganese transport system Transporters TRUE
+K02075 ABC.ZM.P; zinc/manganese transport system permease protein Putative zinc/manganese transport system Transporters TRUE
+K02074 ABC.ZM.A; zinc/manganese transport system ATP-binding protein Putative zinc/manganese transport system Transporters TRUE
+K02009 cbiN; cobalt transport protein Cobalt/nickel transport system Transporters TRUE
+K02008 cbiQ; cobalt/nickel transport system permease protein Cobalt/nickel transport system Transporters TRUE
+K02007 cbiM; cobalt/nickel transport system permease protein Cobalt/nickel transport system Transporters TRUE
+K02006 cbiO; cobalt/nickel transport system ATP-binding protein Cobalt/nickel transport system Transporters TRUE
+K16915 cbiL; nickel transport protein Nickel transport system Transporters TRUE
+K02009 cbiN; cobalt transport protein Nickel transport system Transporters TRUE
+K10094 cbiK; nickel transport system substrate-binding protein Nickel transport system Transporters TRUE
+K02008 cbiQ; cobalt/nickel transport system permease protein Nickel transport system Transporters TRUE
+K02007 cbiM; cobalt/nickel transport system permease protein Nickel transport system Transporters TRUE
+K02006 cbiO; cobalt/nickel transport system ATP-binding protein Nickel transport system Transporters TRUE
+K01989 ABC.X4.S; putative ABC transport system substrate-binding protein Putative ABC transport system Transporters TRUE
+K05832 ABC.X4.P; putative ABC transport system permease protein Putative ABC transport system Transporters TRUE
+K05833 ABC.X4.A; putative ABC transport system ATP-binding protein Putative ABC transport system Transporters TRUE
+K09688 ABC-2.CPSE.P; capsular polysaccharide transport system permease protein Capsular polysaccharide transport system Transporters TRUE
+K10107 ABC-2.CPSE.P1; capsular polysaccharide transport system permease protein Capsular polysaccharide transport system Transporters TRUE
+K09689 ABC-2.CPSE.A; capsular polysaccharide transport system ATP-binding protein Capsular polysaccharide transport system Transporters TRUE
+K09690 ABC-2.LPSE.P; lipopolysaccharide transport system permease protein Lipopolysaccharide transport system Transporters TRUE
+K09691 ABC-2.LPSE.A; lipopolysaccharide transport system ATP-binding protein Lipopolysaccharide transport system Transporters TRUE
+K09692 tagG; teichoic acid transport system permease protein Teichoic acid transport system Transporters TRUE
+K09693 tagH; teichoic acid transport system ATP-binding protein [EC:3.6.3.40] Teichoic acid transport system Transporters TRUE
+K09694 nodJ; lipooligosaccharide transport system permease protein Lipooligosaccharide transport system Transporters TRUE
+K09695 nodI; lipooligosaccharide transport system ATP-binding protein Lipooligosaccharide transport system Transporters TRUE
+K09696 natB; sodium transport system permease protein Sodium transport system Transporters TRUE
+K09697 natA; sodium transport system ATP-binding protein Sodium transport system Transporters TRUE
+K01992 ABC-2.P; ABC-2 type transport system permease protein ABC-2 type transport system Transporters TRUE
+K01990 ABC-2.A; ABC-2 type transport system ATP-binding protein ABC-2 type transport system Transporters TRUE
+K09808 ABC.LPT.P; lipoprotein-releasing system permease protein Lipoprotein-releasing system Transporters TRUE
+K09810 ABC.LPT.A; lipoprotein-releasing system ATP-binding protein [EC:3.6.3.-] Lipoprotein-releasing system Transporters TRUE
+K09811 ftsX; cell division transport system permease protein Cell division transport system Transporters TRUE
+K09812 ftsE; cell division transport system ATP-binding protein Cell division transport system Transporters TRUE
+K09813 hrtB; hemin transport system permease protein Hemin transport system Transporters TRUE
+K09814 hrtA; hemin transport system ATP-binding protein [EC:3.6.3.-] Hemin transport system Transporters TRUE
+K02004 ABC.CD.P; Putative ABC transport system Transporters TRUE
+K02003 ABC.CD.A; Putative ABC transport system Transporters TRUE
+K02195 ccmC; heme exporter membrane protein CcmC Heme transport system Transporters TRUE
+K02194 ccmB; heme exporter membrane protein CcmB Heme transport system Transporters TRUE
+K02193 ccmA; heme exporter ATP-binding protein CcmA [EC:3.6.3.41] Heme transport system Transporters TRUE
+K02777 "PTS-Glc-EIIA; PTS system, glucose-specific IIA component" "PTS system, glucose-specific II component" Transporters TRUE
+K02778 "PTS-Glc-EIIB; PTS system, glucose-specific IIB component" "PTS system, glucose-specific II component" Transporters TRUE
+K02779 "PTS-Glc-EIIC; PTS system, glucose-specific IIC component" "PTS system, glucose-specific II component" Transporters TRUE
+K02777 "PTS-Glc-EIIA; PTS system, sugar-specific IIA component" "PTS system, maltose/glucose-specific II component" Transporters TRUE
+K02790 "PTS-MalGlc-EIIB; PTS system, maltose/glucose-specific IIB component" "PTS system, maltose/glucose-specific II component" Transporters TRUE
+K02791 "PTS-MalGlc-EIIC; PTS system, maltose/glucose-specific IIC component" "PTS system, maltose/glucose-specific II component" Transporters TRUE
+K02802 "PTS-Nag-EIIA; PTS system, N-acetylglucosamine-specific IIA component" "PTS system, N-acetylglucosamine-specific II component" Transporters TRUE
+K02803 "PTS-Nag-EIIB; PTS system, N-acetylglucosamine-specific IIB component" "PTS system, N-acetylglucosamine-specific II component" Transporters TRUE
+K02804 "PTS-Nag-EIIC; PTS system, N-acetylglucosamine-specific IIC component" "PTS system, N-acetylglucosamine-specific II component" Transporters TRUE
+K02777 "PTS-Glc-EIIA; PTS system, sugar-specific IIA component" "PTS system, alpha-glucoside-specific II component" Transporters TRUE
+K02749 "PTS-Glv-EIIB; PTS system, alpha-glucoside-specific IIB component" "PTS system, alpha-glucoside-specific II component" Transporters TRUE
+K02750 "PTS-Glv-EIIC; PTS system, alpha-glucoside-specific IIC component" "PTS system, alpha-glucoside-specific II component" Transporters TRUE
+K02808 "PTS-Scr-EIIA; PTS system, sucrose-specific IIA component" "PTS system, sucrose-specific II component" Transporters TRUE
+K02809 "PTS-Scr-EIIB; PTS system, sucrose-specific IIB component" "PTS system, sucrose-specific II component" Transporters TRUE
+K02810 "PTS-Scr-EIIC; PTS system, sucrose-specific IIC component" "PTS system, sucrose-specific II component" Transporters TRUE
+K02777 "PTS-Glc-EIIA; PTS system, glucose-specific IIA component" "PTS system, trehalose-specific II component" Transporters TRUE
+K02817 "PTS-Tre-EIIA; PTS system, trehalose-specific IIA component" "PTS system, trehalose-specific II component" Transporters TRUE
+K02818 "PTS-Tre-EIIB; PTS system, trehalose-specific IIB component" "PTS system, trehalose-specific II component" Transporters TRUE
+K02819 "PTS-Tre-EIIC; PTS system, trehalose-specific IIC component" "PTS system, trehalose-specific II component" Transporters TRUE
+K02755 "PTS-Bgl-EIIA; PTS system, beta-glucoside-specific IIA component" "PTS system, beta-glucoside-specific II component" Transporters TRUE
+K02756 "PTS-Bgl-EIIB; PTS system, beta-glucoside-specific IIB component" "PTS system, beta-glucoside-specific II component" Transporters TRUE
+K02757 "PTS-Bgl-EIIC; PTS system, beta-glucoside-specific IIC component" "PTS system, beta-glucoside-specific II component" Transporters TRUE
+K02777 "PTS-Glc-EIIA; PTS system, sugar-specific IIA component" "PTS system, beta-glucoside (arbutin/salicin/cellobiose)-specific II component" Transporters TRUE
+K02752 "PTS-Asc-EIIB; PTS system, beta-glucoside (arbutin/salicin/cellobiose)-specific IIB component" "PTS system, beta-glucoside (arbutin/salicin/cellobiose)-specific II component" Transporters TRUE
+K02753 "PTS-Asc-EIIC; PTS system, beta-glucoside (arbutin/salicin/cellobiose)-specific IIC component" "PTS system, beta-glucoside (arbutin/salicin/cellobiose)-specific II component" Transporters TRUE
+K02768 "PTS-Fru-EIIA; PTS system, fructose-specific IIA component" "PTS system, fructose-specific II component" Transporters TRUE
+K02769 "PTS-Fru-EIIB; PTS system, fructose-specific IIB component" "PTS system, fructose-specific II component" Transporters TRUE
+K02770 "PTS-Fru-EIIC; PTS system, fructose-specific IIC component" "PTS system, fructose-specific II component" Transporters TRUE
+K02798 "PTS-Mtl-EIIA; PTS system, mannitol-specific IIA component" "PTS system, mannitol-specific II component" Transporters TRUE
+K02799 "PTS-Mtl-EIIB; PTS system, mannitol-specific IIB component" "PTS system, mannitol-specific II component" Transporters TRUE
+K02800 "PTS-Mtl-EIIC; PTS system, mannitol-specific IIC component" "PTS system, mannitol-specific II component" Transporters TRUE
+K02759 "PTS-Cel-EIIA; PTS system, cellobiose-specific IIA component" "PTS system, cellobiose-specific II component" Transporters TRUE
+K02760 "PTS-Cel-EIIB; PTS system, cellobiose-specific IIB component" "PTS system, cellobiose-specific II component" Transporters TRUE
+K02761 "PTS-Cel-EIIC; PTS system, cellobiose-specific IIC component" "PTS system, cellobiose-specific II component" Transporters TRUE
+K02793 "PTS-Man-EIIA; PTS system, mannose-specific IIA component" "PTS system, mannose-specific II component" Transporters TRUE
+K02794 "PTS-Man-EIIB; PTS system, mannose-specific IIB component" "PTS system, mannose-specific II component" Transporters TRUE
+K02795 "PTS-Man-EIIC; PTS system, mannose-specific IIC component" "PTS system, mannose-specific II component" Transporters TRUE
+K02796 "PTS-Man-EIID; PTS system, mannose-specific IID component" "PTS system, mannose-specific II component" Transporters TRUE
+K02744 "PTS-Aga-EIIA; PTS system, N-acetylgalactosamine-specific IIA component" "PTS system, N-acetylgalactosamine-specific II component" Transporters TRUE
+K02745 "PTS-Aga-EIIB; PTS system, N-acetylgalactosamine-specific IIB component" "PTS system, N-acetylgalactosamine-specific II component" Transporters TRUE
+K02746 "PTS-Aga-EIIC; PTS system, N-acetylgalactosamine-specific IIC component" "PTS system, N-acetylgalactosamine-specific II component" Transporters TRUE
+K02747 "PTS-Aga-EIID; PTS system, N-acetylgalactosamine-specific IID component" "PTS system, N-acetylgalactosamine-specific II component" Transporters TRUE
+K02812 "PTS-Sor-EIIA; PTS system, sorbose-specific IIA component" "PTS system, sorbose-specific II component" Transporters TRUE
+K02813 "PTS-Sor-EIIB; PTS system, sorbose-specific IIB component" "PTS system, sorbose-specific II component" Transporters TRUE
+K02814 "PTS-Sor-EIIC; PTS system, sorbose-specific IIC component" "PTS system, sorbose-specific II component" Transporters TRUE
+K02815 "PTS-Sor-EIID; PTS system, sorbose-specific IID component" "PTS system, sorbose-specific II component" Transporters TRUE
+K02773 "PTS-Gat-EIIA; PTS system, galactitol-specific IIA component" "PTS system, galactitol-specific II component" Transporters TRUE
+K02774 "PTS-Gat-EIIB; PTS system, galactitol-specific IIB component" "PTS system, galactitol-specific II component" Transporters TRUE
+K02775 "PTS-Gat-EIIC; PTS system, galactitol-specific IIC component" "PTS system, galactitol-specific II component" Transporters TRUE
+K02781 "PTS-Gut-EIIA; PTS system, glucitol/sorbitol-specific IIA component" "PTS system, glucitol/sorbitol-specific II component" Transporters TRUE
+K02782 "PTS-Gut-EIIB; PTS system, glucitol/sorbitol-specific IIB component" "PTS system, glucitol/sorbitol-specific II component" Transporters TRUE
+K02783 "PTS-Gut-EIIC; PTS system, glucitol/sorbitol-specific IIC component" "PTS system, glucitol/sorbitol-specific II component" Transporters TRUE
+K02786 "PTS-Lac-EIIA; PTS system, lactose-specific IIA component" "PTS system, lactose-specific II component" Transporters TRUE
+K02787 "PTS-Lac-EIIB; PTS system, lactose-specific IIB component" "PTS system, lactose-specific II component" Transporters TRUE
+K02788 "PTS-Lac-EIIC; PTS system, lactose-specific IIC component" "PTS system, lactose-specific II component" Transporters TRUE
+K02763 "PTS-Dgl-EIIA; PTS system, D-glucosamine-specific IIA component" "PTS system, D-glucosamine-specific II component" Transporters TRUE
+K02764 "PTS-Dgl-EIIB; PTS system, D-glucosamine-specific IIB component" "PTS system, D-glucosamine-specific II component" Transporters TRUE
+K02765 "PTS-Dgl-EIIC; PTS system, D-glucosamine-specific IIC component" "PTS system, D-glucosamine-specific II component" Transporters TRUE
+K02821 "PTS-Ula-EIIA; PTS system, ascorbate-specific IIA component" "PTS system, ascorbate-specific II component" Transporters TRUE
+K02822 "PTS-Ula-EIIB; PTS system, ascorbate-specific IIB component" "PTS system, ascorbate-specific II component" Transporters TRUE
+K03475 "PTS-Ula-EIIC; PTS system, ascorbate-specific IIC component" "PTS system, ascorbate-specific II component" Transporters TRUE
+K11051 ABC-2.CYL.P; multidrug/hemolysin transport system permease protein Multidrug/hemolysin transport system Transporters TRUE
+K11050 ABC-2.CYL.A; multidrug/hemolysin transport system ATP-binding protein Multidrug/hemolysin transport system Transporters TRUE
+K11069 potD; spermidine/putrescine transport system substrate-binding protein Spermidine/putrescine transport system Transporters TRUE
+K11070 potC; spermidine/putrescine transport system permease protein Spermidine/putrescine transport system Transporters TRUE
+K11071 potB; spermidine/putrescine transport system permease protein Spermidine/putrescine transport system Transporters TRUE
+K11072 potA; spermidine/putrescine transport system ATP-binding protein Spermidine/putrescine transport system Transporters TRUE
+K11073 potF; putrescine transport system substrate-binding protein Putrescine transport system Transporters TRUE
+K11074 potI; putrescine transport system permease protein Putrescine transport system Transporters TRUE
+K11075 potH; putrescine transport system permease protein Putrescine transport system Transporters TRUE
+K11076 potG; putrescine transport system ATP-binding protein Putrescine transport system Transporters TRUE
+K11077 attC; mannopine transport system substrate-binding protein Mannopine transport system Transporters TRUE
+K11078 attB; mannopine transport system permease protein Mannopine transport system Transporters TRUE
+K11079 attA2; mannopine transport system permease protein Mannopine transport system Transporters TRUE
+K11080 attA1; mannopine transport system ATP-binding protein Mannopine transport system Transporters TRUE
+K11081 phnS; 2-aminoethylphosphonate transport system substrate-binding protein 2-Aminoethylphosphonate transport system Transporters TRUE
+K11082 phnV; 2-aminoethylphosphonate transport system permease protein 2-Aminoethylphosphonate transport system Transporters TRUE
+K11083 phnU; 2-aminoethylphosphonate transport system permease protein 2-Aminoethylphosphonate transport system Transporters TRUE
+K11084 phnT; 2-aminoethylphosphonate transport system ATP-binding protein 2-Aminoethylphosphonate transport system Transporters TRUE
+K02777 "PTS-Glc-EIIA; PTS system, glucose-specific IIA component" "PTS system, N-acetylmuramic acid-specific II component" Transporters TRUE
+K11191 "PTS-Mur-EIIB; PTS system, N-acetylmuramic acid-specific IIB component" "PTS system, N-acetylmuramic acid-specific II component" Transporters TRUE
+K11192 "PTS-Mur-EIIC; PTS system, N-acetylmuramic acid-specific IIC component" "PTS system, N-acetylmuramic acid-specific II component" Transporters TRUE
+K11194 "PTS-Fru1-EIIA; PTS system, fructose-specific IIA component" "PTS system, fructose-specific II component" Transporters TRUE
+K11195 "PTS-Fru1-EIIB; PTS system, fructose-specific IIB component" "PTS system, fructose-specific II component" Transporters TRUE
+K11196 "PTS-Fru1-EIIC; PTS system, fructose-specific IIC component" "PTS system, fructose-specific II component" Transporters TRUE
+K02771 "PTS-Fru1-EIID; PTS system, fructose-specific IID component" "PTS system, fructose-specific II component" Transporters TRUE
+K11198 "PTS-Mng-EIIA; PTS system, 2-O-A-mannosyl-D-glycerate-specific IIA component" "PTS system, 2-O-A-mannosyl-D-glycerate-specific II component" Transporters TRUE
+K11199 "PTS-Mng-EIIB; PTS system, 2-O-A-mannosyl-D-glycerate-specific IIB component" "PTS system, 2-O-A-mannosyl-D-glycerate-specific II component" Transporters TRUE
+K11200 "PTS-Mng-EIIC; PTS system, 2-O-A-mannosyl-D-glycerate-specific IIC component" "PTS system, 2-O-A-mannosyl-D-glycerate-specific II component" Transporters TRUE
+K11201 "PTS-Fru2-EIIA; PTS system, fructose-specific IIA-like component" "PTS system, fructose-specific II-like component" Transporters TRUE
+K11202 "PTS-Fru2-EIIB; PTS system, fructose-specific IIB-like component" "PTS system, fructose-specific II-like component" Transporters TRUE
+K11203 "PTS-Fru2-EIIC; PTS system, fructose-specific IIC-like component" "PTS system, fructose-specific II-like component" Transporters TRUE
+K11632 bceB; bacitracin transport system permease protein Bacitracin transport system Transporters TRUE
+K11631 bceA; bacitracin transport system ATP-binding protein Bacitracin transport system Transporters TRUE
+K11636 yxdM; putative ABC transport system permease protein Uncharacterized ABC transport system Transporters TRUE
+K11635 yxdL; putative ABC transport system ATP-binding protein Uncharacterized ABC transport system Transporters TRUE
+K11601 mntC; manganese transport system substrate-binding protein Manganese transport system Transporters TRUE
+K11602 mntB; manganese transport system permease protein Manganese transport system Transporters TRUE
+K11603 mntA; manganese transport system ATP-binding protein Manganese transport system Transporters TRUE
+K11604 sitA; manganese/iron transport system substrate-binding protein Manganese/iron transport system Transporters TRUE
+K11605 sitC; manganese/iron transport system permease protein Manganese/iron transport system Transporters TRUE
+K11606 sitD; manganese/iron transport system permease protein Manganese/iron transport system Transporters TRUE
+K11607 sitB; manganese/iron transport system ATP-binding protein Manganese/iron transport system Transporters TRUE
+K11704 mtsA; iron/zinc/manganese/copper transport system substrate-binding protein Iron/zinc/manganese/copper transport system Transporters TRUE
+K11705 mtsC; iron/zinc/manganese/copper transport system permease protein Iron/zinc/manganese/copper transport system Transporters TRUE
+K11706 mtsB; iron/zinc/manganese/copper transport system ATP-binding protein Iron/zinc/manganese/copper transport system Transporters TRUE
+K11707 troA; manganese/zinc/iron transport system substrate-binding protein Manganese/zinc/iron transport system Transporters TRUE
+K11708 troC; manganese/zinc/iron transport system permease protein Manganese/zinc/iron transport system Transporters TRUE
+K11709 troD; manganese/zinc/iron transport system permease protein Manganese/zinc/iron transport system Transporters TRUE
+K11710 troB; manganese/zinc/iron transport system ATP-binding protein Manganese/zinc/iron transport system Transporters TRUE
+K07091 lptF; lipopolysaccharide export system permease protein Lipopolysaccharide export system Transporters TRUE
+K11720 lptG; lipopolysaccharide export system permease protein Lipopolysaccharide export system Transporters TRUE
+K06861 lptB; lipopolysaccharide export system ATP-binding protein [EC:3.6.3.-] Lipopolysaccharide export system Transporters TRUE
+K11950 cmpA; bicarbonate transport system substrate-binding protein Bicarbonate transport system Transporters TRUE
+K11951 cmpB; bicarbonate transport system permease protein Bicarbonate transport system Transporters TRUE
+K11952 cmpC; bicarbonate transport system ATP-binding protein [EC:3.6.3.-] Bicarbonate transport system Transporters TRUE
+K11953 cmpD; bicarbonate transport system ATP-binding protein [EC:3.6.3.-] Bicarbonate transport system Transporters TRUE
+K11954 K11954; neutral amino acid transport system substrate-binding protein Neutral amino acid transport system Transporters TRUE
+K11955 natC; neutral amino acid transport system permease protein Neutral amino acid transport system Transporters TRUE
+K11956 natD; neutral amino acid transport system permease protein Neutral amino acid transport system Transporters TRUE
+K11957 K11957; neutral amino acid transport system ATP-binding protein Neutral amino acid transport system Transporters TRUE
+K11958 natE; neutral amino acid transport system ATP-binding protein Neutral amino acid transport system Transporters TRUE
+K11959 urtA; urea transport system substrate-binding protein Urea transport system Transporters TRUE
+K11960 urtB; urea transport system permease protein Urea transport system Transporters TRUE
+K11961 urtC; urea transport system permease protein Urea transport system Transporters TRUE
+K11962 urtD; urea transport system ATP-binding protein Urea transport system Transporters TRUE
+K11963 urtE; urea transport system ATP-binding protein Urea transport system Transporters TRUE
+K12368 dppA; dipeptide transport system substrate-binding protein Dipeptide transport system Transporters TRUE
+K12369 dppB; dipeptide transport system permease protein Dipeptide transport system Transporters TRUE
+K12370 dppC; dipeptide transport system permease protein Dipeptide transport system Transporters TRUE
+K12371 dppD; dipeptide transport system ATP-binding protein Dipeptide transport system Transporters TRUE
+K12372 dppF; dipeptide transport system ATP-binding protein Dipeptide transport system Transporters TRUE
+K11004 "hlyB; ATP-binding cassette, subfamily B, bacterial HlyB/CyaB" alpha-Hemolysin/cyclolysin transport system Transporters TRUE
+K11003 hlyD; hemolysin D alpha-Hemolysin/cyclolysin transport system Transporters TRUE
+K12340 tolC; outer membrane channel protein TolC alpha-Hemolysin/cyclolysin transport system Transporters TRUE
+K12530 "rtxB; ATP-binding cassette, subfamily B, bacterial RtxB" RTX toxin transport system Transporters TRUE
+K12531 "rtxE; ATP-binding cassette, subfamily B, bacterial RtxE" RTX toxin transport system Transporters TRUE
+K12532 rtxD; RTX toxin transporter RTX toxin transport system Transporters TRUE
+K12340 tolC; outer membrane channel protein TolC RTX toxin transport system Transporters TRUE
+K12533 "rsaD; ATP-binding cassette, subfamily C, bacterial RsaD" S-Layer protein transport system Transporters TRUE
+K12534 rsaE; membrane fusion protein RsaE S-Layer protein transport system Transporters TRUE
+K12535 rsaF; outer membrane protein RsaF S-Layer protein transport system Transporters TRUE
+K12536 "hasD; ATP-binding cassette, subfamily C, bacterial HasD" Hemophore/metalloprotease transport system Transporters TRUE
+K12537 hasE; protease secretion protein HasE Hemophore/metalloprotease transport system Transporters TRUE
+K12538 hasF; outer membrane protein HasF Hemophore/metalloprotease transport system Transporters TRUE
+K12539 "prsD; ATP-binding cassette, subfamily C, bacterial PrsD" Multiple protein transport system Transporters TRUE
+K12540 prsE; membrane fusion protein PrsE Multiple protein transport system Transporters TRUE
+K12541 "lapB; ATP-binding cassette, subfamily C, bacterial LapB" Adhesin protein transport system Transporters TRUE
+K12542 lapC; membrane fusion protein LapC Adhesin protein transport system Transporters TRUE
+K12543 lapE; outer membrane protein LapE Adhesin protein transport system Transporters TRUE
+K13889 gsiB; glutathione transport system substrate-binding protein Glutathione transport system Transporters TRUE
+K13890 gsiC; glutathione transport system permease protein Glutathione transport system Transporters TRUE
+K13891 gsiD; glutathione transport system permease protein Glutathione transport system Transporters TRUE
+K13892 gsiA; glutathione transport system ATP-binding protein Glutathione transport system Transporters TRUE
+K13893 yejA; microcin C transport system substrate-binding protein Microcin C transport system Transporters TRUE
+K13894 yejB; microcin C transport system permease protein Microcin C transport system Transporters TRUE
+K13895 yejE; microcin C transport system permease protein Microcin C transport system Transporters TRUE
+K13896 yejF; microcin C transport system ATP-binding protein Microcin C transport system Transporters TRUE
+K15551 tauA; taurine transport system substrate-binding protein Taurine transport system Transporters TRUE
+K15552 tauC; taurine transport system permease protein Taurine transport system Transporters TRUE
+K10831 tauB; taurine transport system ATP-binding protein [EC:3.6.3.36] Taurine transport system Transporters TRUE
+K15553 ssuA; sulfonate transport system substrate-binding protein Sulfonate transport system Transporters TRUE
+K15554 ssuC; sulfonate transport system permease protein Sulfonate transport system Transporters TRUE
+K15555 ssuB; sulfonate transport system ATP-binding protein [EC:3.6.3.-] Sulfonate transport system Transporters TRUE
+K15556 ophF; phthalate transport system substrate-binding protein Phthalate transport system Transporters TRUE
+K15557 ophG; phthalate transport system permease protein Phthalate transport system Transporters TRUE
+K15558 ophH; phthalate transport system ATP-binding protein Phthalate transport system Transporters TRUE
+K15580 oppA; oligopeptide transport system substrate-binding protein Oligopeptide transport system Transporters TRUE
+K15581 oppB; oligopeptide transport system permease protein Oligopeptide transport system Transporters TRUE
+K15582 oppC; oligopeptide transport system permease protein Oligopeptide transport system Transporters TRUE
+K15583 oppD; oligopeptide transport system ATP-binding protein Oligopeptide transport system Transporters TRUE
+K10823 oppF; oligopeptide transport system ATP-binding protein Oligopeptide transport system Transporters TRUE
+K15584 nikA; nickel transport system substrate-binding protein Nickel transport system Transporters TRUE
+K15585 nikB; nickel transport system permease protein Nickel transport system Transporters TRUE
+K15586 nikC; nickel transport system permease protein Nickel transport system Transporters TRUE
+K15587 nikD; nickel transport system ATP-binding protein [EC:3.6.3.24] Nickel transport system Transporters TRUE
+K10824 nikE; nickel transport system ATP-binding protein [EC:3.6.3.24] Nickel transport system Transporters TRUE
+K15598 thiY; putative hydroxymethylpyrimidine transport system substrate-binding protein Putative hydroxymethylpyrimidine transport system Transporters TRUE
+K15599 thiX; putative hydroxymethylpyrimidine transport system permease protein Putative hydroxymethylpyrimidine transport system Transporters TRUE
+K15600 thiZ; putative hydroxymethylpyrimidine transport system ATP-binding protein Putative hydroxymethylpyrimidine transport system Transporters TRUE
+K03523 bioY; biotin transport system substrate-specific component Biotin transport system Transporters TRUE
+K16783 bioN; biotin transport system permease protein Biotin transport system Transporters TRUE
+K16784 bioM; biotin transport system ATP-binding protein [EC:3.6.3.-] Biotin transport system Transporters TRUE
+K03523 bioY; biotin transport system substrate-specific component Energy-coupling factor transport system Transporters TRUE
+K16923 qrtT; energy-coupling factor transport system substrate-specific component Energy-coupling factor transport system Transporters TRUE
+K16924 mtsT; energy-coupling factor transport system substrate-specific component Energy-coupling factor transport system Transporters TRUE
+K16925 ykoE; energy-coupling factor transport system substrate-specific component Energy-coupling factor transport system Transporters TRUE
+K16926 htsT; energy-coupling factor transport system substrate-specific component Energy-coupling factor transport system Transporters TRUE
+K16927 cbrT; energy-coupling factor transport system substrate-specific component Energy-coupling factor transport system Transporters TRUE
+K16928 mtaT; energy-coupling factor transport system substrate-specific component Energy-coupling factor transport system Transporters TRUE
+K16929 K16929; energy-coupling factor transport system substrate-specific component Energy-coupling factor transport system Transporters TRUE
+K16785 ecfT; energy-coupling factor transport system permease protein Energy-coupling factor transport system Transporters TRUE
+K16786 ecfA1; energy-coupling factor transport system ATP-binding protein [EC:3.6.3.-] Energy-coupling factor transport system Transporters TRUE
+K16787 ecfA2; energy-coupling factor transport system ATP-binding protein [EC:3.6.3.-] Energy-coupling factor transport system Transporters TRUE
+K16916 yydJ; putative peptide transport system permease protein Putative peptide transport system Transporters TRUE
+K16917 yydI; putative peptide transport system ATP-binding protein Putative peptide transport system Transporters TRUE
+K16918 ytrF; acetoin utilization transport system permease protein Acetoin utilization transport system Transporters TRUE
+K16919 ytrC_D; acetoin utilization transport system permease protein Acetoin utilization transport system Transporters TRUE
+K16920 ytrE; acetoin utilization transport system ATP-binding protein Acetoin utilization transport system Transporters TRUE
+K16921 ytrB; acetoin utilization transport system ATP-binding protein Acetoin utilization transport system Transporters TRUE
+K16956 tcyJ; L-cystine transport system substrate-binding protein L-Cystine transport system Transporters TRUE
+K16957 tcyK; L-cystine transport system substrate-binding protein L-Cystine transport system Transporters TRUE
+K16958 tcyL; L-cystine transport system permease protein L-Cystine transport system Transporters TRUE
+K16959 tcyM; L-cystine transport system permease protein L-Cystine transport system Transporters TRUE
+K16960 tcyN; L-cystine transport system ATP-binding protein [EC:7.4.2.1] L-Cystine transport system Transporters TRUE
+K16961 yxeM; putative S-methylcysteine transport system substrate-binding protein Putative S-methylcysteine transport system Transporters TRUE
+K16962 yxeN; putative S-methylcysteine transport system permease protein Putative S-methylcysteine transport system Transporters TRUE
+K16963 yxeO; putative S-methylcysteine transport system ATP-binding protein Putative S-methylcysteine transport system Transporters TRUE
+K17062 bgtB; arginine/lysine/histidine/glutamine transport system substrate-binding and permease protein Arginine/lysine/histidine/glutamine transport system Transporters TRUE
+K17063 bgtA; arginine/lysine/histidine/glutamine transport system ATP-binding protein Arginine/lysine/histidine/glutamine transport system Transporters TRUE
+K17073 lysX1; putative lysine transport system substrate-binding protein Putative lysine transport system Transporters TRUE
+K17074 lysX2; putative lysine transport system permease protein Putative lysine transport system Transporters TRUE
+K17076 lysY; putative lysine transport system ATP-binding protein [EC:7.4.2.1] Putative lysine transport system Transporters TRUE
+K17202 K17202; erythritol transport system substrate-binding protein Erythritol transport system Transporters TRUE
+K17203 K17203; erythritol transport system permease protein Erythritol transport system Transporters TRUE
+K17204 eryE; erythritol transport system ATP-binding protein [COGCOG1129] Erythritol transport system Transporters TRUE
+K17205 xltC; putative xylitol transport system substrate-binding protein Putative xylitol transport system Transporters TRUE
+K17206 xltB; putative xylitol transport system permease protein Putative xylitol transport system Transporters TRUE
+K17207 xltA; putative xylitol transport system ATP-binding protein Putative xylitol transport system Transporters TRUE
+K17208 K17208; inositol transport system substrate-binding protein Inositol transport system Transporters TRUE
+K17209 iatP; inositol transport system permease protein Inositol transport system Transporters TRUE
+K17210 iatA; inositol transport system ATP-binding protein Inositol transport system Transporters TRUE
+K17213 K17213; inositol transport system substrate-binding protein Inositol transport system Transporters TRUE
+K17214 K17214; inositol transport system permease protein Inositol transport system Transporters TRUE
+K17215 K17215; inositol transport system ATP-binding protein Inositol transport system Transporters TRUE
+K17237 inoE; inositol-phosphate transport system substrate-binding protein Inositol-phosphate transport system Transporters TRUE
+K17238 inoF; inositol-phosphate transport system permease protein Inositol-phosphate transport system Transporters TRUE
+K17239 inoG; inositol-phosphate transport system permease protein Inositol-phosphate transport system Transporters TRUE
+K17240 inoK; inositol-phosphate transport system ATP-binding protein Inositol-phosphate transport system Transporters TRUE
+K17241 "aguE; alpha-1,4-digalacturonate transport system substrate-binding protein" "alpha-1,4-Digalacturonate transport system" Transporters TRUE
+K17242 "aguF; alpha-1,4-digalacturonate transport system permease protein" "alpha-1,4-Digalacturonate transport system" Transporters TRUE
+K17243 "aguG; alpha-1,4-digalacturonate transport system permease protein" "alpha-1,4-Digalacturonate transport system" Transporters TRUE
+K17244 chiE; putative chitobiose transport system substrate-binding protein Putative chitobiose transport system Transporters TRUE
+K17245 chiF; putative chitobiose transport system permease protein Putative chitobiose transport system Transporters TRUE
+K17246 chiG; putative chitobiose transport system permease protein Putative chitobiose transport system Transporters TRUE
+K17234 araN; arabinosaccharide transport system substrate-binding protein Arabinosaccharide transport system Transporters TRUE
+K17235 araP; arabinosaccharide transport system permease protein Arabinosaccharide transport system Transporters TRUE
+K17236 araQ; arabinosaccharide transport system permease protein Arabinosaccharide transport system Transporters TRUE
+K10112 msmX; multiple sugar transport system ATP-binding protein Arabinosaccharide transport system Transporters TRUE
+K17318 lplA; putative aldouronate transport system substrate-binding protein Putative aldouronate transport system Transporters TRUE
+K17319 lplB; putative aldouronate transport system permease protein Putative aldouronate transport system Transporters TRUE
+K17320 lplC; putative aldouronate transport system permease protein Putative aldouronate transport system Transporters TRUE
+K17311 K17311; trehalose transport system substrate-binding protein Trehalose transport system Transporters TRUE
+K17312 K17312; trehalose transport system permease protein Trehalose transport system Transporters TRUE
+K17313 treU; trehalose transport system permease protein Trehalose transport system Transporters TRUE
+K17314 treV; trehalose transport system ATP-binding protein Trehalose transport system Transporters TRUE
+K17315 gtsA; glucose/mannose transport system substrate-binding protein Glucose/mannose transport system Transporters TRUE
+K17316 gtsB; glucose/mannose transport system permease protein Glucose/mannose transport system Transporters TRUE
+K17317 gtsC; glucose/mannose transport system permease protein Glucose/mannose transport system Transporters TRUE
+K10112 msmX; multiple sugar transport system ATP-binding protein Glucose/mannose transport system Transporters TRUE
+K17329 "dasA; N,N'-diacetylchitobiose transport system substrate-binding protein" "N,N'-Diacetylchitobiose transport system" Transporters TRUE
+K17330 "dasB; N,N'-diacetylchitobiose transport system permease protein" "N,N'-Diacetylchitobiose transport system" Transporters TRUE
+K17331 "dasC; N,N'-diacetylchitobiose transport system permease protein" "N,N'-Diacetylchitobiose transport system" Transporters TRUE
+K10112 msmX; multiple sugar transport system ATP-binding protein "N,N'-Diacetylchitobiose transport system" Transporters TRUE
+K17321 glpV; glycerol transport system substrate-binding protein Glycerol transport system Transporters TRUE
+K17322 glpP; glycerol transport system permease protein Glycerol transport system Transporters TRUE
+K17323 glpQ; glycerol transport system permease protein Glycerol transport system Transporters TRUE
+K17324 glpS; glycerol transport system ATP-binding protein Glycerol transport system Transporters TRUE
+K17325 glpT; glycerol transport system ATP-binding protein Glycerol transport system Transporters TRUE
+K17464 "PTS-Dga-EIIA; PTS system, D-glucosaminate-specific IIA component" "PTS system, D-glucosaminate-specific II component" Transporters TRUE
+K17465 "PTS-Dga-EIIB; PTS system, D-glucosaminate-specific IIB component" "PTS system, D-glucosaminate-specific II component" Transporters TRUE
+K17466 "PTS-Dga-EIIC; PTS system, D-glucosaminate-specific IIC component" "PTS system, D-glucosaminate-specific II component" Transporters TRUE
+K17467 "PTS-Dga-EIID; PTS system, D-glucosaminate-specific IID component" "PTS system, D-glucosaminate-specific II component" Transporters TRUE
+K17326 bxlE; xylobiose transport system substrate-binding protein Xylobiose transport system Transporters TRUE
+K17327 bxlF; xylobiose transport system permease protein Xylobiose transport system Transporters TRUE
+K17328 bxlG; xylobiose transport system permease protein Xylobiose transport system Transporters TRUE
+K18233 oleC5; oleandomycin transport system permease protein Oleandomycin transport system Transporters TRUE
+K18232 oleC4; oleandomycin transport system ATP-binding protein Oleandomycin transport system Transporters TRUE
+K18216 "steA; ATP-binding cassette, subfamily B, tetracycline resistant protein" "Tetracycline resistance, TetAB(46) transporter" Transporters TRUE
+K18217 "steB; ATP-binding cassette, subfamily B, tetracycline resistant protein" "Tetracycline resistance, TetAB(46) transporter" Transporters TRUE
+K18476 "tetR; TetR/AcrR family transcriptional regulator, tetracycline repressor protein" "Tetracycline resistance, TetA transporter" Transporters TRUE
+K08151 "tetA; MFS transporter, DHA1 family, tetracycline resistance protein" "Tetracycline resistance, TetA transporter" Transporters TRUE
+K02067 "mlaD, linM; phospholipid/cholesterol/gamma-HCH transport system substrate-binding protein" gamma-Hexachlorocyclohexane transport system Transporters TRUE
+K02066 "mlaE, linK; phospholipid/cholesterol/gamma-HCH transport system permease protein" gamma-Hexachlorocyclohexane transport system Transporters TRUE
+K02065 "mlaF, linL, mkl; phospholipid/cholesterol/gamma-HCH transport system ATP-binding protein" gamma-Hexachlorocyclohexane transport system Transporters TRUE
+K18480 linN; cholesterol transport system auxiliary component gamma-Hexachlorocyclohexane transport system Transporters TRUE
+K02067 "mlaD, linM; phospholipid/cholesterol/gamma-HCH transport system substrate-binding protein" Mce transport system Transporters TRUE
+K02066 "mlaE, linK; phospholipid/cholesterol/gamma-HCH transport system permease protein" Mce transport system Transporters TRUE
+K02065 "mlaF, linL, mkl; phospholipid/cholesterol/gamma-HCH transport system ATP-binding protein" Mce transport system Transporters TRUE
+K18481 mas; Mce-associated membrane protein Mce transport system Transporters TRUE
+K19083 braD; bacitracin transport system ATP-binding protein "Bacitracin resistance, VraDE transporter" Transporters TRUE
+K19084 braE; bacitracin transport system permease protein "Bacitracin resistance, VraDE transporter" Transporters TRUE
+K19081 "braS; two-component system, OmpR family, sensor histidine kinase BraS/BceS [EC:2.7.13.3]" "Bacitracin resistance, VraDE transporter" Transporters TRUE
+K19082 "braR; two-component system, OmpR family, response regulator protein BraR/BceR" "Bacitracin resistance, VraDE transporter" Transporters TRUE
+K11631 bceA; bacitracin transport system ATP-binding protein "Bacitracin resistance, VraDE transporter" Transporters TRUE
+K11632 bceB; bacitracin transport system permease protein "Bacitracin resistance, VraDE transporter" Transporters TRUE
+K11629 "bceS; two-component system, OmpR family, bacitracin resistance sensor histidine kinase BceS [EC:2.7.13.3]" "Bacitracin resistance, BceAB transporter" Transporters TRUE
+K11630 "bceR; two-component system, OmpR family, bacitracin resistance response regulator BceR" "Bacitracin resistance, BceAB transporter" Transporters TRUE
+K11631 bceA; bacitracin transport system ATP-binding protein "Bacitracin resistance, BceAB transporter" Transporters TRUE
+K11632 bceB; bacitracin transport system permease protein "Bacitracin resistance, BceAB transporter" Transporters TRUE
+K19226 sapA; cationic peptide transport system substrate-binding protein Cationic peptide transport system Transporters TRUE
+K19227 sapB; cationic peptide transport system permease protein Cationic peptide transport system Transporters TRUE
+K19228 sapC; cationic peptide transport system permease protein Cationic peptide transport system Transporters TRUE
+K19229 sapD; cationic peptide transport system ATP-binding protein Cationic peptide transport system Transporters TRUE
+K19230 sapF; cationic peptide transport system ATP-binding protein Cationic peptide transport system Transporters TRUE
+K19506 "PTS-Gfr-EIIA; PTS system, fructoselysine/glucoselysine-specific IIA component" "PTS system, fructoselysine/glucoselysine-specific II component" Transporters TRUE
+K19507 "PTS-Gfr-EIIB; PTS system, fructoselysine/glucoselysine-specific IIB component" "PTS system, fructoselysine/glucoselysine-specific II component" Transporters TRUE
+K19508 "PTS-Gfr-EIIC; PTS system, fructoselysine/glucoselysine-specific IIC component" "PTS system, fructoselysine/glucoselysine-specific II component" Transporters TRUE
+K19509 "PTS-Gfr-EIID; PTS system, fructoselysine/glucoselysine-specific IID component" "PTS system, fructoselysine/glucoselysine-specific II component" Transporters TRUE
+K19971 psaA; manganese/zinc transport system substrate-binding protein Manganese/zinc transport system Transporters TRUE
+K19972 psaC; manganese/zinc transport system permease protein Manganese/zinc transport system Transporters TRUE
+K10830 psaB; manganese/zinc transport system ATP-binding protein [EC:3.6.3.35] Manganese/zinc transport system Transporters TRUE
+K19975 mntC; manganese/zinc transport system substrate-binding protein Manganese/zinc transport system Transporters TRUE
+K19976 mntB; manganese/zinc transport system permease protein Manganese/zinc transport system Transporters TRUE
+K19973 mntA; manganese/zinc transport system ATP-binding protein [EC:3.6.3.35] Manganese/zinc transport system Transporters TRUE
+K02777 "PTS-Glc-EIIA; PTS system, glucose-specific IIA component" "PTS system, maltose-specific II component" Transporters TRUE
+K20107 "PTS-Mal-EIIB; PTS system, maltose-specific IIB component" "PTS system, maltose-specific II component" Transporters TRUE
+K20108 "PTS-Mal-EIIC; PTS system, maltose-specific IIC component" "PTS system, maltose-specific II component" Transporters TRUE
+K20112 "PTS-Gal-EIIA; PTS system, galactose-specific IIA component" "PTS system, galactose-specific II component" Transporters TRUE
+K20113 "PTS-Gal-EIIB; PTS system, galactose-specific IIB component" "PTS system, galactose-specific II component" Transporters TRUE
+K20114 "PTS-Gal-EIIC; PTS system, galactose-specific IIC component" "PTS system, galactose-specific II component" Transporters TRUE
+K20116 "PTS-Glc1-EIIA; PTS system, glucose-specific IIA component" "PTS system, glucose-specific II component" Transporters TRUE
+K20117 "PTS-Glc1-EIIB; PTS system, glucose-specific IIB component" "PTS system, glucose-specific II component" Transporters TRUE
+K20118 "PTS-Glc1-EIIC; PTS system, glucose-specific IIC component" "PTS system, glucose-specific II component" Transporters TRUE
+K20459 nukF; lantibiotic transport system ATP-binding protein Lantibiotic transport system Transporters TRUE
+K20460 nukE; lantibiotic transport system permease protein Lantibiotic transport system Transporters TRUE
+K20461 nukG; lantibiotic transport system permease protein Lantibiotic transport system Transporters TRUE
+K20491 nisE; lantibiotic transport system permease protein Lantibiotic transport system Transporters TRUE
+K20492 nisG; lantibiotic transport system permease protein Lantibiotic transport system Transporters TRUE
+K20494 epiG; lantibiotic transport system permease protein Lantibiotic transport system Transporters TRUE
+K20490 nisF; lantibiotic transport system ATP-binding protein Lantibiotic transport system Transporters TRUE
+K23055 putative lysine/arginine/ornithine/histidine/octopine transport system substrate-binding protein Putative lysine/arginine/ornithine/histidine/octopine transport system Transporters TRUE
+K23056 putative lysine/arginine/ornithine/histidine/octopine transport system permease protein Putative lysine/arginine/ornithine/histidine/octopine transport system Transporters TRUE
+K23057 putative lysine/arginine/ornithine/histidine/octopine transport system permease protein Putative lysine/arginine/ornithine/histidine/octopine transport system Transporters TRUE
+K23058 putative lysine/arginine/ornithine/histidine/octopine transport system ATPase-binding protein [EC:7.4.2.1] Putative lysine/arginine/ornithine/histidine/octopine transport system Transporters TRUE
+K23060 artR; arginine/lysine/histidine transport system ATP-binding protein [EC:7.4.2.1] Arginine/lysine/histidine transport system Transporters TRUE
+K23059 artP; arginine/lysine/histidine transporter system substrate-binding protein Arginine/lysine/histidine transport system Transporters TRUE
+K17077 artQ; arginine/lysine/histidine transport system permease protein Arginine/lysine/histidine transport system Transporters TRUE
+K23061 lhpP; hydroxyproline transporter system substrate-binding protein Hydroxyproline transporter system Transporters TRUE
+K23062 lhpM; hydroxyproline transport system permease protein Hydroxyproline transporter system Transporters TRUE
+K23063 lhpN; hydroxyproline transport system permease protein Hydroxyproline transporter system Transporters TRUE
+K23064 lhpO; hydroxyproline transport system ATP-binding protein [EC:7.4.2.1] Hydroxyproline transporter system Transporters TRUE
+K15495 wtpC; molybdate/tungstate transport system substrate-binding protein Molybdate/tungstate transport system Transporters TRUE
+K15496 wtpB; molybdate/tungstate transport system permease protein Molybdate/tungstate transport system Transporters TRUE
+K15497 wtpA; molybdate/tungstate transport system ATP-binding protein [EC:3.6.3.-] Molybdate/tungstate transport system Transporters TRUE
+K16199 dppE; dipeptide transport system substrate-binding protein "Dipeptide transport system, Firmicutes" Transporters TRUE
+K16200 dppB1; dipeptide transport system permease protein "Dipeptide transport system, Firmicutes" Transporters TRUE
+K16201 dppC1; dipeptide transport system permease protein "Dipeptide transport system, Firmicutes" Transporters TRUE
+K16202 dppD1; dipeptide transport system ATP-binding protein "Dipeptide transport system, Firmicutes" Transporters TRUE
+K05810 polyphenol oxidase polyphenols carbon utilization Polyphenolics Cleavage TRUE
+K00422 polyphenol oxidase polyphenols carbon utilization Polyphenolics Cleavage TRUE
+K05909 polyphenol oxidase polyphenols carbon utilization Polyphenolics Cleavage TRUE
+K07016 "csm1, cas10; CRISPR-associated protein Csm1" Type III signiture cas proteins MISC CRISPR Type III CRISPR-Cas system FALSE
+K19138 csm2; CRISPR-associated protein Csm2 Subtype III-A factors MISC CRISPR Type III CRISPR-Cas system FALSE
+K09002 csm3; CRISPR-associated protein Csm3 Subtype III-A factors MISC CRISPR Type III CRISPR-Cas system FALSE
+K19139 csm4; CRISPR-associated protein Csm4 Subtype III-A factors MISC CRISPR Type III CRISPR-Cas system FALSE
+K19140 csm5; CRISPR-associated protein Csm5 Subtype III-A factors MISC CRISPR Type III CRISPR-Cas system FALSE
+K07061 cmr1; CRISPR-associated protein Cmr1 Subtype III-B factors MISC CRISPR Type III CRISPR-Cas system FALSE
+K19076 "cmr2, cas10; CRISPR-associated protein Cmr2" Subtype III-B factors MISC CRISPR Type III CRISPR-Cas system FALSE
+K09127 cmr3; CRISPR-associated protein Cmr3 Subtype III-B factors MISC CRISPR Type III CRISPR-Cas system FALSE
+K09000 cmr4; CRISPR-associated protein Cmr4 Subtype III-B factors MISC CRISPR Type III CRISPR-Cas system FALSE
+K19141 cmr5; CRISPR-associated protein Cmr5 Subtype III-B factors MISC CRISPR Type III CRISPR-Cas system FALSE
+K19142 cmr6; CRISPR-associated protein Cmr6 Subtype III-B factors MISC CRISPR Type III CRISPR-Cas system FALSE
+K19143 csx1; CRISPR-associated protein Csx1 Subtype III-U factors MISC CRISPR Type III CRISPR-Cas system FALSE
+K19144 csx3; CRISPR-associated protein Csx3 Subtype III-U factors MISC CRISPR Type III CRISPR-Cas system FALSE
+K19145 csx16; CRISPR-associated protein Csx16 Subtype III-U factors MISC CRISPR Type III CRISPR-Cas system FALSE
+K19146 csaX; CRISPR-associated protein CsaX Subtype III-U factors MISC CRISPR Type III CRISPR-Cas system FALSE
+K09952 "csn1, cas9; CRISPR-associated endonuclease Csn1 [EC:3.1.-.-]" Type II signiture cas proteins MISC CRISPR Type II CRISPR-Cas system FALSE
+K19137 csn2; CRISPR-associated protein Csn2 Subtype II-A factors MISC CRISPR Type II CRISPR-Cas system FALSE
+K07464 cas4; CRISPR-associated exonuclease Cas4 [EC:3.1.12.1] Subtype II-B factors MISC CRISPR Type II CRISPR-Cas system FALSE
+K07012 cas3; CRISPR-associated endonuclease/helicase Cas3 [EC:3.1.-.- 3.6.4.-] Type I signiture cas proteins MISC CRISPR Type I CRISPR-Cas system FALSE
+K07475 cas3; CRISPR-associated endonuclease Cas3-HD [EC:3.1.-.-] Type I signiture cas proteins MISC CRISPR Type I CRISPR-Cas system FALSE
+K19085 csa1; CRISPR-associated protein Csa1 Subtype I-A factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19074 csa2; CRISPR-associated protein Csa2 Subtype I-A factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K07725 csa3; CRISPR-associated protein Csa3 Subtype I-A factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19086 "csa4, cas8a2; CRISPR-associated protein Csa4" Subtype I-A factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19087 csa5; CRISPR-associated protein Csa5 Subtype I-A factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19088 "cst1, cas8a; CRISPR-associated protein Cst1" Subtype I-A factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19075 "cst2, cas7; CRISPR-associated protein Cst2" Subtype I-A factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K07464 cas4; CRISPR-associated exonuclease Cas4 [EC:3.1.12.1] Subtype I-A factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19089 cas5a_b_c; CRISPR-associated protein Cas5a/b/c Subtype I-A factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19090 cas5t; CRISPR-associated protein Cas5t Subtype I-A factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19091 cas6; CRISPR-associated endoribonuclease Cas6 [EC:3.1.-.-] Subtype I-A factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19114 csh1; CRISPR-associated protein Csh1 Subtype I-B factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19115 csh2; CRISPR-associated protein Csh2 Subtype I-B factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K07464 cas4; CRISPR-associated exonuclease Cas4 [EC:3.1.12.1] Subtype I-B factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19116 cas5h; CRISPR-associated protein Cas5h Subtype I-B factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19117 "csd1, cas8c; CRISPR-associated protein Csd1" Subtype I-C factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19118 "csd2, cas7; CRISPR-associated protein Csd2" Subtype I-C factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K07464 cas4; CRISPR-associated exonuclease Cas4 [EC:3.1.12.1] Subtype I-C factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19119 cas5d; CRISPR-associated protein Cas5d Subtype I-C factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19120 csc1; CRISPR-associated protein Csc1 Subtype I-D factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19121 csc2; CRISPR-associated protein Csc2 Subtype I-D factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19122 csc3; CRISPR-associated protein Csc3 Subtype I-D factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K07464 cas4; CRISPR-associated exonuclease Cas4 [EC:3.1.12.1] Subtype I-D factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19091 cas6; CRISPR-associated endoribonuclease Cas6 [EC:3.1.-.-] Subtype I-D factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19123 "casA, cse1; CRISPR system Cascade subunit CasA" Subtype I-E factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19046 "casB, cse2; CRISPR system Cascade subunit CasB" Subtype I-E factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19124 "casC, cse4; CRISPR system Cascade subunit CasC" Subtype I-E factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19125 "casD, cse5; CRISPR system Cascade subunit CasD" Subtype I-E factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19126 "casE, cse3; CRISPR system Cascade subunit CasE" Subtype I-E factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19127 csy1; CRISPR-associated protein Csy1 Subtype I-F factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19128 csy2; CRISPR-associated protein Csy2 Subtype I-F factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19129 csy3; CRISPR-associated protein Csy3 Subtype I-F factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19130 "csy4, cas6f; CRISPR-associated endonuclease Csy4 [EC:3.1.-.-]" Subtype I-F factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19131 csb1; CRISPR-associated protein Csb1 Subtype I-U factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19132 csb2; CRISPR-associated protein Csb2 Subtype I-U factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19133 csb3; CRISPR-associated protein Csb3 Subtype I-U factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19134 csx10; CRISPR-associated protein Csx10 Subtype I-U factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19135 csx14; CRISPR-associated protein Csx14 Subtype I-U factors MISC CRISPR Type I CRISPR-Cas system FALSE
+K19136 csx17; CRISPR-associated protein Csx17 Subtype I-U factors MISC CRISPR Type I CRISPR-Cas system FALSE
+A02H Catlytic type: Aspartate; maximally active in the range pH 4-6 Endopeptidases Organic Nitrogen Peptidase FALSE
+A02G Catlytic type: Aspartate; maximally active in the range pH 4-6 Endopeptidases Organic Nitrogen Peptidase FALSE
+A02F Catlytic type: Aspartate; maximally active in the range pH 4-6 Endopeptidases Organic Nitrogen Peptidase FALSE
+A02E Catlytic type: Aspartate; maximally active in the range pH 4-6 Endopeptidases Organic Nitrogen Peptidase FALSE
+A02D Catlytic type: Aspartate; maximally active in the range pH 4-6 Endopeptidases Organic Nitrogen Peptidase FALSE
+A02C Catlytic type: Aspartate; maximally active in the range pH 4-6 Endopeptidases Organic Nitrogen Peptidase FALSE
+A02B Catlytic type: Aspartate; maximally active in the range pH 4-6 Endopeptidases Organic Nitrogen Peptidase FALSE
+A02A Catlytic type: Aspartate; maximally active in the range pH 4-6 Endopeptidases Organic Nitrogen Peptidase FALSE
+A03B Catlytic type: Aspartate; Several cleavage sites are thought to exist; The peptidases in family A3 are the polyprotein-processing endopeptidases of the pararetroviruses; LeuAla cleavage site found within a highly hydrophobic region has been identified for one member Endopeptidases Organic Nitrogen Peptidase FALSE
+A03A Catlytic type: Aspartate; Several cleavage sites are thought to exist; The peptidases in family A3 are the polyprotein-processing endopeptidases of the pararetroviruses; LeuAla cleavage site found within a highly hydrophobic region has been identified for one member Endopeptidases Organic Nitrogen Peptidase FALSE
+A11B Catlytic type: Aspartate; performs all the cleavages that occur in the polyproteins; initial cleavage in the Gag-Pol polyprotein exposes the N-terminus of the endopeptidase and is an essential prerequisite for the other cleavages to occur Endopeptidases involved in the processing of polyproteins encoded by retrotransposons Organic Nitrogen Peptidase FALSE
+A11A Catlytic type: Aspartate; performs all the cleavages that occur in the polyproteins; initial cleavage in the Gag-Pol polyprotein exposes the N-terminus of the endopeptidase and is an essential prerequisite for the other cleavages to occur Endopeptidases involved in the processing of polyproteins encoded by retrotransposons Organic Nitrogen Peptidase FALSE
+A22B "Catlytic type: Aspartate; See Additional Information; Functional in Alzheimer's disease; Beta peptides are derived from an internal segment (about 42 amino acids) of the large Alzheimers precursor protein that is excised by peptidase activities known as 'beta-secretase' (cleaving at the N-terminus of the beta-peptide) and 'gamma-secretase' (cleaving at the C-terminus). The gamma-secretase cleavage occurs in a transmembrane segment of the APP, and is mediated by presenilin in complex with nicastrin, APH-1 and PEN-2. A third activity termed 'alpha-secretase' degrades the beta-peptide, making it harmless. More than one individual peptidase may be responsible for each of the secretase activities." Membrane-inserted endopeptidases Organic Nitrogen Peptidase FALSE
+A22A "Catlytic type: Aspartate; See Additional Information; Functional in Alzheimer's disease; Beta peptides are derived from an internal segment (about 42 amino acids) of the large Alzheimers precursor protein that is excised by peptidase activities known as 'beta-secretase' (cleaving at the N-terminus of the beta-peptide) and 'gamma-secretase' (cleaving at the C-terminus). The gamma-secretase cleavage occurs in a transmembrane segment of the APP, and is mediated by presenilin in complex with nicastrin, APH-1 and PEN-2. A third activity termed 'alpha-secretase' degrades the beta-peptide, making it harmless. More than one individual peptidase may be responsible for each of the secretase activities." Membrane-inserted endopeptidases Organic Nitrogen Peptidase FALSE
+A33 Catlytic type: Aspartate Endopeptidases Organic Nitrogen Peptidase FALSE
+C01B Catlytic type: Cysteine; Dominant specificity subsite in most of the peptidases of subfamily C1A is S2; Family C1 peptidases contribute proteolytic activity to the digestive vacuoles of protozoa and to the lysosomal system of eukaryotic cells Many endopeptidases and a few exopeptidases Organic Nitrogen Peptidase FALSE
+C01A Catlytic type: Cysteine; Dominant specificity subsite in most of the peptidases of subfamily C1A is S2; Family C1 peptidases contribute proteolytic activity to the digestive vacuoles of protozoa and to the lysosomal system of eukaryotic cells Many endopeptidases and a few exopeptidases Organic Nitrogen Peptidase FALSE
+C02B "Catlytic type: Cysteine; hydrophobic residues (Tyr, Met, Leu, Val) and also Arg tend to be found in the P2 position; dependent on neutral pH" Endopeptidases termed calpains Organic Nitrogen Peptidase FALSE
+C02A "Catlytic type: Cysteine; hydrophobic residues (Tyr, Met, Leu, Val) and also Arg tend to be found in the P2 position; dependent on neutral pH" Endopeptidases termed calpains Organic Nitrogen Peptidase FALSE
+C03H Catlytic type: Cysteine; Bonds cleaved in processing the viral polyprotein are commonly -Gln-Gly- Endopeptidases of RNA viruses Organic Nitrogen Peptidase FALSE
+C03G Catlytic type: Cysteine; Bonds cleaved in processing the viral polyprotein are commonly -Gln-Gly- Endopeptidases of RNA viruses Organic Nitrogen Peptidase FALSE
+C03F Catlytic type: Cysteine; Bonds cleaved in processing the viral polyprotein are commonly -Gln-Gly- Endopeptidases of RNA viruses Organic Nitrogen Peptidase FALSE
+C03E Catlytic type: Cysteine; Bonds cleaved in processing the viral polyprotein are commonly -Gln-Gly- Endopeptidases of RNA viruses Organic Nitrogen Peptidase FALSE
+C03D Catlytic type: Cysteine; Bonds cleaved in processing the viral polyprotein are commonly -Gln-Gly- Endopeptidases of RNA viruses Organic Nitrogen Peptidase FALSE
+C03C Catlytic type: Cysteine; Bonds cleaved in processing the viral polyprotein are commonly -Gln-Gly- Endopeptidases of RNA viruses Organic Nitrogen Peptidase FALSE
+C03B Catlytic type: Cysteine; Bonds cleaved in processing the viral polyprotein are commonly -Gln-Gly- Endopeptidases of RNA viruses Organic Nitrogen Peptidase FALSE
+C03A Catlytic type: Cysteine; Bonds cleaved in processing the viral polyprotein are commonly -Gln-Gly- Endopeptidases of RNA viruses Organic Nitrogen Peptidase FALSE
+C04 Catlytic type: Cysteine; cleavage of GlnGly bonds in the processing of the viral polyprotein Cysteine endopeptidases of viruses Organic Nitrogen Peptidase FALSE
+C05 "Catlytic type: Cysteine; cleaves Xaa-Xbb-Gly-Xbb-Xbb type bonds, where Xaa is Met, Leu or Ile and Xbb is any amino acid ; processes the virus protein precursors by removing an N-terminal propeptide" Endopeptidase adenain Organic Nitrogen Peptidase FALSE
+C06 Catlytic type: Cysteine; cleavage site is -Tyr-Xaa-GlyGly-; serves a function in viral infectivity Cysteine endopeptidases of RNA viruses Organic Nitrogen Peptidase FALSE
+C07 Catlytic type: Cysteine; cleaves a single Gly|+|Gly bond; p29 peptidase is autocatylitically released during translation from the small polyprotein of the virus Contains only the p29 peptidase from chestnut blight hypovirus Organic Nitrogen Peptidase FALSE
+C08 Catlytic type: Cysteine; cleaves of a single Gly-Ala bond; p48 endopeptidase is autocatylitically released from the small polyprotein Contains only the p48 proteinase of the chestnut blight hypovirus Organic Nitrogen Peptidase FALSE
+C09 Catlytic type: Cysteine; cleaves at (Ala/Ile)-Gly-(Ala/Cys/Gly)(Ala/Tyr) site in the viral nonstructural polyproteins Viral cysteine endopeptidases Organic Nitrogen Peptidase FALSE
+C104 Catlytic type: Cysteine; cleaves the cell wall cross-linking peptide between D-Ala and Ala ; can cross epithelial cell membranes Cysteine endopeptidases Organic Nitrogen Peptidase FALSE
+C105 Catlytic type: Cysteine; Processing of polyprotein occurs at two glycyl bonds Polyprotein-processing cysteine endopeptidases Organic Nitrogen Peptidase FALSE
+C107 Catlytic type: Cysteine; preference for Asn in P2 and cleaves the polyprotein at two sites Polyprotein processing cysteine endopeptidases Organic Nitrogen Peptidase FALSE
+C108 Catlytic type: Cysteine; important for processing the N-terminal extension of ribosomal protein L27 Prp peptidase Organic Nitrogen Peptidase FALSE
+C113 Catlytic type: Cysteine; member is IgdE peptidase IgdE peptidase Organic Nitrogen Peptidase FALSE
+C14B "Catlytic type: Cysteine; All the peptidases of family C14 have a strict requirement for the amino acid in P1 to be aspartate, however the substrate specificities of the individual caspases are distinct and determined by the residues present in the pockets of P2, P3 and P4.; caspases that have strict specificity for the hydrolysis of aspartyl bonds" Cytosolic endopeptidases termed caspases that have strict specificity for the hydrolysis of aspartyl bonds Organic Nitrogen Peptidase FALSE
+C14A "Catlytic type: Cysteine; All the peptidases of family C14 have a strict requirement for the amino acid in P1 to be aspartate, however the substrate specificities of the individual caspases are distinct and determined by the residues present in the pockets of P2, P3 and P4.; caspases that have strict specificity for the hydrolysis of aspartyl bonds" Cytosolic endopeptidases termed caspases that have strict specificity for the hydrolysis of aspartyl bonds Organic Nitrogen Peptidase FALSE
+C16B Catlytic type: Cysteine; requirement for Phe in P6 in PLP2; Papain-like proteinase 1 and papain-like proteinase are both members of family C16 Polyprotein processing endopeptidases from coronaviruses Organic Nitrogen Peptidase FALSE
+C16A Catlytic type: Cysteine; a requirement for Arg or Lys in P5; Papain-like proteinase 1 and papain-like proteinase are both members of family C16 Polyprotein processing endopeptidases from coronaviruses Organic Nitrogen Peptidase FALSE
+C18 Catlytic type: Cysteine; cleaves at the 2/3 site; may be an essential step in the replication of hepatitis C virus Viral cysteine endopeptidase Organic Nitrogen Peptidase FALSE
+C19 Catlytic type: Cysteine; hydrolyse bonds involving the carboxyl group of the C-terminal Gly residue of ubiquitin; intracellular peptidases that remove ubiquitin molecules from polyubiquinated peptides by cleavage of isopeptide bonds Ubiquitinyl hydrolases Organic Nitrogen Peptidase FALSE
+C21 Catlytic type: Cysteine; cleavage of the 206-kDa polyprotein occurs in cis at a Ala-Thr bond; involved in the proteolytic maturation of turnip yellow mosaic virus (TYMV) Polyprotein processing endopeptidases from the single-stranded RNA viruses related to turnip yellow mosaic virus (tymoviruses) Organic Nitrogen Peptidase FALSE
+C23 "Catlytic type: Cysteine; leave in cis but not in trans, and an Ala-Asp cleavage site; peptidases of the family are necessary for the processing of the carlavirus polyproteins" Cysteine endopeptidases of single-stranded RNA viruses Organic Nitrogen Peptidase FALSE
+C24 "Catlytic type: Cysteine; substrate is the viral polyprotein with the majority of the identified cleavage sites being Glu in P1, and the remainder, Gln; P1 residue is commonly Gly; refers to single-stranded RNA viruses" Cysteine endopeptidases of single-stranded RNA viruses Organic Nitrogen Peptidase FALSE
+C26 Catlytic type: Cysteine; gamma-linked glutamate bonds Omega peptidase gamma-glutamyl hydrolase Organic Nitrogen Peptidase FALSE
+C27 Catlytic type: Cysteine; processes the non-structural polyprotein at Gly1300-Gly1301; non-structural polyprotein processing endopeptidase from the rubella virus Non-structural polyprotein processing endopeptidase from the rubella virus Organic Nitrogen Peptidase FALSE
+C28 Catlytic type: Cysteine; cleaves the host initiation factor eIF-4G firstly at Gly479-Arg480 and then at Lys318-Arg319; processing of viral polyprotein Viral processing endopeptidases Organic Nitrogen Peptidase FALSE
+C30 "Catlytic type: Cysteine; requirement for Gln at position P1;P1 may be occupied by small aliphatic residues; P2 Leu is usually found, but may be Ile, Tyr, Val, Phe or Met; P4 may contain Val, Ala, Ser or Tyr; processing of viral polyprotein" Endopeptidases from coronaviruses Organic Nitrogen Peptidase FALSE
+C31 "Catlytic type: Cysteine; cleaves the polyprotein C-terminal to the catalytic His, producing a 20- to 22-kDa product" Polyprotein processing endopeptidases from viruses Organic Nitrogen Peptidase FALSE
+C32 Catlytic type: Cysteine; cleaves a Gly-Gly bond just C-terminal to the active site His residue "Polyprotein-processing peptidase of arteriviruses, papain-like cysteine proteinase beta (PCP beta)" Organic Nitrogen Peptidase FALSE
+C33 Catlytic type: Cysteine; cleaves between two Gly residues Viral polyprotein-processing endopeptidase Organic Nitrogen Peptidase FALSE
+C36 Catlytic type: Cysteine; cleaves between the helicase and polymerase domains and is predicted to be 600 amino acids from the C-terminus of the protein Putative papain-like peptidase Organic Nitrogen Peptidase FALSE
+C37 Catlytic type: Cysteine; P1 residues in the cleavage sites are commonly Glu or Gln; responsible for all of the processing reactions in the ORF1 polyproteins of the caliciviruses "Calicivirin, a polyprotein-processing endopeptidases known from caliciviruses" Organic Nitrogen Peptidase FALSE
+C39 Catlytic type: Cysteine; cleave the 'double-glycine' leader peptides from the precursors of various bacteriocins Bacteriocin-processing endopeptidases from bacteria Organic Nitrogen Peptidase FALSE
+C40 "Catlytic type: Cysteine; hydrolyses substrates of the general structure L-Ala-gamma-D-GluL-Zaa-Yaa, in which Zaa is a di-amino acid such as L-lysine or diaminopimelic acid, and Yaa is D-Ala or D-Ala-D-Ala; expressed during sporulation, and is responsible for the degradation of bacterial cell wall components" Bacterial cell-wall modifying enzymes Organic Nitrogen Peptidase FALSE
+C42 "Catlytic type: Cysteine; cleaves a single Gly-Gly bond, releasing the N-terminal 66 kDa leader protein, which includes the peptidase; peptidase releases the N-terminal protein from the viral polyprotein" Polyprotein processing endopeptidases from closteroviruses Organic Nitrogen Peptidase FALSE
+C44 Catlytic type: Cysteine; the only known peptidase activity is the autolytic cleavage of the amidophosphoribosyltransferase precursor protein Self-processing precursor of amidophosphoribosyltransferase Organic Nitrogen Peptidase FALSE
+C46 "Catlytic type: Cysteine; autolytic cleavage occurs at a conserved -Gly-Cys- bond, and is mediated by the C-terminal domain of the hedgehog protein" "C-terminal, intein-like domains of the hedgehog proteins, which mediate autolytic cleavage of the proteins" Organic Nitrogen Peptidase FALSE
+C48 Catlytic type: Cysteine; demonstrates dual enzymic activity different to most deubiquitinating enzymes SUMO (small ubiquitin-like modifier) deconjugating enzymes Organic Nitrogen Peptidase FALSE
+C49 Catlytic type: Cysteine Strawberry mottle virus 3C-like peptidase Organic Nitrogen Peptidase FALSE
+C51 Catlytic type: Cysteine; bacteriophage phi11 cleaves the crosslinking peptide of the host at the D-Ala-Gly bond Endopeptidases that hydrolyse bacterial cell-wall crosslinking peptides Organic Nitrogen Peptidase FALSE
+C53 Catlytic type: Cysteine; releases itself from the N-terminus of the p20 polyprotein by an autolytic cleavage of the Cys168-Gly bond in cys; processing of viral polyprotein Endopeptidases that process the {Pestivirus} p20 polyprotein Organic Nitrogen Peptidase FALSE
+C57 "Catlytic type: Cysteine; P4b and P25K proteins are cleaved within an AlaGly-Ala motif, and AlaGly-Ser motif for P4a only; processing of smallpox viral protein" Endopeptidases that process the precursors of viral proteins Organic Nitrogen Peptidase FALSE
+C59 Catlytic type: Cysteine; autolytic cleavage of the penicillin V acylase precursor protein Cys-dependent Ntn-hydrolases Organic Nitrogen Peptidase FALSE
+C60B Catlytic type: Cysteine; consensus cleavage site is NPQT-N; catalyzes the formation of an amide bond between the new C-terminal Thr and a cell wall pentaglycine cross-bridge Bacterial peptidases with strong transferase activity Organic Nitrogen Peptidase FALSE
+C60A Catlytic type: Cysteine; consensus cleavage site is LPXT-G; catalyzes the formation of an amide bond between the new C-terminal Thr and a cell wall pentaglycine cross-bridge Bacterial peptidases with strong transferase activity Organic Nitrogen Peptidase FALSE
+C62 "Catlytic type: Cysteine; cleavage consensus site has been defined as -Val-Xaa-His-GluYaa, in which Yaa is Leu or Val; predicted to be the key enzyme in the processing of the GAV replicase polyprotein precursors, pp1a and pp1ab" Viral polyprotein-processing endopeptidase Organic Nitrogen Peptidase FALSE
+C63 Catlytic type: Cysteine; cleaves at -GlyGly-Xaa- sites to produce six major structural components of mature virions; required for the maturation of the virus (e.g. African swine fever virus) Endopeptidases Organic Nitrogen Peptidase FALSE
+C71 Endopeptidases that cleave crosslinking peptides of the archaean cell wall Endopeptidases that cleave crosslinking peptides of the archaean cell wall Organic Nitrogen Peptidase FALSE
+C74 "Catlytic type: Cysteine; cleavage between NS2 and NS3 of the viral polyprotein, a cleavage that is correlated with cytopathogenicity ; Contributes to maturation of the viral polyprotein" Viral self-processing peptidases Organic Nitrogen Peptidase FALSE
+C76 Catlytic type: Cysteine; releases of ubiquitin from proteins ubiquitinylated via Lys48; enzymes from herpes simplex virus Ubiquitinyl hydrolases Organic Nitrogen Peptidase FALSE
+C85B Catlytic type: Cysteine; cleaved the lysine-63-linked polyubiquitin chains on tumor necrosis factor receptor-associated factor 3 Deubiquitinylating peptidases Organic Nitrogen Peptidase FALSE
+C85A Catlytic type: Cysteine; cleaved the lysine-63-linked polyubiquitin chains on tumor necrosis factor receptor-associated factor 3 Deubiquitinylating peptidases Organic Nitrogen Peptidase FALSE
+C87 Catlytic type: Cysteine; deubiquitinylase and deISGylase activities Viral isopeptidases Organic Nitrogen Peptidase FALSE
+C89 Catlytic type: Cysteine Self-cleaving precursor protein Organic Nitrogen Peptidase FALSE
+C97 Catlytic type: Cysteine; localize in the cytoplasm SUMO (small ubiquitin-like modifier) deconjugating enzymes Organic Nitrogen Peptidase FALSE
+C99 "Catlytic type: Cysteine; releases itself from the viral polyprotein and cleavage occurs in trans; processes the viral polyprotein, releasing proteins that are essential for maturation of the virus" Endopeptidases from RNA viruses Organic Nitrogen Peptidase FALSE
+G02 Catlytic type: Glutamate; Self-cleavage is important for correct assembly of the viral appendages Self-cleaving endopeptidases Organic Nitrogen Peptidase FALSE
+I02 Inhibitors of serine peptidases Inhibitors of serine peptidases Organic Nitrogen Peptidase FALSE
+I04 Inhibitors of serine and cysteine endopeptidases Inhibitors of serine and cysteine endopeptidases Organic Nitrogen Peptidase FALSE
+I08 Inhibitors of serine and metallo endopeptidases Inhibitors of serine and metallo endopeptidases Organic Nitrogen Peptidase FALSE
+I24 Inhibitors of serine endopeptidases from family S16 Inhibitors of serine endopeptidases from family S16 Organic Nitrogen Peptidase FALSE
+I25C "inhibit peptidases of family S8 and M12, but not C1" Inhibitors primarily of the papain-like cysteine peptidases in family C1 Organic Nitrogen Peptidase FALSE
+I25B inhibit peptidases of mostly C1 and also some legumain (family C13) Inhibitors primarily of the papain-like cysteine peptidases in family C1 Organic Nitrogen Peptidase FALSE
+I25A inhibit peptidases of family C1 Inhibitors primarily of the papain-like cysteine peptidases in family C1 Organic Nitrogen Peptidase FALSE
+I29 Inhibitors of cysteine peptidases from family C1 Inhibitors of cysteine peptidases from family C1 Organic Nitrogen Peptidase FALSE
+I32 "Inhibitors of caspases, cysteine endopeptidases from family C14" "Inhibitors of caspases, cysteine endopeptidases" Organic Nitrogen Peptidase FALSE
+I36 Inhibitor of metalloendopeptidases in family M4 Inhibitor of metalloendopeptidases Organic Nitrogen Peptidase FALSE
+I43 Inhibitors of metallopeptidases from family M12 Inhibitors of metallopeptidases from family M12 Organic Nitrogen Peptidase FALSE
+I50B "inhibits human caspase; In general, I50 inhibitors facilitate the replication of baculoviruses in their hosts by blocking the apoptosis of the cells that would normally follow viral infection." "Capsases, peptidases in family C14" Organic Nitrogen Peptidase FALSE
+I50A "inhibits human caspase; In general, I50 inhibitors facilitate the replication of baculoviruses in their hosts by blocking the apoptosis of the cells that would normally follow viral infection." "Capsases, peptidases in family C14" Organic Nitrogen Peptidase FALSE
+I51 Inhibitor of serine carboxypeptidase Y and some members of the S1 family Inhibitor of serine carboxypeptidase Y Organic Nitrogen Peptidase FALSE
+I63 "Inhibitor of the metallopeptidase pappalysin-1; Pappalysin-1 promotes cell growth by the cleavage of insulin-like growth factor binding proteins-4 and -5, causing the release of bound insulin-like growth factors" Inhibitor of the metallopeptidase pappalysin-1 Organic Nitrogen Peptidase FALSE
+I75 "Inhibitors of metallo-endopeptidases; contains bacteriophage lambda CIII protein, which helps push the phage towards the lysogenic mode of phage development" Inhibitors of metallo-endopeptidases Organic Nitrogen Peptidase FALSE
+I87 "Inhibitors, specificity unknown; HflC (Escherichia coli); The factor that influences bacteriophage lambda to remain in the lysogenic stage or to lyse the host cell is transcription factor CII. Degradation of CII by the host FtsH peptidase promotes lysis" "Inhibitors, specificity unknown" Organic Nitrogen Peptidase FALSE
+I91 "Inhibitors of caspase-9; prevents activation of the executor caspases in the mitochondrial cell death pathway, thereby preventing apoptosis and destruction of the cell in which the virus is being propagated" Inhibitors of caspase-9 Organic Nitrogen Peptidase FALSE
+M03C Catlytic type: Metallo; cleave near C-terminus of substrates with low molecule mass (generally less than 19 residues) Metallopeptidases with varied activities Organic Nitrogen Peptidase FALSE
+M03B Catlytic type: Metallo; cleave near C-terminus of substrates with low molecule mass (generally less than 19 residues) Metallopeptidases with varied activities Organic Nitrogen Peptidase FALSE
+M03A Catlytic type: Metallo; cleave near C-terminus of substrates with low molecule mass (generally less than 19 residues) Metallopeptidases with varied activities Organic Nitrogen Peptidase FALSE
+M10C Catlytic type: Metallo; mostly secreted proteins that function extracellularly Metalloendopeptidases Organic Nitrogen Peptidase FALSE
+M10B Catlytic type: Metallo; mostly secreted proteins that function extracellularly Metalloendopeptidases Organic Nitrogen Peptidase FALSE
+M10A Catlytic type: Metallo; mostly secreted proteins that function extracellularly Metalloendopeptidases Organic Nitrogen Peptidase FALSE
+M12C "Catlytic type: Metallo; shown to have specificity for -Xaa-Asp- bond, but in general have much broader specificities; occur as proenzymes that require activation by limited proteolysis" Metalloendopeptidases Organic Nitrogen Peptidase FALSE
+M12B "Catlytic type: Metallo; shown to have specificity for -Xaa-Asp- bond, but in general have much broader specificities; occur as proenzymes that require activation by limited proteolysis" Metalloendopeptidases Organic Nitrogen Peptidase FALSE
+M12A "Catlytic type: Metallo; shown to have specificity for -Xaa-Asp- bond, but in general have much broader specificities; occur as proenzymes that require activation by limited proteolysis" Metalloendopeptidases Organic Nitrogen Peptidase FALSE
+M13 Catlytic type: Metallo; cleaves Trp-Val/Ile bond in the 'big endothelin' precursors of endothelin 1 Metalloendopeptidases restricted to action on substrates smaller than proteins Organic Nitrogen Peptidase FALSE
+M14C "Catlytic type: Metallo; hydrolyse single, C-terminal amino acids from polypeptide chains; shown to be involved in bacterial cell wall metabolism" Metallocarboxypeptidases Organic Nitrogen Peptidase FALSE
+M14D "Catlytic type: Metallo; hydrolyse single, C-terminal amino acids from polypeptide chains" Metallocarboxypeptidases Organic Nitrogen Peptidase FALSE
+M14B "Catlytic type: Metallo; hydrolyse single, C-terminal amino acids from polypeptide chains (prefers basic amino acids)" Metallocarboxypeptidases Organic Nitrogen Peptidase FALSE
+M14A "Catlytic type: Metallo; hydrolyse single, C-terminal amino acids from polypeptide chains (prefers aromatic or branched side chains)" Metallocarboxypeptidases Organic Nitrogen Peptidase FALSE
+M15D "Catlytic type: Metallo; substrates of the type Xaa-YaaZaa, with blocked amino terminus and free C-terminus ; involved in bacterial cell wall biosynthesis and metabolism" "Metallopeptidases, mostly specialised carboxypeptidases and dipeptidases" Organic Nitrogen Peptidase FALSE
+M15C "Catlytic type: Metallo; substrates of the type Xaa-YaaZaa, with blocked amino terminus and free C-terminus ; involved in bacterial cell wall biosynthesis and metabolism" "Metallopeptidases, mostly specialised carboxypeptidases and dipeptidases" Organic Nitrogen Peptidase FALSE
+M15B "Catlytic type: Metallo; substrates of the type Xaa-YaaZaa, with blocked amino terminus and free C-terminus ; involved in bacterial cell wall biosynthesis and metabolism" "Metallopeptidases, mostly specialised carboxypeptidases and dipeptidases" Organic Nitrogen Peptidase FALSE
+M15A "Catlytic type: Metallo; substrates of the type Xaa-YaaZaa, with blocked amino terminus and free C-terminus ; involved in bacterial cell wall biosynthesis and metabolism" "Metallopeptidases, mostly specialised carboxypeptidases and dipeptidases" Organic Nitrogen Peptidase FALSE
+M16C "Catlytic type: Metallo; specificities are varied, but the site of cleavage is seldom far from a terminus of the substrate molecule and often include cleavage of Xaa-Arg bonds; inhibited by chelating agents" Metalloendopeptidases Organic Nitrogen Peptidase FALSE
+M16B "Catlytic type: Metallo; specificities are varied, but the site of cleavage is seldom far from a terminus of the substrate molecule and often include cleavage of Xaa-Arg bonds; inhibited by chelating agents" Metalloendopeptidases Organic Nitrogen Peptidase FALSE
+M16A "Catlytic type: Metallo; specificities are varied, but the site of cleavage is seldom far from a terminus of the substrate molecule and often include cleavage of Xaa-Arg bonds; inhibited by chelating agents" Metalloendopeptidases Organic Nitrogen Peptidase FALSE
+M20E Catlytic type: Metallo "Exopeptidases: carboxypeptidases, dipeptidases and a specialised aminopeptidase" Organic Nitrogen Peptidase FALSE
+M20A Catlytic type: Metallo; glutamate carboxypeptidase "Exopeptidases: carboxypeptidases, dipeptidases and a specialised aminopeptidase" Organic Nitrogen Peptidase FALSE
+M20D Catlytic type: Metallo; broad specificity; generally found in archaea "Exopeptidases: carboxypeptidases, dipeptidases and a specialised aminopeptidase" Organic Nitrogen Peptidase FALSE
+M20F Catlytic type: Metallo; non-specific dipeptidase ; eukaryotic "Exopeptidases: carboxypeptidases, dipeptidases and a specialised aminopeptidase" Organic Nitrogen Peptidase FALSE
+M20B Catlytic type: Metallo; acts only on tripeptide substrates; also known as tripeptidases "Exopeptidases: carboxypeptidases, dipeptidases and a specialised aminopeptidase" Organic Nitrogen Peptidase FALSE
+M20C Catlytic type: Metallo; Xaa-His dipeptidase; also known as carnosinases "Exopeptidases: carboxypeptidases, dipeptidases and a specialised aminopeptidase" Organic Nitrogen Peptidase FALSE
+M23B "Catlytic type: Metallo; cleaves either the N-acylmuramoyl-Ala bond between the cell wall peptidoglycan and the cross-linking peptideor a bond within the cross-linking peptide (e.g. stapholysin), with preference for Gly bonds; used by certain bacteria to lyse cell walls of other bacteria, either as a defensive or feeding mechanism" Endopeptidases that lyse bacterial cell wall peptidoglycans Organic Nitrogen Peptidase FALSE
+M23A "Catlytic type: Metallo; cleaves either the N-acylmuramoyl-Ala bond between the cell wall peptidoglycan and the cross-linking peptideor a bond within the cross-linking peptide (e.g. stapholysin), with preference for Gly bonds; used by certain bacteria to lyse cell walls of other bacteria, either as a defensive or feeding mechanism" Endopeptidases that lyse bacterial cell wall peptidoglycans Organic Nitrogen Peptidase FALSE
+M27 Catlytic type: Metallo; cleaves synaptobrevin 2 at the Gln76-Phe77 bond or at the Gln60-Lys61 bond; synaptobrevin is the only known substrate of this class Highly selective metalloendopeptidases Organic Nitrogen Peptidase FALSE
+M38 "Catlytic type: Metallo; releases an N-terminal isoaspartate from select dipeptides, with beta-Asp|+|Leu being the best cleavage site" An omega peptidase Organic Nitrogen Peptidase FALSE
+M41 Catlytic type: Metallo; degrades a given membrane bound substrate molecule progressively from either N-terminus or C-terminus ; a member is FtsH peptidase (Escherichia coli) ATP-dependent metalloendopeptidases Organic Nitrogen Peptidase FALSE
+M42 Catlytic type: Metallo; broad specificity Metalloaminopeptidases some of which also have acylaminoacylpeptidase activity Organic Nitrogen Peptidase FALSE
+M43B Catlytic type: Metallo; cleave insulin-like growth factor binding-protein 5 (IGFBP-5) at Ser143-Lys144 or cleave IGFBP-1 at Met135-Lys136 Metallo-endopeptidases Organic Nitrogen Peptidase FALSE
+M43A Catlytic type: Metallo; cleaves beta-casein at Pro63-Gly64 and Met102-Ala103 Metallo-endopeptidases Organic Nitrogen Peptidase FALSE
+M44 "Catlytic type: Metallo; processes the viral polyprotein into multiple fragments at Ala-GlyXaa motifs where Xaa is Ala, Ser, Thr or Lys; essential for virus maturation" Metalloendopeptidase from the pox viruses Organic Nitrogen Peptidase FALSE
+M48C "Catlytic type: Metallo; requirement for substrates that are prenylated at a C-terminal motif known as CAAX, in which A is an aliphatic residue, and the lipid is attached to the cysteine residue; Eukaryotic" Metallo-endopeptidases Organic Nitrogen Peptidase FALSE
+M48B "Catlytic type: Metallo; requirement for substrates that are prenylated at a C-terminal motif known as CAAX, in which A is an aliphatic residue, and the lipid is attached to the cysteine residue; Eukaryotic" Metallo-endopeptidases Organic Nitrogen Peptidase FALSE
+M48A "Catlytic type: Metallo; requirement for substrates that are prenylated at a C-terminal motif known as CAAX, in which A is an aliphatic residue, and the lipid is attached to the cysteine residue; Eukaryotic" Metallo-endopeptidases Organic Nitrogen Peptidase FALSE
+M56 Catlytic type: Metallo; Autolysis of the BlaR1 precursor occurs at Arg293-Arg; allow bacteria to respond to the presence of beta-lactam antibiotics by the expression of beta-lactamases and penicillin-binding proteins Membrane-bound bacterial endopeptidases Organic Nitrogen Peptidase FALSE
+M60 Catlytic type: Metallo; degrades into a number of fragments with site specificity unknown; only currently identified substrate for enhancin is insect intestinal mucin Metalloendopeptidases Organic Nitrogen Peptidase FALSE
+M67C Catlytic type: Metallo; cleaves Lys48-linked tetra-ubiquitin and Lys63-linked polyubiquitin chains Isopeptidases that release ubiquitin from ubiquitinated proteins Organic Nitrogen Peptidase FALSE
+M67B Catlytic type: Metallo; cleaves Lys48-linked tetra-ubiquitin and Lys63-linked polyubiquitin chains Isopeptidases that release ubiquitin from ubiquitinated proteins Organic Nitrogen Peptidase FALSE
+M67A Catlytic type: Metallo; cleaves Lys48-linked tetra-ubiquitin and Lys63-linked polyubiquitin chains Isopeptidases that release ubiquitin from ubiquitinated proteins Organic Nitrogen Peptidase FALSE
+M78 "Catlytic type: Metallo; Cleaves of ImmR occurs at Phe95+Met, releasing the N-terminal DNA-binding domain" Metallo-endopeptidases Organic Nitrogen Peptidase FALSE
+M79 "Catlytic type: Metallo; cleaves at the -Cys(R)Xaa-Xaa-Xbb, in which Cys(R) is cysteine in which the thiol is substituted with a C15(farnesyl) or C20 (geranylgeranyl) side chain, Xaa is normally a small, aliphatic residue, and Xbb is any amino acid" Specialised endopeptidases that typically cleave a C-terminal tripeptide from an isoprenylated protein Organic Nitrogen Peptidase FALSE
+M86 "Catlytic type: Metallo; hydrolyse gamma-linked poly-DL-glutamic acid (gamma-DL-PGA), giving final products no smaller than trimers, even when subjected to prolonged incubation or the addition of more enzyme; phage encoded peptidase gamma-PGA" Poly-gamma-glutamyl hydrolases Organic Nitrogen Peptidase FALSE
+N01 "Catlytic type: Asparagine; autolytic cleavage of Asn363-Ala364 releasing a 44-residue C-terminal fragment; peptidases in family N1 are the coat proteins from nodaviruses, single-stranded RNA viruses; coat protein precursor undergoes slow, autolytic maturation in which cleavage of the coat protein helps stabilize the virion and is an important stage in maturation of the virus" An endopeptidase Organic Nitrogen Peptidase FALSE
+N02 Catlytic type: Asparagine; autolytic cleavage of Asn570-Phe571 releasing a 74-residue fragment from the C-terminus of the coat protein only the endopeptidase of tetraviruses Organic Nitrogen Peptidase FALSE
+N04 Catlytic type: Asparagine; release of the passenger domain from the precursor; cleavage causes the virulence factor to be secreted (shown in E. coli) Tsh-associated self-cleaving domain Organic Nitrogen Peptidase FALSE
+N05 Catlytic type: Asparagine; release of an N-terminal 44-residue peptide from the N-terminus of the coat protein; important for virion stabilization Self-cleaving endopeptidases Organic Nitrogen Peptidase FALSE
+N07 Catlytic type: Asparagine; cleaves one of the capsid proteins at at Asn42; important for virion stabilization Self-cleaving endopeptidases Organic Nitrogen Peptidase FALSE
+N08 Catlytic type: Asparagine; cleaves the VP0 viral capsid protein into VP2 and VP4 in the provirion Self-cleaving endopeptidases Organic Nitrogen Peptidase FALSE
+N09 Catlytic type: Asparagine; release of the intein from the extein; intein is a polypeptide insert into another protein (the extein) which is able to release itself from the host protein and splice the two portions of the extein together Self-cleaving proteins Organic Nitrogen Peptidase FALSE
+N10E "Catlytic type: Asparagine; first residue of the intein must by Cys, Ser or Thr and the last residue of the intein must be Asn or Gln; the first residue of the second portion of the extein must be Cys, Ser or Thr.; An intein is a polypeptide insert into another protein (the extein) which is able to release itself from the host protein and splice the two portions of the extein together." self-cleaving proteins Organic Nitrogen Peptidase FALSE
+N10D "Catlytic type: Asparagine; first residue of the intein must by Cys, Ser or Thr and the last residue of the intein must be Asn or Gln; the first residue of the second portion of the extein must be Cys, Ser or Thr.; An intein is a polypeptide insert into another protein (the extein) which is able to release itself from the host protein and splice the two portions of the extein together." self-cleaving proteins Organic Nitrogen Peptidase FALSE
+N10C "Catlytic type: Asparagine; first residue of the intein must by Cys, Ser or Thr and the last residue of the intein must be Asn or Gln; the first residue of the second portion of the extein must be Cys, Ser or Thr.; An intein is a polypeptide insert into another protein (the extein) which is able to release itself from the host protein and splice the two portions of the extein together." self-cleaving proteins Organic Nitrogen Peptidase FALSE
+N10B "Catlytic type: Asparagine; first residue of the intein must by Cys, Ser or Thr and the last residue of the intein must be Asn or Gln; the first residue of the second portion of the extein must be Cys, Ser or Thr.; An intein is a polypeptide insert into another protein (the extein) which is able to release itself from the host protein and splice the two portions of the extein together." self-cleaving proteins Organic Nitrogen Peptidase FALSE
+N11 "Catlytic type: Asparagine; cleaves at the start and end of the intein, which is then released" Self-cleaving proteins Organic Nitrogen Peptidase FALSE
+S01F "Catlytic type: Serine; 3 types:trypsin-like where there is cleavage of amide substrates following Arg or Lys at P1, chymotrypsin-like where cleavage occurs following one of the hydrophobic amino acids at P1, and elastase-like with cleavage following an Ala at P1" Serine endopeptidases Organic Nitrogen Peptidase FALSE
+S01E "Catlytic type: Serine; 3 types:trypsin-like where there is cleavage of amide substrates following Arg or Lys at P1, chymotrypsin-like where cleavage occurs following one of the hydrophobic amino acids at P1, and elastase-like with cleavage following an Ala at P1" Serine endopeptidases Organic Nitrogen Peptidase FALSE
+S01D "Catlytic type: Serine; 3 types:trypsin-like where there is cleavage of amide substrates following Arg or Lys at P1, chymotrypsin-like where cleavage occurs following one of the hydrophobic amino acids at P1, and elastase-like with cleavage following an Ala at P1" Serine endopeptidases Organic Nitrogen Peptidase FALSE
+S01C "Catlytic type: Serine; 3 types:trypsin-like where there is cleavage of amide substrates following Arg or Lys at P1, chymotrypsin-like where cleavage occurs following one of the hydrophobic amino acids at P1, and elastase-like with cleavage following an Ala at P1" Serine endopeptidases Organic Nitrogen Peptidase FALSE
+S01B "Catlytic type: Serine; 3 types:trypsin-like where there is cleavage of amide substrates following Arg or Lys at P1, chymotrypsin-like where cleavage occurs following one of the hydrophobic amino acids at P1, and elastase-like with cleavage following an Ala at P1" Serine endopeptidases Organic Nitrogen Peptidase FALSE
+S01A "Catlytic type: Serine; 3 types:trypsin-like where there is cleavage of amide substrates following Arg or Lys at P1, chymotrypsin-like where cleavage occurs following one of the hydrophobic amino acids at P1, and elastase-like with cleavage following an Ala at P1" Serine endopeptidases Organic Nitrogen Peptidase FALSE
+S03 Catlytic type: Serine; cis cleavage of the Trp264-Ser bond at its own C-terminus to release it from the polyprotein; RNA virus protein excised from the polyprotein that forms the viral coat Viral endopeptidase togavirin Organic Nitrogen Peptidase FALSE
+S06 Catlytic type: Serine; cleave human IgA1 in a part of the hinge region that is absent from IgA2 Serine endopeptidases of bacteria Organic Nitrogen Peptidase FALSE
+S07 "Catlytic type: Serine; cleaves at sites like -Xaa-XaaYaa-, where Xaa is normally an amino acid with a basic side chain, and Yaa has a short side chain" Serine endopeptidase Organic Nitrogen Peptidase FALSE
+S08C Catlytic type: Serine; nonspecific peptidases with a preference to cleave after hydrophobic residues; secreted or attached to the cell wall Serine endopeptidase subtilisin and its homologues Organic Nitrogen Peptidase FALSE
+S08B Catlytic type: Serine; nonspecific peptidases with a preference to cleave after hydrophobic residues; secreted or attached to the cell wall Serine endopeptidase subtilisin and its homologues Organic Nitrogen Peptidase FALSE
+S08A Catlytic type: Serine; nonspecific peptidases with a preference to cleave after hydrophobic residues; secreted or attached to the cell wall Serine endopeptidase subtilisin and its homologues Organic Nitrogen Peptidase FALSE
+S09D "Catlytic type: Serine; generally cleaves prolyl bonds, with some exceptions (see additional information); oligopeptidase B cleaves Arg and Lys bonds; acylaminoacyl-peptidase releases an N-acylated amino acid from an oligopeptide blocked by a acetyl, chloroacetyl, formyl or carbamyl group" Serine-dependent peptidases Organic Nitrogen Peptidase FALSE
+S09C "Catlytic type: Serine; generally cleaves prolyl bonds, with some exceptions (see additional information); oligopeptidase B cleaves Arg and Lys bonds; acylaminoacyl-peptidase releases an N-acylated amino acid from an oligopeptide blocked by a acetyl, chloroacetyl, formyl or carbamyl group" Serine-dependent peptidases Organic Nitrogen Peptidase FALSE
+S09B "Catlytic type: Serine; generally cleaves prolyl bonds, with some exceptions (see additional information); oligopeptidase B cleaves Arg and Lys bonds; acylaminoacyl-peptidase releases an N-acylated amino acid from an oligopeptide blocked by a acetyl, chloroacetyl, formyl or carbamyl group" Serine-dependent peptidases Organic Nitrogen Peptidase FALSE
+S09A "Catlytic type: Serine; generally cleaves prolyl bonds, with some exceptions (see additional information); oligopeptidase B cleaves Arg and Lys bonds; acylaminoacyl-peptidase releases an N-acylated amino acid from an oligopeptide blocked by a acetyl, chloroacetyl, formyl or carbamyl group" Serine-dependent peptidases Organic Nitrogen Peptidase FALSE
+S11 Catlytic type: Serine; transfer of the C-terminal D-Ala to water OR the peptidoglycan monomer is transferred to an exogenous receptor after removal of the C-terminal D-Ala (some have both activities); mainly involved in the synthesis of bacterial cell walls Serine-type D-Ala-D-Ala carboxypeptidases Organic Nitrogen Peptidase FALSE
+S12 Catlytic type: Serine; wide range of activities and specificities; involved in the synthesis and remodelling of bacterial cell walls Serine-type D-Ala-D-Ala carboxypeptidases Organic Nitrogen Peptidase FALSE
+S14 Catlytic type: Serine; cleaves preferentially after nonpolar residues; involved in quality control and the regulatory degradation of specific proteins Endopeptidase Clp and its homologues Organic Nitrogen Peptidase FALSE
+S16 Catlytic type: Serine; cleaves when P1 is Leu; ATP-dependent peptidase and a protein-activated ATPase "Endopeptidases, mostly ATP-dependent" Organic Nitrogen Peptidase FALSE
+S21 "Catlytic type: Serine; cleaves at Val/Leu-Xaa-AlaSer, where Xaa is a polar residue; involved in the late stages of assembly of the viral prohead, breaking down the scaffold protein upon which the prohead is assembled" "Assemblins, which are processing endopeptidases of the herpesviruses, one of the groups of DNA viruses" Organic Nitrogen Peptidase FALSE
+S24 Catlytic type: Serine; cleaves.at an Ala-Gly or a Cys-Gly bond "Two-domain proteins that undergo autolysis, separating the functional domains" Organic Nitrogen Peptidase FALSE
+S26C "Catlytic type: Serine; removes hydrophobic, N-terminal signal peptides as the proteins are translocated across membranes; 'Ala-Xaa-Ala' motif preceding the cleavage site; major enzymes that remove the signal peptides and facilitate secretion" Peptidase family S26 contains endopeptidases Organic Nitrogen Peptidase FALSE
+S26B "Catlytic type: Serine; removes hydrophobic, N-terminal signal peptides as the proteins are translocated across membranes; 'Ala-Xaa-Ala' motif preceding the cleavage site; major enzymes that remove the signal peptides and facilitate secretion" Peptidase family S26 contains endopeptidases Organic Nitrogen Peptidase FALSE
+S26A "Catlytic type: Serine; removes hydrophobic, N-terminal signal peptides as the proteins are translocated across membranes; 'Ala-Xaa-Ala' motif preceding the cleavage site; major enzymes that remove the signal peptides and facilitate secretion" Peptidase family S26 contains endopeptidases Organic Nitrogen Peptidase FALSE
+S28 "Catlytic type: Serine; cleaves the -Pro-Xaa bond, in which Xaa is C-terminal" "Exopeptidases that hydrolyse prolyl bonds, and are known only from eukaryotes" Organic Nitrogen Peptidase FALSE
+S29 Catlytic type: Serine; cleaves when P1 residue at each site is Cys or Thr; member is hepacivirin Polyprotein-processing peptidases of hepatitis viruses Organic Nitrogen Peptidase FALSE
+S30 "Catlytic type: Serine; cleaves a bond at its own C-terminus where the the scissile bond is -Xaa-Ser-, in which Xaa is Phe or Tyr; essential for viral infectivity" Viral polyprotein-processing peptidases Organic Nitrogen Peptidase FALSE
+S31 "Catlytic type: Serine; cleaves each pestivirus polyprotein at four positions, between NS3 and NS4, NS4A and NS4B, NS4B and NS5A, and between NS5A and NS5B; essential for viral replication" Polyprotein processing endopeptidase from pestiviruses Organic Nitrogen Peptidase FALSE
+S32 "Catlytic type: Serine; cleaves at four Glu-Gly bonds and one Glu-Ser bond in the ORF1a polyprotein, and an additional two Glu-Gly and one Gln-Ser bond in the ORF1b polyprotein; Arteriviruses are RNA viruses with a genome that encodes two polyproteins, ORF1a and ORF1ab." One of the arterivirus polyprotein processing endopeptidases Organic Nitrogen Peptidase FALSE
+S33 "Catlytic type: Serine; releases an N-terminal residue from a peptide, preferably (but not exclusively) a proline; secreted or periplasmic enzymes;Prolyl aminopeptidase may confer a selective advantage allowing a bacterium to utilize proline-rich substrates" Exopeptidases that act at the N-terminus of peptides Organic Nitrogen Peptidase FALSE
+S49C "Catlytic type: Serine; hydrolyzes the N-blocked p-nitrophenyl esters of Gly, Ala, Phe, Val, Leu and Trp; prefers hydrophobic amino acids on either side of the scissile bond and will not cleave a peptide containing fewer than six amino acids; destruction of cleaved signal pepides in the periplasmic space" Endopeptidases Organic Nitrogen Peptidase FALSE
+S49B "Catlytic type: Serine; hydrolyzes the N-blocked p-nitrophenyl esters of Gly, Ala, Phe, Val, Leu and Trp; prefers hydrophobic amino acids on either side of the scissile bond and will not cleave a peptide containing fewer than six amino acids; destruction of cleaved signal pepides in the periplasmic space" Endopeptidases Organic Nitrogen Peptidase FALSE
+S49A "Catlytic type: Serine; hydrolyzes the N-blocked p-nitrophenyl esters of Gly, Ala, Phe, Val, Leu and Trp; prefers hydrophobic amino acids on either side of the scissile bond and will not cleave a peptide containing fewer than six amino acids; destruction of cleaved signal pepides in the periplasmic space" Endopeptidases Organic Nitrogen Peptidase FALSE
+S50 Catlytic type: Serine; cleaves the polyprotein at two sites both containing Ala; processes the viral polyprotein and releases itself and the major capsid proteins Polyprotein processing endopeptidases from double-stranded RNA viruses Organic Nitrogen Peptidase FALSE
+S53 Catlytic type: Serine; preferences for hydrophobic residues in the P1 and P2 positions; secreted proteins Acid-acting endopeptidases and a tripeptidyl-peptidase Organic Nitrogen Peptidase FALSE
+S54 Catlytic type: Serine; membrane bound Membrane-bound serine endopeptidases Organic Nitrogen Peptidase FALSE
+S62 "Catlytic type: Serine; cleaves the chymotrypsin substrate Suc-Leu-Leu-Val-Tyr-NHMec and casein ; not essential but when absent, reduces viral growth" Viral endopeptidases Organic Nitrogen Peptidase FALSE
+S65 Catlytic type: Serine; processes of the polyprotein occurs at Phe-Xaa-Xaa-Gln+ consensus sequences Endopeptidases Organic Nitrogen Peptidase FALSE
+S69 Catlytic type: Serine; cleaves alanyl bonds in the processing of a viral polyprotein Viral endopeptidases Organic Nitrogen Peptidase FALSE
+S73 Catlytic type: Serine Serine endopeptidases Organic Nitrogen Peptidase FALSE
+S74 Catlytic type: Serine; autoproteolysis releases the chaperone domains Serine endopeptidases Organic Nitrogen Peptidase FALSE
+S75 "Catlytic type: Serine; cleaves several sites in the polyprotein, with cleavage at Gln(Ala/Thr) ; processes the relicase polyprotein 1ab releasing individual proteins" Endopeptidases Organic Nitrogen Peptidase FALSE
+S77 "Catlytic type: Serine; cleaves P22, IPII, IPIII and P68 at selected GluAla bonds; cleaves P23 at a GluGly bond; processing of prohead protein" Prohead endopeptidase from bacteriophage T4 Organic Nitrogen Peptidase FALSE
+S78 Catlytic type: Serine; processes the coat protein at the lysyl bond; involved in the maturation of the phage prohead Endopeptidases from bacteriophages Organic Nitrogen Peptidase FALSE
+S80 Catlytic type: Serine; cleaves at Ser/Ala/Gly)-Xaa-Glu+; perform all the processing cleavages required for maturation of the viral prohead prohead peptidase gp175 Organic Nitrogen Peptidase FALSE
+S81 "Catlytic type: Serine; cleaves the beta-(1,4)-glycosidic bond between N-acetylmuramic acid and N-acetylglucosamine of the peptidoglycan of bacterial cell walls" Isopeptidases Organic Nitrogen Peptidase FALSE
+T01B "Catlytic type: Threonine; eukaryotic proteasome has three different activities (trypsin-like, chymotrypsin-like and cleavage after glutamate); archaean and bacterial proteasomes have only chymotrypsin-like activity; involved in turnover of intracellular proteins" Component peptidases of the proteasome and related compound peptidases Organic Nitrogen Peptidase FALSE
+T01A "Catlytic type: Threonine; eukaryotic proteasome has three different activities (trypsin-like, chymotrypsin-like and cleavage after glutamate); archaean and bacterial proteasomes have only chymotrypsin-like activity; involved in turnover of intracellular proteins" Component peptidases of the proteasome and related compound peptidases Organic Nitrogen Peptidase FALSE
+T03 "Catlytic type: Threonine; catalyzes the transfer of the gamma-glutamyl moiety of gamma-glutamyl-derived peptides such as glutathione (gammaGlu-Cys-Gly), and anilides such as gamma-glutamyl-7-amido-4-methylcoumarin (gammaGlu-AMC) to acceptor molecules including water and various dipeptides" Self-processing proteins that express aminopeptidase as well as aminotransferase activities in their mature forms Organic Nitrogen Peptidase FALSE
+U32 degrades soluble and reconstituted fibrillar type I collagen Endopeptidases from bacteria Organic Nitrogen Peptidase FALSE
+U40 "cleaves the cell wall peptide bridge formed by meso-2,6-diaminopimelic acid and D-Ala; component of the bacteriophage lysin" Protein P5 murein endopeptidase from bacteriophage phi-6 Organic Nitrogen Peptidase FALSE
+K01872 AARS; alanyl-tRNA synthetase [EC:6.1.1.7] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K01887 RARS; arginyl-tRNA synthetase [EC:6.1.1.19] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K01893 NARS; asparaginyl-tRNA synthetase [EC:6.1.1.22] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K22503 DARS; aspartyl-tRNA synthetase [EC:6.1.1.12] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K01876 DARS2; aspartyl-tRNA synthetase [EC:6.1.1.12] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K01883 CARS; cysteinyl-tRNA synthetase [EC:6.1.1.16] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K01886 QARS; glutaminyl-tRNA synthetase [EC:6.1.1.18] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K01885 EARS; glutamyl-tRNA synthetase [EC:6.1.1.17] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K01880 GARS; glycyl-tRNA synthetase [EC:6.1.1.14] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K01892 HARS; histidyl-tRNA synthetase [EC:6.1.1.21] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K01870 IARS; isoleucyl-tRNA synthetase [EC:6.1.1.5] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K01869 LARS; leucyl-tRNA synthetase [EC:6.1.1.4] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K04567 "KARS; lysyl-tRNA synthetase, class II [EC:6.1.1.6]" "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K01874 MARS; methionyl-tRNA synthetase [EC:6.1.1.10] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K01889 FARSA; phenylalanyl-tRNA synthetase alpha chain [EC:6.1.1.20] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K01890 FARSB; phenylalanyl-tRNA synthetase beta chain [EC:6.1.1.20] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K01881 PARS; prolyl-tRNA synthetase [EC:6.1.1.15] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K01875 SARS; seryl-tRNA synthetase [EC:6.1.1.11] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K01868 TARS; threonyl-tRNA synthetase [EC:6.1.1.3] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K01867 WARS; tryptophanyl-tRNA synthetase [EC:6.1.1.2] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K01866 YARS; tyrosyl-tRNA synthetase [EC:6.1.1.1] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K01873 VARS; valyl-tRNA synthetase [EC:6.1.1.9] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K14163 EPRS; bifunctional glutamyl/prolyl-tRNA synthetase [EC:6.1.1.17 6.1.1.15] "Aminoacyl-tRNA biosynthesis, eukaryotes" MISC Information systems FALSE
+K03006 RPB1; DNA-directed RNA polymerase II subunit RPB1 [EC:2.7.7.6] "RNA polymerase II, eukaryotes" MISC Information systems FALSE
+K03010 RPB2; DNA-directed RNA polymerase II subunit RPB2 [EC:2.7.7.6] "RNA polymerase II, eukaryotes" MISC Information systems FALSE
+K03011 RPB3; DNA-directed RNA polymerase II subunit RPB3 "RNA polymerase II, eukaryotes" MISC Information systems FALSE
+K03008 RPB11; DNA-directed RNA polymerase II subunit RPB11 "RNA polymerase II, eukaryotes" MISC Information systems FALSE
+K03012 RPB4; DNA-directed RNA polymerase II subunit RPB4 "RNA polymerase II, eukaryotes" MISC Information systems FALSE
+K03015 RPB7; DNA-directed RNA polymerase II subunit RPB7 "RNA polymerase II, eukaryotes" MISC Information systems FALSE
+K03017 RPB9; DNA-directed RNA polymerase II subunit RPB9 "RNA polymerase II, eukaryotes" MISC Information systems FALSE
+K03013 "RPB5; DNA-directed RNA polymerases I, II, and III subunit RPABC1" "RNA polymerase II, eukaryotes" MISC Information systems FALSE
+K03014 "RPB6; DNA-directed RNA polymerases I, II, and III subunit RPABC2" "RNA polymerase II, eukaryotes" MISC Information systems FALSE
+K03016 "RPB8; DNA-directed RNA polymerases I, II, and III subunit RPABC3" "RNA polymerase II, eukaryotes" MISC Information systems FALSE
+K03009 "RPB12; DNA-directed RNA polymerases I, II, and III subunit RPABC4" "RNA polymerase II, eukaryotes" MISC Information systems FALSE
+K03007 "RPB10; DNA-directed RNA polymerases I, II, and III subunit RPABC5" "RNA polymerase II, eukaryotes" MISC Information systems FALSE
+K03018 RPC1; DNA-directed RNA polymerase III subunit RPC1 [EC:2.7.7.6] "RNA polymerase III, eukaryotes" MISC Information systems FALSE
+K03021 RPC2; DNA-directed RNA polymerase III subunit RPC2 [EC:2.7.7.6] "RNA polymerase III, eukaryotes" MISC Information systems FALSE
+K03027 RPC40; DNA-directed RNA polymerases I and III subunit RPAC1 "RNA polymerase III, eukaryotes" MISC Information systems FALSE
+K03020 RPC19; DNA-directed RNA polymerases I and III subunit RPAC2 "RNA polymerase III, eukaryotes" MISC Information systems FALSE
+K03023 RPC82; DNA-directed RNA polymerase III subunit RPC3 "RNA polymerase III, eukaryotes" MISC Information systems FALSE
+K03026 RPC53; DNA-directed RNA polymerase III subunit RPC4 "RNA polymerase III, eukaryotes" MISC Information systems FALSE
+K14721 RPC37; DNA-directed RNA polymerase III subunit RPC5 "RNA polymerase III, eukaryotes" MISC Information systems FALSE
+K03025 RPC34; DNA-directed RNA polymerase III subunit RPC6 "RNA polymerase III, eukaryotes" MISC Information systems FALSE
+K03024 RPC31; DNA-directed RNA polymerase III subunit RPC7 "RNA polymerase III, eukaryotes" MISC Information systems FALSE
+K03022 RPC25; DNA-directed RNA polymerase III subunit RPC8 "RNA polymerase III, eukaryotes" MISC Information systems FALSE
+K03019 RPC11; DNA-directed RNA polymerase III subunit RPC10 "RNA polymerase III, eukaryotes" MISC Information systems FALSE
+K03013 "RPB5; DNA-directed RNA polymerases I, II, and III subunit RPABC1" "RNA polymerase III, eukaryotes" MISC Information systems FALSE
+K03014 "RPB6; DNA-directed RNA polymerases I, II, and III subunit RPABC2" "RNA polymerase III, eukaryotes" MISC Information systems FALSE
+K03016 "RPB8; DNA-directed RNA polymerases I, II, and III subunit RPABC3" "RNA polymerase III, eukaryotes" MISC Information systems FALSE
+K03009 "RPB12; DNA-directed RNA polymerases I, II, and III subunit RPABC4" "RNA polymerase III, eukaryotes" MISC Information systems FALSE
+K03007 "RPB10; DNA-directed RNA polymerases I, II, and III subunit RPABC5" "RNA polymerase III, eukaryotes" MISC Information systems FALSE
+K02999 RPA1; DNA-directed RNA polymerase I subunit RPA1 [EC:2.7.7.6] "RNA polymerase I, eukaryotes" MISC Information systems FALSE
+K03002 RPA2; DNA-directed RNA polymerase I subunit RPA2 [EC:2.7.7.6] "RNA polymerase I, eukaryotes" MISC Information systems FALSE
+K03027 RPC40; DNA-directed RNA polymerases I and III subunit RPAC1 "RNA polymerase I, eukaryotes" MISC Information systems FALSE
+K03020 RPC19; DNA-directed RNA polymerases I and III subunit RPAC2 "RNA polymerase I, eukaryotes" MISC Information systems FALSE
+K03000 RPA12; DNA-directed RNA polymerase I subunit RPA12 "RNA polymerase I, eukaryotes" MISC Information systems FALSE
+K03001 RPA14; DNA-directed RNA polymerase I subunit RPA14 "RNA polymerase I, eukaryotes" MISC Information systems FALSE
+K03003 RPA34; DNA-directed RNA polymerase I subunit RPA34 "RNA polymerase I, eukaryotes" MISC Information systems FALSE
+K03004 RPA43; DNA-directed RNA polymerase I subunit RPA43 "RNA polymerase I, eukaryotes" MISC Information systems FALSE
+K03005 RPA49; DNA-directed RNA polymerase I subunit RPA49 "RNA polymerase I, eukaryotes" MISC Information systems FALSE
+K03013 "RPB5; DNA-directed RNA polymerases I, II, and III subunit RPABC1" "RNA polymerase I, eukaryotes" MISC Information systems FALSE
+K03014 "RPB6; DNA-directed RNA polymerases I, II, and III subunit RPABC2" "RNA polymerase I, eukaryotes" MISC Information systems FALSE
+K03016 "RPB8; DNA-directed RNA polymerases I, II, and III subunit RPABC3" "RNA polymerase I, eukaryotes" MISC Information systems FALSE
+K03009 "RPB12; DNA-directed RNA polymerases I, II, and III subunit RPABC4" "RNA polymerase I, eukaryotes" MISC Information systems FALSE
+K03007 "RPB10; DNA-directed RNA polymerases I, II, and III subunit RPABC5" "RNA polymerase I, eukaryotes" MISC Information systems FALSE
+K03040 rpoA; DNA-directed RNA polymerase subunit alpha [EC:2.7.7.6] "RNA polymerase, bacteria" MISC Information systems FALSE
+K03043 rpoB; DNA-directed RNA polymerase subunit beta [EC:2.7.7.6] "RNA polymerase, bacteria" MISC Information systems FALSE
+K03046 rpoC; DNA-directed RNA polymerase subunit beta' [EC:2.7.7.6] "RNA polymerase, bacteria" MISC Information systems FALSE
+K13797 rpoBC; DNA-directed RNA polymerase subunit beta-beta' [EC:2.7.7.6] "RNA polymerase, bacteria" MISC Information systems FALSE
+K03060 rpoZ; DNA-directed RNA polymerase subunit omega [EC:2.7.7.6] "RNA polymerase, bacteria" MISC Information systems FALSE
+K03048 rpoE; DNA-directed RNA polymerase subunit delta "RNA polymerase, bacteria" MISC Information systems FALSE
+K03042 rpoA2; DNA-directed RNA polymerase subunit A [EC:2.7.7.6] "RNA polymerase, archaea" MISC Information systems FALSE
+K03041 rpoA1; DNA-directed RNA polymerase subunit A' [EC:2.7.7.6] "RNA polymerase, archaea" MISC Information systems FALSE
+K03044 rpoB1; DNA-directed RNA polymerase subunit B' [EC:2.7.7.6] "RNA polymerase, archaea" MISC Information systems FALSE
+K03045 rpoB2; DNA-directed RNA polymerase subunit B [EC:2.7.7.6] "RNA polymerase, archaea" MISC Information systems FALSE
+K13798 rpoB; DNA-directed RNA polymerase subunit B [EC:2.7.7.6] "RNA polymerase, archaea" MISC Information systems FALSE
+K03053 rpoH; DNA-directed RNA polymerase subunit H [EC:2.7.7.6] "RNA polymerase, archaea" MISC Information systems FALSE
+K03055 rpoK; DNA-directed RNA polymerase subunit K [EC:2.7.7.6] "RNA polymerase, archaea" MISC Information systems FALSE
+K03058 rpoN; DNA-directed RNA polymerase subunit N [EC:2.7.7.6] "RNA polymerase, archaea" MISC Information systems FALSE
+K03047 rpoD; DNA-directed RNA polymerase subunit D [EC:2.7.7.6] "RNA polymerase, archaea" MISC Information systems FALSE
+K03049 rpoE1; DNA-directed RNA polymerase subunit E [EC:2.7.7.6] "RNA polymerase, archaea" MISC Information systems FALSE
+K03050 rpoE2; DNA-directed RNA polymerase subunit E [EC:2.7.7.6] "RNA polymerase, archaea" MISC Information systems FALSE
+K03056 rpoL; DNA-directed RNA polymerase subunit L [EC:2.7.7.6] "RNA polymerase, archaea" MISC Information systems FALSE
+K03059 rpoP; DNA-directed RNA polymerase subunit P [EC:2.7.7.6] "RNA polymerase, archaea" MISC Information systems FALSE
+K03051 rpoF; DNA-directed RNA polymerase subunit F [EC:2.7.7.6] "RNA polymerase, archaea" MISC Information systems FALSE
+K03052 rpoG; DNA-directed RNA polymerase subunit G [EC:2.7.7.6] "RNA polymerase, archaea" MISC Information systems FALSE
+K03054 rpoI; DNA-directed RNA polymerase subunit I [EC:2.7.7.6] "RNA polymerase, archaea" MISC Information systems FALSE
+K02337 dnaE; DNA polymerase III subunit alpha [EC:2.7.7.7] "DNA polymerase III complex, bacteria" MISC Information systems FALSE
+K03763 "polC; DNA polymerase III subunit alpha, Gram-positive type [EC:2.7.7.7]" "DNA polymerase III complex, bacteria" MISC Information systems FALSE
+K02342 dnaQ; DNA polymerase III subunit epsilon [EC:2.7.7.7] "DNA polymerase III complex, bacteria" MISC Information systems FALSE
+K14159 rnhA-dnaQ; ribonuclease HI / DNA polymerase III subunit epsilon [EC:3.1.26.4 2.7.7.7] "DNA polymerase III complex, bacteria" MISC Information systems FALSE
+K02345 holE; DNA polymerase III subunit theta [EC:2.7.7.7] "DNA polymerase III complex, bacteria" MISC Information systems FALSE
+K02338 dnaN; DNA polymerase III subunit beta [EC:2.7.7.7] "DNA polymerase III complex, bacteria" MISC Information systems FALSE
+K02340 holA; DNA polymerase III subunit delta [EC:2.7.7.7] "DNA polymerase III complex, bacteria" MISC Information systems FALSE
+K02341 holB; DNA polymerase III subunit delta' [EC:2.7.7.7] "DNA polymerase III complex, bacteria" MISC Information systems FALSE
+K02343 dnaX; DNA polymerase III subunit gamma/tau [EC:2.7.7.7] "DNA polymerase III complex, bacteria" MISC Information systems FALSE
+K02339 holC; DNA polymerase III subunit chi [EC:2.7.7.7] "DNA polymerase III complex, bacteria" MISC Information systems FALSE
+K02344 holD; DNA polymerase III subunit psi [EC:2.7.7.7] "DNA polymerase III complex, bacteria" MISC Information systems FALSE
+K02320 "POLA1; DNA polymerase alpha, subunit A [EC:2.7.7.7]" DNA polymerase alpha / primase complex MISC Information systems FALSE
+K02321 "POLA2; DNA polymerase alpha, subunit B [EC:2.7.7.7]" DNA polymerase alpha / primase complex MISC Information systems FALSE
+K02685 PRI2; DNA primase large subunit [EC:2.7.7.-] DNA polymerase alpha / primase complex MISC Information systems FALSE
+K02684 PRI1; DNA primase small subunit [EC:2.7.7.-] DNA polymerase alpha / primase complex MISC Information systems FALSE
+K02327 "POLD1; DNA polymerase delta, subunit A [EC:2.7.7.7]" DNA polymerase delta complex MISC Information systems FALSE
+K02328 "POLD2; DNA polymerase delta, subunit B [EC:2.7.7.7]" DNA polymerase delta complex MISC Information systems FALSE
+K03504 "POLD3; DNA polymerase delta, subunit C [EC:2.7.7.7]" DNA polymerase delta complex MISC Information systems FALSE
+K03505 "POLD4; DNA polymerase delta, subunit D [EC:2.7.7.7]" DNA polymerase delta complex MISC Information systems FALSE
+K02324 "POLE1; DNA polymerase epsilon, subunit A [EC:2.7.7.7]" DNA polymerase epsilon complex MISC Information systems FALSE
+K02325 "POLE2; DNA Polymerase epsilon, subunit B [EC:2.7.7.7]" DNA polymerase epsilon complex MISC Information systems FALSE
+K02326 "POLE3; DNA Polymerase epsilon, subunit C [EC:2.7.7.7]" DNA polymerase epsilon complex MISC Information systems FALSE
+K03506 "POLE4; DNA polymerase epsilon, subunit D [EC:2.7.7.7]" DNA polymerase epsilon complex MISC Information systems FALSE
+K02322 DPB1; DNA polymerase II large subunit [EC:2.7.7.7] "DNA polymerase II complex, archaea" MISC Information systems FALSE
+K02323 DPB2; DNA polymerase II small subunit [EC:2.7.7.7] "DNA polymerase II complex, archaea" MISC Information systems FALSE
+K15342 cas1; CRISP-associated protein Cas1 Universal Cas proteins MISC CRISPR FALSE
+K09951 cas2; CRISPR-associated protein Cas2 Universal Cas proteins MISC CRISPR FALSE
+K01812 glucuronate isomerase Pentose and glucuronate interconversions carbon utilization sugar utilization (woodcroft) galacturonic acid degradation TRUE
+K00041 tagaturonate reductase Pentose and glucuronate interconversions carbon utilization (Woodcroft) sugar utilization (woodcroft) galacturonic acid degradation TRUE
+K01685 altronate hydrolase Pentose and glucuronate interconversions carbon utilization (Woodcroft) sugar utilization (woodcroft) galacturonic acid degradation TRUE
+K16849 altronate dehydratase small subunit Pentose and glucuronate interconversions carbon utilization (Woodcroft) sugar utilization (woodcroft) galacturonic acid degradation TRUE
+K16850 altronate dehydratase large subunit Pentose and glucuronate interconversions carbon utilization (Woodcroft) sugar utilization (woodcroft) galacturonic acid degradation TRUE
+K00874 2-dehydro-3-deoxygluconokinase Pentose and glucuronate interconversions carbon utilization (Woodcroft) sugar utilization (woodcroft) galacturonic acid degradation TRUE
+K01625 2-dehydro-3-deoxyphosphogluconate aldolase / (4S)-4-hydroxy-2-oxoglutarate aldolase Pentose and glucuronate interconversions carbon utilization (Woodcroft) sugar utilization (woodcroft) galacturonic acid degradation TRUE
+K01785 aldose 1-epimerase Galactose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) galactose degradation TRUE
+K00849 galactokinase Galactose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) galactose degradation TRUE
+K00965 UDPglucose--hexose-1-phosphate uridylyltransferase Galactose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) galactose degradation TRUE
+K01784 UDP-glucose 4-epimerase Galactose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) galactose degradation TRUE
+K01190 beta-galactosidase Galactose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) lactose degradation TRUE
+K12111 evolved beta-galactosidase subunit alpha Galactose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) lactose degradation TRUE
+K12112 evolved beta-galactosidase subunit beta Galactose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) lactose degradation TRUE
+K12309 beta-galactosidase Galactose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) lactose degradation TRUE
+K01203 sucrase-isomaltase Starch and sucrose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) sucrose degradation TRUE
+K01193 beta-fructofuranosidase Starch and sucrose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) sucrose degradation TRUE
+K12047 maltase-glucoamylase Starch and sucrose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) sucrose degradation TRUE
+K01187 alpha-glucosidase Starch and sucrose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) sucrose degradation TRUE
+K12316 lysosomal alpha-glucosidase Starch and sucrose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) sucrose degradation TRUE
+K12317 neutral alpha-glucosidase C Starch and sucrose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) sucrose degradation TRUE
+K15922 sulfoquinovosidase Starch and sucrose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) sucrose degradation TRUE
+K00690 sucrose phosphorylase Starch and sucrose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) sucrose degradation TRUE
+K00847 fructokinase Fructose and mannose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) fructose degradation TRUE
+K00844 hexokinase Fructose and mannose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) fructose degradation TRUE
+K00844 hexokinase Fructose and mannose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) mannose degradation TRUE
+K02793 mannose PTS system EIIA component Fructose and mannose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) mannose degradation TRUE
+K02794 mannose PTS system EIIAB component Fructose and mannose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) mannose degradation TRUE
+K02795 mannose PTS system EIIC component Fructose and mannose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) mannose degradation TRUE
+K02796 mannose PTS system EIID component Fructose and mannose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) mannose degradation TRUE
+K01809 mannose-6-phosphate isomerase Fructose and mannose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) mannose degradation TRUE
+K01818 L-fucose/D-arabinose isomerase Fructose and mannose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) fucose degradation TRUE
+K00879 L-fuculokinase Fructose and mannose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) fucose degradation TRUE
+K01628 L-fuculose-phosphate aldolase Fructose and mannose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) fucose degradation TRUE
+K01805 xylose isomerase Fructose and mannose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) xylose degradation (isomerase pathway) TRUE
+K00854 xylulokinase Fructose and mannose metabolism carbon utilization (Woodcroft) sugar utilization (woodcroft) xylose degradation (isomerase pathway) TRUE
+K17743 D-xylose reductase Pentose and glucuronate interconversions carbon utilization (Woodcroft) sugar utilization (woodcroft) xylose degradation (oxidoreductase pathway) TRUE
+K00011 aldehyde reductase Pentose and glucuronate interconversions carbon utilization (Woodcroft) sugar utilization (woodcroft) xylose degradation (oxidoreductase pathway) TRUE
+K05351 D-xylulose reductase Pentose and glucuronate interconversions carbon utilization (Woodcroft) sugar utilization (woodcroft) xylose degradation (oxidoreductase pathway) TRUE
+K00008 L-iditol 2-dehydrogenase Pentose and glucuronate interconversions carbon utilization (Woodcroft) sugar utilization (woodcroft) xylose degradation (oxidoreductase pathway) TRUE
+K00854 xylulokinase Pentose and glucuronate interconversions carbon utilization (Woodcroft) sugar utilization (woodcroft) xylose degradation (oxidoreductase pathway) TRUE
+K14275 D-xylonate dehydratase Pentose and glucuronate interconversions carbon utilization (Woodcroft) sugar utilization (woodcroft) xylose degradation (xylonate hydratase pathway) TRUE
+K00078 dihydrodiol dehydrogenase / D-xylose 1-dehydrogenase (NADP) Pentose and glucuronate interconversions carbon utilization (Woodcroft) sugar utilization (woodcroft) xylose degradation (weimburg/dahms) TRUE
+K14273 D-xylose 1-dehydrogenase (NADP+) Pentose and glucuronate interconversions carbon utilization (Woodcroft) sugar utilization (woodcroft) xylose degradation (weimburg/dahms) TRUE
+K14274 "xylono-1,5-lactonase" Pentose and glucuronate interconversions carbon utilization (Woodcroft) sugar utilization (woodcroft) xylose degradation (weimburg/dahms) TRUE
+K14275 D-xylonate dehydratase Pentose and glucuronate interconversions carbon utilization (Woodcroft) sugar utilization (woodcroft) xylose degradation (weimburg/dahms) TRUE
+AA Lytic polygalacturonic acid monooxygenase (C4-hydroxylating) (EC 1.14.99.-) Auxiliary Activities carbon utilization CAZY TRUE
+CE18 N-acetylgalactosamine deacetylase (EC 3.5.1.-) Carbohydrate Esterases carbon utilization CAZY TRUE
+CE19 Carbohydrate Esterases carbon utilization CAZY TRUE
+CE20 Carbohydrate Esterases carbon utilization CAZY TRUE
+GH167 beta-carrageenase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH168 "endo-alpha-(1,3)-L-fucanase (EC 3.2.1.211)" Glycoside Hydrolases carbon utilization CAZY TRUE
+GH169 "beta-glucuronidase (EC 3.2.1.31); beta-1,4-D-glucuronidase (EC 3.2.1.-)" Glycoside Hydrolases carbon utilization CAZY TRUE
+GH170 6-phospho-N-acetylmuramidase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH171 peptidoglycan beta-N-acetylmuramidase (EC 3.2.1.92) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH172 difructose-anhydride-I synthase (EC 4.2.1.179 (old 3.2.1.134)); alpha-D-Arabinofuranosidase (EC 3.2.1.-); alpha-D-Fructofuranosidase (EC 3.2.1.-) Glycoside Hydrolases carbon utilization CAZY TRUE
+GH173 beta-galactosidase (EC 3.2.1.23) Glycoside Hydrolases carbon utilization CAZY TRUE
+PL38 "endo-_-1,4-glucuronan lyase (EC 4.2.2.14)" Polysaccharide Lyases carbon utilization CAZY TRUE
+PL39 alginate lyase (EC 4.2.2.-) Polysaccharide Lyases carbon utilization CAZY TRUE
+PL40 ulvan lyase (EC 4.2.2.-) Polysaccharide Lyases carbon utilization CAZY TRUE
+PL41 alginate lyase (EC 4.2.2.3) Polysaccharide Lyases carbon utilization CAZY TRUE
+PL42 "L-rhamnose-_-1,4-D-glucuronate lyase (EC 4.2.2.-); L-Rh_-_-1,4-GlcA _-L-rhamnohydrolase (EC 3.2.1.-)" Polysaccharide Lyases carbon utilization CAZY TRUE
+CBM86 Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM87 "Binding to alpha-1,4-N-acetylgalactosamine-rich regions of galactosaminogalactan" Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM88 Binding to terminal galactose in galactoxyloglucan and galactomannan Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM89 Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM90 Modules of approx 110 residues appended to PL24 and PL28 ulvan lyases; ulvan-binding function demonstrated for the CBM90 module of PL28 ulvan lyase from Nonlabens ulvanivorans Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+CBM91 Binding to xylans (birchwood and oat spelt) Carbohydrate-Binding Modules carbon utilization CAZY TRUE
+GT108 "GDP-alpha-D-Manp: beta-1,2-D-mannosyltransferase (EC 2.4.1.374)" GlycosylTransferases carbon utilization CAZY TRUE
+GT109 "UDP-GalNAc: beta-1,4-N-acetylgalactosaminyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT110 "galactoside alpha-1,3/1,4-L-fucosyltransferase (EC 2.4.1.65); galactoside alpha-1,3-L-fucosyltransferase (EC 2.4.1.152); glycoprotein alpha-1,3-L-fucosyltransferase (EC 2.4.1.214)" GlycosylTransferases carbon utilization CAZY TRUE
+GT111 "UDP-Galf: beta-1,3-galactofuranosyltransferase (EC 2.4.1.-)" GlycosylTransferases carbon utilization CAZY TRUE
+GT112 ADP-glyceromannoheptose: glycoprotein O-heptosyltransferase (EC 2.4.99.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT113 Glucosyltransferase (2.4.1.-); Hexosyltransferase (2.4.1.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT114 beta-xylosyltransferase (EC 2.4.1.-) GlycosylTransferases carbon utilization CAZY TRUE
+GT115 UDP-GlcNAc: Dol-PP-GlcNAc beta-GlcNAc-transferase (EC 2.4.1.-) GlycosylTransferases carbon utilization CAZY TRUE
diff --git a/tests/reference_dbs/dram_dbs/module_step_form.tsv b/tests/reference_dbs/dram_dbs/module_step_form.tsv
new file mode 100644
index 0000000..8cc5188
--- /dev/null
+++ b/tests/reference_dbs/dram_dbs/module_step_form.tsv
@@ -0,0 +1,3289 @@
+gene ko module module_name path product_ids product_names substrate_ids substrate_names
+hexokinase/glucokinase [EC:2.7.1.1 2.7.1.2] [RN:R01786] K00844 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 0,0 C00668 alpha-D-Glucose 6-phosphate C00267 alpha-D-Glucose
+hexokinase/glucokinase [EC:2.7.1.1 2.7.1.2] [RN:R01786] K12407 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 0,1 C00668 alpha-D-Glucose 6-phosphate C00267 alpha-D-Glucose
+hexokinase/glucokinase [EC:2.7.1.1 2.7.1.2] [RN:R01786] K00845 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 0,2 C00668 alpha-D-Glucose 6-phosphate C00267 alpha-D-Glucose
+polyphosphate glucokinase [EC:2.7.1.63] [RN:R02189] K00886 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 0,3 C00668 alpha-D-Glucose 6-phosphate C00267 alpha-D-Glucose
+K00918 ADP-dependent glucokinase [EC:2.7.1.147] [RN:R09085] K08074 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 0,4 C00668 alpha-D-Glucose 6-phosphate C00267 alpha-D-Glucose
+ADP-dependent phosphofructokinase [EC:2.7.1.146] [RN:R09084] K00918 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 0,5 C05378 beta-D-Fructose 1,6-bisphosphate C05345 beta-D-Fructose 6-phosphate
+glucose-6-phosphate isomerase [EC:5.3.1.9] [RN:R02740] K01810 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 1,0 C05345 beta-D-Fructose 6-phosphate C00668 alpha-D-Glucose 6-phosphate
+glucose-6-phosphate isomerase [EC:5.3.1.9] [RN:R02740] K06859 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 1,1 C05345 beta-D-Fructose 6-phosphate C00668 alpha-D-Glucose 6-phosphate
+glucose-6-phosphate isomerase [EC:5.3.1.9] [RN:R02740] K13810 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 1,2 C05345 beta-D-Fructose 6-phosphate C00668 alpha-D-Glucose 6-phosphate
+glucose-6-phosphate isomerase [EC:5.3.1.9] [RN:R02740] K15916 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 1,3 C05345 beta-D-Fructose 6-phosphate C00668 alpha-D-Glucose 6-phosphate
+6-phosphofructokinase [EC:2.7.1.11] [RN:R04779] K00850 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 2,0 C05378 beta-D-Fructose 1,6-bisphosphate C05345 beta-D-Fructose 6-phosphate
+6-phosphofructokinase [EC:2.7.1.11] [RN:R04779] K16370 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 2,1 C05378 beta-D-Fructose 1,6-bisphosphate C05345 beta-D-Fructose 6-phosphate
+ADP-dependent phosphofructokinase [EC:2.7.1.146] [RN:R09084] K00918 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 2,2 C05378 beta-D-Fructose 1,6-bisphosphate C05345 beta-D-Fructose 6-phosphate
+fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01070] K01623 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 3,0 C00111,C00118 Glycerone phosphate,D-Glyceraldehyde 3-phosphate C05378 beta-D-Fructose 1,6-bisphosphate
+fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01070] K01624 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 3,1 C00111,C00118 Glycerone phosphate,D-Glyceraldehyde 3-phosphate C05378 beta-D-Fructose 1,6-bisphosphate
+fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01070] K11645 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 3,2 C00111,C00118 Glycerone phosphate,D-Glyceraldehyde 3-phosphate C05378 beta-D-Fructose 1,6-bisphosphate
+fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01070] K16305 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 3,3 C00111,C00118 Glycerone phosphate,D-Glyceraldehyde 3-phosphate C05378 beta-D-Fructose 1,6-bisphosphate
+fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01070] K16306 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 3,4 C00111,C00118 Glycerone phosphate,D-Glyceraldehyde 3-phosphate C05378 beta-D-Fructose 1,6-bisphosphate
+triosephosphate isomerase [EC:5.3.1.1] [RN:R01015] K01803 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 4,0 C00118 D-Glyceraldehyde 3-phosphate C00111 Glycerone phosphate
+glyceraldehyde 3-phosphate dehydrogenase [EC:1.2.1.12 1.2.1.59] [RN:R01061 R01063] K00134 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 5,0,0,0 C00236 3-Phospho-D-glyceroyl phosphate C00118 D-Glyceraldehyde 3-phosphate
+glyceraldehyde 3-phosphate dehydrogenase [EC:1.2.1.12 1.2.1.59] [RN:R01061 R01063] K00150 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 5,0,0,1 C00236 3-Phospho-D-glyceroyl phosphate C00118 D-Glyceraldehyde 3-phosphate
+phosphoglycerate kinase [EC:2.7.2.3] [RN:R01512] K00927 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 5,0,1,0 C00197 3-Phospho-D-glycerate C00236 3-Phospho-D-glyceroyl phosphate
+glyceraldehyde-3-phosphate dehydrogenase (ferredoxin) [EC:1.2.7.6] [RN:R07159] K11389 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 5,1 C00197 3-Phospho-D-glycerate C00118 D-Glyceraldehyde 3-phosphate
+phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] K01834 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 6,0 C00631 2-Phospho-D-glycerate C00197 3-Phospho-D-glycerate
+phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] K15633 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 6,1 C00631 2-Phospho-D-glycerate C00197 3-Phospho-D-glycerate
+phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] K15634 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 6,2 C00631 2-Phospho-D-glycerate C00197 3-Phospho-D-glycerate
+phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] K15635 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 6,3 C00631 2-Phospho-D-glycerate C00197 3-Phospho-D-glycerate
+enolase [EC:4.2.1.11] [RN:R00658] K01689 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 7,0 C00074 Phosphoenolpyruvate C00631 2-Phospho-D-glycerate
+pyruvate kinase [EC:2.7.1.40] [RN:R00200] K00873 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 8,0 C00022 Pyruvate C00074 Phosphoenolpyruvate
+pyruvate kinase [EC:2.7.1.40] [RN:R00200] K12406 M00001 Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 8,1 C00022 Pyruvate C00074 Phosphoenolpyruvate
+triosephosphate isomerase [EC:5.3.1.1] [RN:R01015] K01803 M00002 Glycolysis, core module involving three-carbon compounds 0,0 C00118 D-Glyceraldehyde 3-phosphate C00111 Glycerone phosphate
+glyceraldehyde 3-phosphate dehydrogenase [EC:1.2.1.12 1.2.1.59] [RN:R01061 R01063] K00134 M00002 Glycolysis, core module involving three-carbon compounds 1,0,0,0 C00236 3-Phospho-D-glyceroyl phosphate C00118 D-Glyceraldehyde 3-phosphate
+glyceraldehyde 3-phosphate dehydrogenase [EC:1.2.1.12 1.2.1.59] [RN:R01061 R01063] K00150 M00002 Glycolysis, core module involving three-carbon compounds 1,0,0,1 C00236 3-Phospho-D-glyceroyl phosphate C00118 D-Glyceraldehyde 3-phosphate
+phosphoglycerate kinase [EC:2.7.2.3] [RN:R01512] K00927 M00002 Glycolysis, core module involving three-carbon compounds 1,0,1,0 C00197 3-Phospho-D-glycerate C00236 3-Phospho-D-glyceroyl phosphate
+glyceraldehyde-3-phosphate dehydrogenase (ferredoxin) [EC:1.2.7.6] [RN:R07159] K11389 M00002 Glycolysis, core module involving three-carbon compounds 1,1 C00197 3-Phospho-D-glycerate C00118 D-Glyceraldehyde 3-phosphate
+phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] K01834 M00002 Glycolysis, core module involving three-carbon compounds 2,0 C00631 2-Phospho-D-glycerate C00197 3-Phospho-D-glycerate
+phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] K15633 M00002 Glycolysis, core module involving three-carbon compounds 2,1 C00631 2-Phospho-D-glycerate C00197 3-Phospho-D-glycerate
+phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] K15634 M00002 Glycolysis, core module involving three-carbon compounds 2,2 C00631 2-Phospho-D-glycerate C00197 3-Phospho-D-glycerate
+phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] K15635 M00002 Glycolysis, core module involving three-carbon compounds 2,3 C00631 2-Phospho-D-glycerate C00197 3-Phospho-D-glycerate
+enolase [EC:4.2.1.11] [RN:R00658] K01689 M00002 Glycolysis, core module involving three-carbon compounds 3,0 C00074 Phosphoenolpyruvate C00631 2-Phospho-D-glycerate
+pyruvate kinase [EC:2.7.1.40] [RN:R00200] K00873 M00002 Glycolysis, core module involving three-carbon compounds 4,0 C00022 Pyruvate C00074 Phosphoenolpyruvate
+pyruvate kinase [EC:2.7.1.40] [RN:R00200] K12406 M00002 Glycolysis, core module involving three-carbon compounds 4,1 C00022 Pyruvate C00074 Phosphoenolpyruvate
+phosphoenolpyruvate carboxykinase [EC:4.1.1.32 4.1.1.49] [RN:R00431 R00726 R00341] K01596 M00003 Gluconeogenesis, oxaloacetate => fructose-6P 0,0 C00074 Phosphoenolpyruvate C00036 Oxaloacetate
+phosphoenolpyruvate carboxykinase [EC:4.1.1.32 4.1.1.49] [RN:R00431 R00726 R00341] K01610 M00003 Gluconeogenesis, oxaloacetate => fructose-6P 0,1 C00074 Phosphoenolpyruvate C00036 Oxaloacetate
+enolase [EC:4.2.1.11] [RN:R00658] K01689 M00003 Gluconeogenesis, oxaloacetate => fructose-6P 1,0 C00631 2-Phospho-D-glycerate C00074 Phosphoenolpyruvate
+phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] K01834 M00003 Gluconeogenesis, oxaloacetate => fructose-6P 2,0 C00197 3-Phospho-D-glycerate C00631 2-Phospho-D-glycerate
+phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] K15633 M00003 Gluconeogenesis, oxaloacetate => fructose-6P 2,1 C00197 3-Phospho-D-glycerate C00631 2-Phospho-D-glycerate
+phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] K15634 M00003 Gluconeogenesis, oxaloacetate => fructose-6P 2,2 C00197 3-Phospho-D-glycerate C00631 2-Phospho-D-glycerate
+phosphoglycerate mutase [EC:5.4.2.11 5.4.2.12] [RN:R01518] K15635 M00003 Gluconeogenesis, oxaloacetate => fructose-6P 2,3 C00197 3-Phospho-D-glycerate C00631 2-Phospho-D-glycerate
+phosphoglycerate kinase [EC:2.7.2.3] [RN:R01512] K00927 M00003 Gluconeogenesis, oxaloacetate => fructose-6P 3,0 C00236 3-Phospho-D-glyceroyl phosphate C00197 3-Phospho-D-glycerate
+glyceraldehyde 3-phosphate dehydrogenase [EC:1.2.1.12 1.2.1.59] [RN:R01061 R01063] K00134 M00003 Gluconeogenesis, oxaloacetate => fructose-6P 4,0 C00118 (2R)-2-Hydroxy-3-(phosphonooxy)-propanal C00236 3-Phospho-D-glyceroyl phosphate
+glyceraldehyde 3-phosphate dehydrogenase [EC:1.2.1.12 1.2.1.59] [RN:R01061 R01063] K00150 M00003 Gluconeogenesis, oxaloacetate => fructose-6P 4,1 C00118 (2R)-2-Hydroxy-3-(phosphonooxy)-propanal C00236 3-Phospho-D-glyceroyl phosphate
+triosephosphate isomerase (TIM) [EC:5.3.1.1] [RN:R01015] K01803 M00003 Gluconeogenesis, oxaloacetate => fructose-6P 5,0 C00111 Glycerone phosphate C00118 (2R)-2-Hydroxy-3-(phosphonooxy)-propanal
+fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01070] K01623 M00003 Gluconeogenesis, oxaloacetate => fructose-6P 6,0,0,0 C05378 beta-D-Fructose 1,6-bisphosphate C00111,C00118 Glycerone phosphate,(2R)-2-Hydroxy-3-(phosphonooxy)-propanal
+fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01070] K01624 M00003 Gluconeogenesis, oxaloacetate => fructose-6P 6,0,0,1 C05378 beta-D-Fructose 1,6-bisphosphate C00111,C00118 Glycerone phosphate,(2R)-2-Hydroxy-3-(phosphonooxy)-propanal
+fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01070] K11645 M00003 Gluconeogenesis, oxaloacetate => fructose-6P 6,0,0,2 C05378 beta-D-Fructose 1,6-bisphosphate C00111,C00118 Glycerone phosphate,(2R)-2-Hydroxy-3-(phosphonooxy)-propanal
+fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R04780] K03841 M00003 Gluconeogenesis, oxaloacetate => fructose-6P 6,0,1,0 C05345 beta-D-Fructose 6-phosphate C05378 beta-D-Fructose 1,6-bisphosphate
+fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R04780] K02446 M00003 Gluconeogenesis, oxaloacetate => fructose-6P 6,0,1,1 C05345 beta-D-Fructose 6-phosphate C05378 beta-D-Fructose 1,6-bisphosphate
+fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R04780] K11532 M00003 Gluconeogenesis, oxaloacetate => fructose-6P 6,0,1,2 C05345 beta-D-Fructose 6-phosphate C05378 beta-D-Fructose 1,6-bisphosphate
+fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R04780] K01086 M00003 Gluconeogenesis, oxaloacetate => fructose-6P 6,0,1,3 C05345 beta-D-Fructose 6-phosphate C05378 beta-D-Fructose 1,6-bisphosphate
+fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R04780] K04041 M00003 Gluconeogenesis, oxaloacetate => fructose-6P 6,0,1,4 C05345 beta-D-Fructose 6-phosphate C05378 beta-D-Fructose 1,6-bisphosphate
+fructose 1,6-bisphosphate aldolase/phosphatase [EC:4.1.2.13 3.1.3.11] [RN:R01070 R04780] K01622 M00003 Gluconeogenesis, oxaloacetate => fructose-6P 6,1 C05345 beta-D-Fructose 6-phosphate C05378 beta-D-Fructose 1,6-bisphosphate
+hexose-6-phosphate dehydrogenase [EC:1.1.1.47 3.1.1.31] [RN:R02736 R02035] K13937 M00004 Pentose phosphate pathway (Pentose phosphate cycle) 0,0 C00345 6-Phospho-D-gluconate C01236 D-Glucono-1,5-lactone 6-phosphate
+glucose-6-phosphate 1-dehydrogenase [EC:1.1.1.49 1.1.1.363 1.1.1.388] [RN:R02736 R10907] K00036 M00004 Pentose phosphate pathway (Pentose phosphate cycle) 0,1,0,0 C01236 D-Glucono-1,5-lactone 6-phosphate C01172 beta-D-Glucose 6-phosphate
+glucose-6-phosphate 1-dehydrogenase [EC:1.1.1.49 1.1.1.363 1.1.1.388] [RN:R02736 R10907] K19243 M00004 Pentose phosphate pathway (Pentose phosphate cycle) 0,1,0,1 C01236 D-Glucono-1,5-lactone 6-phosphate C01172 beta-D-Glucose 6-phosphate
+6-phosphogluconolactonase [EC:3.1.1.31] [RN:R02035] K01057 M00004 Pentose phosphate pathway (Pentose phosphate cycle) 0,1,1,0 C00345 6-Phospho-D-gluconate C01236 D-Glucono-1,5-lactone 6-phosphate
+6-phosphogluconolactonase [EC:3.1.1.31] [RN:R02035] K07404 M00004 Pentose phosphate pathway (Pentose phosphate cycle) 0,1,1,1 C00345 6-Phospho-D-gluconate C01236 D-Glucono-1,5-lactone 6-phosphate
+6-phosphogluconate dehydrogenase [EC:1.1.1.44 1.1.1.343] [RN:R01528 R10221] K00033 M00004 Pentose phosphate pathway (Pentose phosphate cycle) 1,0 C00199 D-Ribulose 5-phosphate C00345 6-Phospho-D-gluconate
+ribulose-phosphate 3-epimerase [EC:5.1.3.1] [RN:R01529] K01783 M00004 Pentose phosphate pathway (Pentose phosphate cycle) 2,0 C00231 D-Xylulose 5-phosphate C00199 D-Ribulose 5-phosphate
+ribose 5-phosphate isomerase [EC:5.3.1.6] [RN:R01056] K01807 M00004 Pentose phosphate pathway (Pentose phosphate cycle) 3,0 C00117 D-Ribose 5-phosphate C00199 D-Ribulose 5-phosphate
+ribose 5-phosphate isomerase [EC:5.3.1.6] [RN:R01056] K01808 M00004 Pentose phosphate pathway (Pentose phosphate cycle) 3,1 C00117 D-Ribose 5-phosphate C00199 D-Ribulose 5-phosphate
+transketolase [EC:2.2.1.1] [RN:R01641] K00615 M00004 Pentose phosphate pathway (Pentose phosphate cycle) 4,0 C05382,C00118 Sedoheptulose 7-phosphate,D-Glyceraldehyde 3-phosphate C00117,C00231 D-Ribose 5-phosphate,D-Xylulose 5-phosphate
+transaldolase [EC:2.2.1.2] [RN:R01827] K00616 M00004 Pentose phosphate pathway (Pentose phosphate cycle) 5,0 C00279,C05345 D-Erythrose 4-phosphate,beta-D-Fructose 6-phosphate C05382,C00118 Sedoheptulose 7-phosphate,D-Glyceraldehyde 3-phosphate
+glucose-6-phosphate isomerase [EC:5.3.1.9] [RN:R02740 R02739] K01810 M00004 Pentose phosphate pathway (Pentose phosphate cycle) 6,0 C01172 beta-D-Glucose 6-phosphate C00668 alpha-D-Glucose 6-phosphate
+glucose-6-phosphate isomerase [EC:5.3.1.9] [RN:R02740 R02739] K06859 M00004 Pentose phosphate pathway (Pentose phosphate cycle) 6,1 C01172 beta-D-Glucose 6-phosphate C00668 alpha-D-Glucose 6-phosphate
+glucose-6-phosphate isomerase [EC:5.3.1.9] [RN:R02740 R02739] K13810 M00004 Pentose phosphate pathway (Pentose phosphate cycle) 6,2 C01172 beta-D-Glucose 6-phosphate C00668 alpha-D-Glucose 6-phosphate
+glucose-6-phosphate isomerase [EC:5.3.1.9] [RN:R02740 R02739] K15916 M00004 Pentose phosphate pathway (Pentose phosphate cycle) 6,3 C01172 beta-D-Glucose 6-phosphate C00668 alpha-D-Glucose 6-phosphate
+ribose-phosphate pyrophosphokinase [EC:2.7.6.1] [RN:R01049] K00948 M00005 PRPP biosynthesis, ribose 5P => PRPP 0,0 C00119 5-Phospho-alpha-D-ribose 1-diphosphate C00117 D-Ribose 5-phosphate
+hexose-6-phosphate dehydrogenase [EC:1.1.1.47 3.1.1.31] [RN:R02736 R02035] K13937 M00006 Pentose phosphate pathway, oxidative phase, glucose 6P => ribulose 5P 0,0 C00345 6-Phospho-D-gluconate C01236 D-Glucono-1,5-lactone 6-phosphate
+glucose-6-phosphate 1-dehydrogenase [EC:1.1.1.49 1.1.1.363 1.1.1.388] [RN:R02736 R10907] K00036 M00006 Pentose phosphate pathway, oxidative phase, glucose 6P => ribulose 5P 0,1,0,0 C01236 D-Glucono-1,5-lactone 6-phosphate C01172 beta-D-Glucose 6-phosphate
+glucose-6-phosphate 1-dehydrogenase [EC:1.1.1.49 1.1.1.363 1.1.1.388] [RN:R02736 R10907] K19243 M00006 Pentose phosphate pathway, oxidative phase, glucose 6P => ribulose 5P 0,1,0,1 C01236 D-Glucono-1,5-lactone 6-phosphate C01172 beta-D-Glucose 6-phosphate
+6-phosphogluconolactonase [EC:3.1.1.31] [RN:R02035] K01057 M00006 Pentose phosphate pathway, oxidative phase, glucose 6P => ribulose 5P 0,1,1,0 C00345 6-Phospho-D-gluconate C01236 D-Glucono-1,5-lactone 6-phosphate
+6-phosphogluconolactonase [EC:3.1.1.31] [RN:R02035] K07404 M00006 Pentose phosphate pathway, oxidative phase, glucose 6P => ribulose 5P 0,1,1,1 C00345 6-Phospho-D-gluconate C01236 D-Glucono-1,5-lactone 6-phosphate
+6-phosphogluconate dehydrogenase [EC:1.1.1.44 1.1.1.343] [RN:R01528 R10221] K00033 M00006 Pentose phosphate pathway, oxidative phase, glucose 6P => ribulose 5P 1,0 C00199 D-Ribulose 5-phosphate C00345 6-Phospho-D-gluconate
+transketolase [EC:2.2.1.1] [RN:R01830 R01641] K00615 M00007 Pentose phosphate pathway, non-oxidative phase, fructose 6P => ribose 5P 0,0 C00117,C00231 D-Ribose 5-phosphate,D-Xylulose 5-phosphate C05382,C00118 Sedoheptulose 7-phosphate,D-Glyceraldehyde 3-phosphate
+transaldolase [EC:2.2.1.2] [RN:R01827] K00616 M00007 Pentose phosphate pathway, non-oxidative phase, fructose 6P => ribose 5P 1,0 C05382,C00118 Sedoheptulose 7-phosphate,D-Glyceraldehyde 3-phosphate C00279,C05345 D-Erythrose 4-phosphate,beta-D-Fructose 6-phosphate
+transaldolase [EC:2.2.1.2] [RN:R01827] K13810 M00007 Pentose phosphate pathway, non-oxidative phase, fructose 6P => ribose 5P 1,1 C05382,C00118 Sedoheptulose 7-phosphate,D-Glyceraldehyde 3-phosphate C00279,C05345 D-Erythrose 4-phosphate,beta-D-Fructose 6-phosphate
+ribulose-phosphate 3-epimerase [EC:5.1.3.1] [RN:R01529] K01783 M00007 Pentose phosphate pathway, non-oxidative phase, fructose 6P => ribose 5P 2,0 C00199 D-Ribulose 5-phosphate C00231 D-Xylulose 5-phosphate
+ribose 5-phosphate isomerase [EC:5.3.1.6] [RN:R01056] K01807 M00007 Pentose phosphate pathway, non-oxidative phase, fructose 6P => ribose 5P 3,0 C00117 D-Ribose 5-phosphate C00199 D-Ribulose 5-phosphate
+ribose 5-phosphate isomerase [EC:5.3.1.6] [RN:R01056] K01808 M00007 Pentose phosphate pathway, non-oxidative phase, fructose 6P => ribose 5P 3,1 C00117 D-Ribose 5-phosphate C00199 D-Ribulose 5-phosphate
+glucose-6-phosphate 1-dehydrogenase [EC:1.1.1.49 1.1.1.363] [RN:R02736 R10907] K00036 M00008 Entner-Doudoroff pathway, glucose-6P => glyceraldehyde-3P + pyruvate 0,0 C01236 D-Glucono-1,5-lactone 6-phosphate C01172 beta-D-Glucose 6-phosphate
+6-phosphogluconolactonase [EC:3.1.1.31] [RN:R02035] K01057 M00008 Entner-Doudoroff pathway, glucose-6P => glyceraldehyde-3P + pyruvate 1,0 C00345 6-Phospho-D-gluconate C01236 D-Glucono-1,5-lactone 6-phosphate
+6-phosphogluconolactonase [EC:3.1.1.31] [RN:R02035] K07404 M00008 Entner-Doudoroff pathway, glucose-6P => glyceraldehyde-3P + pyruvate 1,1 C00345 6-Phospho-D-gluconate C01236 D-Glucono-1,5-lactone 6-phosphate
+phosphogluconate dehydratase [EC:4.2.1.12] [RN:R02036] K01690 M00008 Entner-Doudoroff pathway, glucose-6P => glyceraldehyde-3P + pyruvate 2,0 C04442 2-Dehydro-3-deoxy-6-phospho-D-gluconate C00345 6-Phospho-D-gluconate
+2-dehydro-3-deoxyphosphogluconate aldolase [EC:4.1.2.14] [RN:R05605] K01625 M00008 Entner-Doudoroff pathway, glucose-6P => glyceraldehyde-3P + pyruvate 3,0 C00118,C00022 D-Glyceraldehyde 3-phosphate,Pyruvate C04442 2-Dehydro-3-deoxy-6-phospho-D-gluconate
+citrate synthase [EC:2.3.3.1] [RN:R00351] K01647 M00009 Citrate cycle (TCA cycle, Krebs cycle) 0,0 C00158 Citrate C00024,C00036 Acetyl-CoA,Oxaloacetate
+citrate (Re)-synthase [EC:2.3.3.3] [RN:R00351] K05942 M00009 Citrate cycle (TCA cycle, Krebs cycle) 0,1 C00158 Citrate C00024,C00036 Acetyl-CoA,Oxaloacetate
+aconitate hydratase [EC:4.2.1.3] [RN:R01325 R01900 R01324] K01681 M00009 Citrate cycle (TCA cycle, Krebs cycle) 1,0 C00311 Isocitrate C00158 Citrate
+aconitate hydratase [EC:4.2.1.3] [RN:R01325 R01900 R01324] K01682 M00009 Citrate cycle (TCA cycle, Krebs cycle) 1,1 C00311 Isocitrate C00158 Citrate
+isocitrate dehydrogenase [EC:1.1.1.42 1.1.1.41] [RN:R01899 R00268 R00267 R00709] K00031 M00009 Citrate cycle (TCA cycle, Krebs cycle) 2,0 C00026 2-Oxoglutarate C00311 Isocitrate
+isocitrate dehydrogenase [EC:1.1.1.42 1.1.1.41] [RN:R01899 R00268 R00267 R00709] K00030 M00009 Citrate cycle (TCA cycle, Krebs cycle) 2,1 C00026 2-Oxoglutarate C00311 Isocitrate
+2-oxoglutarate dehydrogenase complex [EC:1.2.4.2 2.3.1.61 1.8.1.4] [RN:R00621 R03316 R02570 R07618] K00164 M00009 Citrate cycle (TCA cycle, Krebs cycle) 3,0 C15972 Enzyme N6-(lipoyl)lysine C15973 Enzyme N6-(dihydrolipoyl)lysine
+2-oxoglutarate dehydrogenase complex [EC:1.2.4.2 2.3.1.61 1.8.1.4] [RN:R00621 R03316 R02570 R07618] K00658 M00009 Citrate cycle (TCA cycle, Krebs cycle) 3,0 C15972 Enzyme N6-(lipoyl)lysine C15973 Enzyme N6-(dihydrolipoyl)lysine
+2-oxoglutarate dehydrogenase complex [EC:1.2.4.2 2.3.1.61 1.8.1.4] [RN:R00621 R03316 R02570 R07618] K00382 M00009 Citrate cycle (TCA cycle, Krebs cycle) 3,0 C15972 Enzyme N6-(lipoyl)lysine C15973 Enzyme N6-(dihydrolipoyl)lysine
+2-oxoglutarate/2-oxoacid ferredoxin oxidoreductase subunit alpha [EC:1.2.7.3 1.2.7.11] [RN:R01197] K00174 M00009 Citrate cycle (TCA cycle, Krebs cycle) 3,1 C00091 Succinyl-CoA C00026 2-Oxoglutarate
+2-oxoglutarate/2-oxoacid ferredoxin oxidoreductase subunit beta [EC:1.2.7.3 1.2.7.11] [RN:R01197] K00175 M00009 Citrate cycle (TCA cycle, Krebs cycle) 3,1 C00091 Succinyl-CoA C00026 2-Oxoglutarate
+2-oxoglutarate ferredoxin oxidoreductase subunit gamma [EC:1.2.7.3] [RN:R01197] K00177 M00009 Citrate cycle (TCA cycle, Krebs cycle) 3,1 C00091 Succinyl-CoA C00026 2-Oxoglutarate
+2-oxoglutarate ferredoxin oxidoreductase subunit delta [EC:1.2.7.3] [RN:R01197] K00176 M00009 Citrate cycle (TCA cycle, Krebs cycle) 3,1 C00091 Succinyl-CoA C00026 2-Oxoglutarate
+succinyl-CoA synthetase [EC:6.2.1.5] [RN:R00405] K01902 M00009 Citrate cycle (TCA cycle, Krebs cycle) 4,0 C00042 Succinate C00091 Succinyl-CoA
+succinyl-CoA synthetase [EC:6.2.1.5] [RN:R00405] K01903 M00009 Citrate cycle (TCA cycle, Krebs cycle) 4,0 C00042 Succinate C00091 Succinyl-CoA
+succinyl-CoA synthetase [EC:6.2.1.4 6.2.1.5] [RN:R00405 R00432 R00727] K01899 M00009 Citrate cycle (TCA cycle, Krebs cycle) 4,1 C00042 Succinate C00091 Succinyl-CoA
+succinyl-CoA synthetase [EC:6.2.1.4 6.2.1.5] [RN:R00405 R00432 R00727] K01900 M00009 Citrate cycle (TCA cycle, Krebs cycle) 4,1 C00042 Succinate C00091 Succinyl-CoA
+succinyl-CoA:acetate CoA-transferase [EC:2.8.3.18] [RN:R10343] K18118 M00009 Citrate cycle (TCA cycle, Krebs cycle) 4,2 C00042 Succinate C00091 Succinyl-CoA
+succinate dehydrogenase [EC:1.3.5.1] [RN:R02164] K00234 M00009 Citrate cycle (TCA cycle, Krebs cycle) 5,0 C00122 Fumarate C00042 Succinate
+succinate dehydrogenase [EC:1.3.5.1] [RN:R02164] K00235 M00009 Citrate cycle (TCA cycle, Krebs cycle) 5,0 C00122 Fumarate C00042 Succinate
+succinate dehydrogenase [EC:1.3.5.1] [RN:R02164] K00236 M00009 Citrate cycle (TCA cycle, Krebs cycle) 5,0 C00122 Fumarate C00042 Succinate
+succinate dehydrogenase [EC:1.3.5.1] [RN:R02164] K00237 M00009 Citrate cycle (TCA cycle, Krebs cycle) 5,0 C00122 Fumarate C00042 Succinate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K00239 M00009 Citrate cycle (TCA cycle, Krebs cycle) 5,1 C00122 Fumarate C00042 Succinate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K00240 M00009 Citrate cycle (TCA cycle, Krebs cycle) 5,1 C00122 Fumarate C00042 Succinate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K00241 M00009 Citrate cycle (TCA cycle, Krebs cycle) 5,1 C00122 Fumarate C00042 Succinate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K00242 M00009 Citrate cycle (TCA cycle, Krebs cycle) 5,1 C00122 Fumarate C00042 Succinate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K18859 M00009 Citrate cycle (TCA cycle, Krebs cycle) 5,1 C00122 Fumarate C00042 Succinate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K18860 M00009 Citrate cycle (TCA cycle, Krebs cycle) 5,1 C00122 Fumarate C00042 Succinate
+fumarate reductase [EC:1.3.5.4] [RN:R02164] K00244 M00009 Citrate cycle (TCA cycle, Krebs cycle) 5,2 C00122 Fumarate C00042 Succinate
+fumarate reductase [EC:1.3.5.4] [RN:R02164] K00245 M00009 Citrate cycle (TCA cycle, Krebs cycle) 5,2 C00122 Fumarate C00042 Succinate
+fumarate reductase [EC:1.3.5.4] [RN:R02164] K00246 M00009 Citrate cycle (TCA cycle, Krebs cycle) 5,2 C00122 Fumarate C00042 Succinate
+fumarate reductase [EC:1.3.5.4] [RN:R02164] K00247 M00009 Citrate cycle (TCA cycle, Krebs cycle) 5,2 C00122 Fumarate C00042 Succinate
+fumarate hydratase [EC:4.2.1.2] [RN:R01082] K01676 M00009 Citrate cycle (TCA cycle, Krebs cycle) 6,0 C00149 (S)-Malate C00122 Fumarate
+fumarate hydratase [EC:4.2.1.2] [RN:R01082] K01679 M00009 Citrate cycle (TCA cycle, Krebs cycle) 6,1 C00149 (S)-Malate C00122 Fumarate
+fumarate hydratase [EC:4.2.1.2] [RN:R01082] K01677 M00009 Citrate cycle (TCA cycle, Krebs cycle) 6,2 C00149 (S)-Malate C00122 Fumarate
+fumarate hydratase [EC:4.2.1.2] [RN:R01082] K01678 M00009 Citrate cycle (TCA cycle, Krebs cycle) 6,2 C00149 (S)-Malate C00122 Fumarate
+malate dehydrogenase [EC:1.1.1.37] [RN:R00342] K00026 M00009 Citrate cycle (TCA cycle, Krebs cycle) 7,0 C00036 Oxaloacetate C00149 (S)-Malate
+malate dehydrogenase [EC:1.1.1.37] [RN:R00342] K00025 M00009 Citrate cycle (TCA cycle, Krebs cycle) 7,1 C00036 Oxaloacetate C00149 (S)-Malate
+malate dehydrogenase [EC:1.1.1.37] [RN:R00342] K00024 M00009 Citrate cycle (TCA cycle, Krebs cycle) 7,2 C00036 Oxaloacetate C00149 (S)-Malate
+malate dehydrogenase (quinone) [EC:1.1.5.4] [RN:R00361] K00116 M00009 Citrate cycle (TCA cycle, Krebs cycle) 7,3 C00036 Oxaloacetate C00149 (S)-Malate
+citrate synthase [EC:2.3.3.1] [RN:R00351] K01647 M00010 Citrate cycle, first carbon oxidation, oxaloacetate => 2-oxoglutarate 0,0 C00158 Citrate C00036,C00024 Oxaloacetate,Acetyl-CoA
+citrate (Re)-synthase [EC:2.3.3.3] [RN:R00351] K05942 M00010 Citrate cycle, first carbon oxidation, oxaloacetate => 2-oxoglutarate 0,1 C00158 Citrate C00036,C00024 Oxaloacetate,Acetyl-CoA
+aconitate hydratase [EC:4.2.1.3] [RN:R01325 R01900 R01324] K01681 M00010 Citrate cycle, first carbon oxidation, oxaloacetate => 2-oxoglutarate 1,0 C00311 Isocitrate C00158 Citrate
+aconitate hydratase [EC:4.2.1.3] [RN:R01325 R01900 R01324] K01682 M00010 Citrate cycle, first carbon oxidation, oxaloacetate => 2-oxoglutarate 1,1 C00311 Isocitrate C00158 Citrate
+isocitrate dehydrogenase [EC:1.1.1.42 1.1.1.41] [RN:R01899 R00268 R00267 R00709] K00031 M00010 Citrate cycle, first carbon oxidation, oxaloacetate => 2-oxoglutarate 2,0 C00026 2-Oxoglutarate C00311 Isocitrate
+isocitrate dehydrogenase [EC:1.1.1.42 1.1.1.41] [RN:R01899 R00268 R00267 R00709] K00030 M00010 Citrate cycle, first carbon oxidation, oxaloacetate => 2-oxoglutarate 2,1 C00026 2-Oxoglutarate C00311 Isocitrate
+2-oxoglutarate dehydrogenase [EC:1.2.4.2 2.3.1.61 1.8.1.4] [RN:R00621 R03316 R02570 R07618] K00164 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 0,0 C15972 Enzyme N6-(lipoyl)lysine C15973 Enzyme N6-(dihydrolipoyl)lysine
+2-oxoglutarate dehydrogenase [EC:1.2.4.2 2.3.1.61 1.8.1.4] [RN:R00621 R03316 R02570 R07618] K00658 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 0,0 C15972 Enzyme N6-(lipoyl)lysine C15973 Enzyme N6-(dihydrolipoyl)lysine
+2-oxoglutarate dehydrogenase [EC:1.2.4.2 2.3.1.61 1.8.1.4] [RN:R00621 R03316 R02570 R07618] K00382 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 0,0 C15972 Enzyme N6-(lipoyl)lysine C15973 Enzyme N6-(dihydrolipoyl)lysine
+2-oxoglutarate/2-oxoacid ferredoxin oxidoreductase subunit alpha [EC:1.2.7.3 1.2.7.11] [RN:R01197] K00174 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 0,1 C00091 Succinyl-CoA C00026 2-Oxoglutarate
+2-oxoglutarate/2-oxoacid ferredoxin oxidoreductase subunit beta [EC:1.2.7.3 1.2.7.11] [RN:R01197] K00175 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 0,1 C00091 Succinyl-CoA C00026 2-Oxoglutarate
+2-oxoglutarate ferredoxin oxidoreductase subunit gamma [EC:1.2.7.3] [RN:R01197] K00177 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 0,1 C00091 Succinyl-CoA C00026 2-Oxoglutarate
+2-oxoglutarate ferredoxin oxidoreductase subunit delta [EC:1.2.7.3] [RN:R01197] K00176 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 0,1 C00091 Succinyl-CoA C00026 2-Oxoglutarate
+succinyl-CoA synthetase [EC:6.2.1.5] [RN:R00405] K01902 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 1,0 C00042 Succinate C00091 Succinyl-CoA
+succinyl-CoA synthetase [EC:6.2.1.5] [RN:R00405] K01903 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 1,0 C00042 Succinate C00091 Succinyl-CoA
+succinyl-CoA synthetase [EC:6.2.1.4 6.2.1.5] [RN:R00405 R00432 R00727] K01899 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 1,1 C00042 Succinate C00091 Succinyl-CoA
+succinyl-CoA synthetase [EC:6.2.1.4 6.2.1.5] [RN:R00405 R00432 R00727] K01900 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 1,1 C00042 Succinate C00091 Succinyl-CoA
+succinyl-CoA:acetate CoA-transferase [EC:2.8.3.18] [RN:R10343] K18118 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 1,2 C00042 Succinate C00091 Succinyl-CoA
+succinate dehydrogenase [EC:1.3.5.1] [RN:R02164] K00234 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 2,0 C00122 Fumarate C00042 Succinate
+succinate dehydrogenase [EC:1.3.5.1] [RN:R02164] K00235 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 2,0 C00122 Fumarate C00042 Succinate
+succinate dehydrogenase [EC:1.3.5.1] [RN:R02164] K00236 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 2,0 C00122 Fumarate C00042 Succinate
+succinate dehydrogenase [EC:1.3.5.1] [RN:R02164] K00237 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 2,0 C00122 Fumarate C00042 Succinate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K00239 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 2,1 C00122 Fumarate C00042 Succinate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K00240 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 2,1 C00122 Fumarate C00042 Succinate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K00241 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 2,1 C00122 Fumarate C00042 Succinate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K00242 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 2,1 C00122 Fumarate C00042 Succinate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K18859 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 2,1 C00122 Fumarate C00042 Succinate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K18860 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 2,1 C00122 Fumarate C00042 Succinate
+fumarate reductase [EC:1.3.5.4] [RN:R02164] K00244 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 2,2 C00122 Fumarate C00042 Succinate
+fumarate reductase [EC:1.3.5.4] [RN:R02164] K00245 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 2,2 C00122 Fumarate C00042 Succinate
+fumarate reductase [EC:1.3.5.4] [RN:R02164] K00246 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 2,2 C00122 Fumarate C00042 Succinate
+fumarate reductase [EC:1.3.5.4] [RN:R02164] K00247 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 2,2 C00122 Fumarate C00042 Succinate
+fumarate hydratase [EC:4.2.1.2] [RN:R01082] K01676 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 3,0 C00149 (S)-Malate C00122 Fumarate
+fumarate hydratase [EC:4.2.1.2] [RN:R01082] K01679 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 3,1 C00149 (S)-Malate C00122 Fumarate
+fumarate hydratase [EC:4.2.1.2] [RN:R01082] K01677 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 3,2 C00149 (S)-Malate C00122 Fumarate
+fumarate hydratase [EC:4.2.1.2] [RN:R01082] K01678 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 3,2 C00149 (S)-Malate C00122 Fumarate
+malate dehydrogenase [EC:1.1.1.37] [RN:R00342] K00026 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 4,0 C00036 Oxaloacetate C00149 (S)-Malate
+malate dehydrogenase [EC:1.1.1.37] [RN:R00342] K00025 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 4,1 C00036 Oxaloacetate C00149 (S)-Malate
+malate dehydrogenase [EC:1.1.1.37] [RN:R00342] K00024 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 4,2 C00036 Oxaloacetate C00149 (S)-Malate
+malate dehydrogenase (quinone) [EC:1.1.5.4] [RN:R00361] K00116 M00011 Citrate cycle, second carbon oxidation, 2-oxoglutarate => oxaloacetate 4,3 C00036 Oxaloacetate C00149 (S)-Malate
+citrate synthase [EC:2.3.3.1] [RN:R00351] K01647 M00012 Glyoxylate cycle 0,0 C00158 Citrate C00024,C00036 Acetyl-CoA,Oxaloacetate
+aconitate hydratase [EC:4.2.1.3] [RN:R01325 R01900] K01681 M00012 Glyoxylate cycle 1,0 C00311 Isocitrate C00417 cis-Aconitate
+aconitate hydratase [EC:4.2.1.3] [RN:R01325 R01900] K01682 M00012 Glyoxylate cycle 1,1 C00311 Isocitrate C00417 cis-Aconitate
+isocitrate lyase [EC:4.1.3.1] [RN:R00479] K01637 M00012 Glyoxylate cycle 2,0 C00048 Glyoxylate C00311 Isocitrate
+malate synthase [EC:2.3.3.9] [RN:R00472] K01638 M00012 Glyoxylate cycle 3,0 C00149 (S)-Malate C00024,C00048 Acetyl-CoA,Glyoxylate
+bifunctional (S)-malyl-CoA lyase/thioesterase [EC:4.1.3.24 3.1.2.30] [RN:R00473 R10612] K19282 M00012 Glyoxylate cycle 3,1 C00149 (S)-Malate C00024,C00048 Acetyl-CoA,Glyoxylate
+malate dehydrogenase [EC:1.1.1.37] [RN:R00342] K00026 M00012 Glyoxylate cycle 4,0 C00036 Oxaloacetate C00149 (S)-Malate
+malate dehydrogenase [EC:1.1.1.37] [RN:R00342] K00025 M00012 Glyoxylate cycle 4,1 C00036 Oxaloacetate C00149 (S)-Malate
+malate dehydrogenase [EC:1.1.1.37] [RN:R00342] K00024 M00012 Glyoxylate cycle 4,2 C00036 Oxaloacetate C00149 (S)-Malate
+ACADS; butyryl-CoA dehydrogenase [EC:1.3.8.1] [RN:R04432] K00248 M00013 Malonate semialdehyde pathway, propanoyl-CoA => acetyl-CoA 0,0 C00894 Propenoyl-CoA C00100 Propanoyl-CoA
+E1.3.3.6; acyl-CoA oxidase [EC:1.3.3.6] [RN:R12356] K00232 M00013 Malonate semialdehyde pathway, propanoyl-CoA => acetyl-CoA 0,1 C00894 Propenoyl-CoA C00100 Propanoyl-CoA
+enoyl-CoA hydratase [EC:4.2.1.17] [RN:R03045] K07511 M00013 Malonate semialdehyde pathway, propanoyl-CoA => acetyl-CoA 1,0 C05668 3-Hydroxypropionyl-CoA C00894 Propenoyl-CoA
+enoyl-CoA hydratase [EC:4.2.1.17] [RN:R03045] K07514 M00013 Malonate semialdehyde pathway, propanoyl-CoA => acetyl-CoA 1,1 C05668 3-Hydroxypropionyl-CoA C00894 Propenoyl-CoA
+enoyl-CoA hydratase [EC:4.2.1.17] [RN:R03045] K07515 M00013 Malonate semialdehyde pathway, propanoyl-CoA => acetyl-CoA 1,2 C05668 3-Hydroxypropionyl-CoA C00894 Propenoyl-CoA
+multifunctional beta-oxidation protein [EC:4.2.1.-] [RN:R03045] K14729 M00013 Malonate semialdehyde pathway, propanoyl-CoA => acetyl-CoA 1,3 C05668 3-Hydroxypropionyl-CoA C00894 Propenoyl-CoA
+3-hydroxyisobutyryl-CoA hydrolase [EC:3.1.2.4] [RN:R03157 R03158] K05605 M00013 Malonate semialdehyde pathway, propanoyl-CoA => acetyl-CoA 2,0 C01013 3-Hydroxypropanoate C05668 3-Hydroxypropionyl-CoA
+3-hydroxypropionate dehydrogenase [EC:1.1.1.59] [RN:R01608] K23146 M00013 Malonate semialdehyde pathway, propanoyl-CoA => acetyl-CoA 3,0 C00222 3-Oxopropanoate C01013 3-Hydroxypropanoate
+malonate-semialdehyde dehydrogenase (acetylating) [EC:1.2.1.18] [RN:R00740] K00140 M00013 Malonate semialdehyde pathway, propanoyl-CoA => acetyl-CoA 4,0
+UDPglucose 6-dehydrogenase [EC:1.1.1.22] [RN:R00286] K00012 M00014 Glucuronate pathway (uronate pathway) 0,0 C00167 UDP-glucuronate C00029 UDP-glucose
+UDP-sugar pyrophosphorylase [EC:2.7.7.64] [RN:R01381] K12447 M00014 Glucuronate pathway (uronate pathway) 1,0,0,0 C05385 D-Glucuronate 1-phosphate C00167 UDP-glucuronate
+glucuronokinase [EC:2.7.1.43] [RN:R01476] K16190 M00014 Glucuronate pathway (uronate pathway) 1,0,1,0 C00191 D-Glucuronate C05385 D-Glucuronate 1-phosphate
+glucuronosyltransferase [EC:2.4.1.17] [RN:R01383] K00699 M00014 Glucuronate pathway (uronate pathway) 1,1,0,0 C03033 beta-D-Glucuronoside C00167 UDP-glucuronate
+beta-glucuronidase [EC:3.2.1.31] [RN:R01478] K01195 M00014 Glucuronate pathway (uronate pathway) 1,1,1,0 C00191 D-Glucuronate C03033 beta-D-Glucuronoside
+beta-glucuronidase [EC:3.2.1.31] [RN:R01478] K14756 M00014 Glucuronate pathway (uronate pathway) 1,1,1,1 C00191 D-Glucuronate C03033 beta-D-Glucuronoside
+alcohol dehydrogenase (NADP+) [EC:1.1.1.2] [RN:R01481] K00002 M00014 Glucuronate pathway (uronate pathway) 2,0 C00800 L-Gulonate C00191 D-Glucuronate
+L-gulonate 3-dehydrogenase [EC:1.1.1.45] [RN:R02640] K13247 M00014 Glucuronate pathway (uronate pathway) 3,0 C00618 3-Dehydro-L-gulonate C00800 L-Gulonate
+L-xylulose reductase [EC:1.1.1.10] [RN:R01904] K03331 M00014 Glucuronate pathway (uronate pathway) 5,0 C00379 Xylitol C00312 L-Xylulose
+D-xylulose reductase [EC:1.1.1.9] [RN:R01896] K05351 M00014 Glucuronate pathway (uronate pathway) 6,0 C00310 D-Xylulose C00379 Xylitol
+L-iditol 2-dehydrogenase [EC:1.1.1.14] [RN:R01896] K00008 M00014 Glucuronate pathway (uronate pathway) 6,1 C00310 D-Xylulose C00379 Xylitol
+xylulokinase [EC:2.7.1.17] [RN:R01639] K00854 M00014 Glucuronate pathway (uronate pathway) 7,0 C00231 D-Xylulose 5-phosphate C00310 D-Xylulose
+glutamate 5-kinase [EC:2.7.2.11] [RN:R00239] K00931 M00015 Proline biosynthesis, glutamate => proline 0,0,0,0 C03287 L-Glutamyl 5-phosphate C00025 L-Glutamate
+glutamate-5-semialdehyde dehydrogenase [EC:1.2.1.41] [RN:R03313] K00147 M00015 Proline biosynthesis, glutamate => proline 0,0,1,0 C01165 L-Glutamate 5-semialdehyde C03287 L-Glutamyl 5-phosphate
+delta-1-pyrroline-5-carboxylate synthetase [EC:2.7.2.11 1.2.1.41] [RN:R00239 R03313] K12657 M00015 Proline biosynthesis, glutamate => proline 0,1 C01165 L-Glutamate 5-semialdehyde C03287 L-Glutamyl 5-phosphate
+pyrroline-5-carboxylate reductase [EC:1.5.1.2] [RN:R01251] K00286 M00015 Proline biosynthesis, glutamate => proline 1,0 C00148 L-Proline C03912 (S)-1-Pyrroline-5-carboxylate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K00928 M00016 Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine 0,0 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12524 M00016 Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine 0,1 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12525 M00016 Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine 0,2 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12526 M00016 Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine 0,3 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate-semialdehyde dehydrogenase [EC:1.2.1.11] [RN:R02291] K00133 M00016 Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine 1,0 C00441 L-Aspartate 4-semialdehyde C03082 4-Phospho-L-aspartate
+4-hydroxy-tetrahydrodipicolinate synthase [EC:4.3.3.7] [RN:R10147] K01714 M00016 Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine 2,0 C20258 (2S,4S)-4-Hydroxy-2,3,4,5-tetrahydrodipicolinate C00441 L-Aspartate 4-semialdehyde
+4-hydroxy-tetrahydrodipicolinate reductase [EC:1.17.1.8] [RN:R04198 R04199] K00215 M00016 Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine 3,0 C03972 2,3,4,5-Tetrahydrodipicolinate C20258 (2S,4S)-4-Hydroxy-2,3,4,5-tetrahydrodipicolinate
+2,3,4,5-tetrahydropyridine-2-carboxylate N-succinyltransferase [EC:2.3.1.117] [RN:R04365] K00674 M00016 Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine 4,0 C04462 N-Succinyl-2-L-amino-6-oxoheptanedioate C03972 2,3,4,5-Tetrahydrodipicolinate
+N-succinyldiaminopimelate aminotransferase [EC:2.6.1.17] [RN:R04475] K00821 M00016 Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine 5,0 C04421 N-Succinyl-LL-2,6-diaminoheptanedioate C04462 N-Succinyl-2-L-amino-6-oxoheptanedioate
+N-succinyldiaminopimelate aminotransferase [EC:2.6.1.17] [RN:R04475] K14267 M00016 Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine 5,1 C04421 N-Succinyl-LL-2,6-diaminoheptanedioate C04462 N-Succinyl-2-L-amino-6-oxoheptanedioate
+succinyl-diaminopimelate desuccinylase [EC:3.5.1.18] [RN:R02734] K01439 M00016 Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine 6,0 C00666 LL-2,6-Diaminoheptanedioate C04421 N-Succinyl-LL-2,6-diaminoheptanedioate
+diaminopimelate epimerase [EC:5.1.1.7] [RN:R02735] K01778 M00016 Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine 7,0 C00680 meso-2,6-Diaminoheptanedioate C00666 LL-2,6-Diaminoheptanedioate
+diaminopimelate decarboxylase [EC:4.1.1.20] [RN:R00451] K01586 M00016 Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine 8,0 C00047 L-Lysine C00680 meso-2,6-Diaminoheptanedioate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12526 M00016 Lysine biosynthesis, succinyl-DAP pathway, aspartate => lysine 8,1 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K00928 M00017 Methionine biosynthesis, apartate => homoserine => methionine 0,0 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12524 M00017 Methionine biosynthesis, apartate => homoserine => methionine 0,1 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12525 M00017 Methionine biosynthesis, apartate => homoserine => methionine 0,2 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12526 M00017 Methionine biosynthesis, apartate => homoserine => methionine 0,3 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate-semialdehyde dehydrogenase [EC:1.2.1.11] [RN:R02291] K00133 M00017 Methionine biosynthesis, apartate => homoserine => methionine 1,0 C00441 L-Aspartate 4-semialdehyde C03082 4-Phospho-L-aspartate
+homoserine dehydrogenase [EC:1.1.1.3] [RN:R01773 R01775] K00003 M00017 Methionine biosynthesis, apartate => homoserine => methionine 2,0 C00263 L-Homoserine C00441 L-Aspartate 4-semialdehyde
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12524 M00017 Methionine biosynthesis, apartate => homoserine => methionine 2,1 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12525 M00017 Methionine biosynthesis, apartate => homoserine => methionine 2,2 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+homoserine O-succinyltransferase [EC:2.3.1.46] [RN:R01777] K00651 M00017 Methionine biosynthesis, apartate => homoserine => methionine 3,0 C01118 O-Succinyl-L-homoserine C00263 L-Homoserine
+cystathionine gamma-synthase [EC:2.5.1.48] [RN:R03260] K01739 M00017 Methionine biosynthesis, apartate => homoserine => methionine 4,0 C02291 L-Cystathionine C01118 O-Succinyl-L-homoserine
+cystathionine beta-lyase [EC:4.4.1.8] [RN:R01286] K01760 M00017 Methionine biosynthesis, apartate => homoserine => methionine 5,0 C00155 L-Homocysteine C02291 L-Cystathionine
+methionine synthase [EC:2.1.1.13 2.1.1.14] [RN:R00946 R04405] K00548 M00017 Methionine biosynthesis, apartate => homoserine => methionine 6,0 C00073 L-Methionine C00155 L-Homocysteine
+methionine synthase [EC:2.1.1.13 2.1.1.14] [RN:R00946 R04405] K00549 M00017 Methionine biosynthesis, apartate => homoserine => methionine 6,1 C00073 L-Methionine C00155 L-Homocysteine
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K00928 M00018 Threonine biosynthesis, aspartate => homoserine => threonine 0,0 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12524 M00018 Threonine biosynthesis, aspartate => homoserine => threonine 0,1 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12525 M00018 Threonine biosynthesis, aspartate => homoserine => threonine 0,2 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12526 M00018 Threonine biosynthesis, aspartate => homoserine => threonine 0,3 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate-semialdehyde dehydrogenase [EC:1.2.1.11] [RN:R02291] K00133 M00018 Threonine biosynthesis, aspartate => homoserine => threonine 1,0 C00441 L-Aspartate 4-semialdehyde C03082 4-Phospho-L-aspartate
+homoserine dehydrogenase [EC:1.1.1.3] [RN:R01773 R01775] K00003 M00018 Threonine biosynthesis, aspartate => homoserine => threonine 2,0 C00263 L-Homoserine C00441 L-Aspartate 4-semialdehyde
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12524 M00018 Threonine biosynthesis, aspartate => homoserine => threonine 2,1 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12525 M00018 Threonine biosynthesis, aspartate => homoserine => threonine 2,2 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+homoserine kinase [EC:2.7.1.39] [RN:R01771] K00872 M00018 Threonine biosynthesis, aspartate => homoserine => threonine 3,0 C01102 O-Phospho-L-homoserine C00263 L-Homoserine
+homoserine kinase [EC:2.7.1.39] [RN:R01771] K02204 M00018 Threonine biosynthesis, aspartate => homoserine => threonine 3,1 C01102 O-Phospho-L-homoserine C00263 L-Homoserine
+homoserine kinase [EC:2.7.1.39] [RN:R01771] K02203 M00018 Threonine biosynthesis, aspartate => homoserine => threonine 3,2 C01102 O-Phospho-L-homoserine C00263 L-Homoserine
+threonine synthase [EC:4.2.3.1] [RN:R01466] K01733 M00018 Threonine biosynthesis, aspartate => homoserine => threonine 4,0 C00188 L-Threonine C01102 O-Phospho-L-homoserine
+acetolactate synthase [EC:2.2.1.6] [RN:R00226 R08648] K01652 M00019 Valine/isoleucine biosynthesis, pyruvate => valine / 2-oxobutanoate => isoleucine 0,0 C06006 (S)-2-Aceto-2-hydroxybutanoate C00109 2-Oxobutanoate
+acetolactate synthase [EC:2.2.1.6] [RN:R00226 R08648] K01653 M00019 Valine/isoleucine biosynthesis, pyruvate => valine / 2-oxobutanoate => isoleucine 0,0 C06006 (S)-2-Aceto-2-hydroxybutanoate C00109 2-Oxobutanoate
+acetolactate synthase [EC:2.2.1.6] [RN:R00226 R08648] K11258 M00019 Valine/isoleucine biosynthesis, pyruvate => valine / 2-oxobutanoate => isoleucine 0,0 C06006 (S)-2-Aceto-2-hydroxybutanoate C00109 2-Oxobutanoate
+ketol-acid reductoisomerase [EC:1.1.1.86] [RN:R05071 R04440 R04439 R05069 R05068] K00053 M00019 Valine/isoleucine biosynthesis, pyruvate => valine / 2-oxobutanoate => isoleucine 1,0 C06007 (R)-2,3-Dihydroxy-3-methylpentanoate C14463 (R)-3-Hydroxy-3-methyl-2-oxopentanoate
+dihydroxy-acid dehydratase [EC:4.2.1.9] [RN:R04441 R05070] K01687 M00019 Valine/isoleucine biosynthesis, pyruvate => valine / 2-oxobutanoate => isoleucine 2,0 C00671 (S)-3-Methyl-2-oxopentanoic acid C06007 (R)-2,3-Dihydroxy-3-methylpentanoate
+branched-chain amino acid aminotransferase [EC:2.6.1.42] [RN:R01214 R02199] K00826 M00019 Valine/isoleucine biosynthesis, pyruvate => valine / 2-oxobutanoate => isoleucine 3,0 C00407 L-Isoleucine C00671 (S)-3-Methyl-2-oxopentanoic acid
+D-3-phosphoglycerate dehydrogenase [EC:1.1.1.95] [RN:R01513] K00058 M00020 Serine biosynthesis, glycerate-3P => serine 0,0 C03232 3-Phosphonooxypyruvate C00197 3-Phospho-D-glycerate
+phosphoserine aminotransferase [EC:2.6.1.52] [RN:R04173] K00831 M00020 Serine biosynthesis, glycerate-3P => serine 1,0 C01005 O-Phospho-L-serine C03232 3-Phosphonooxypyruvate
+phosphoserine phosphatase [EC:3.1.3.3] [RN:R00582] K01079 M00020 Serine biosynthesis, glycerate-3P => serine 2,0 C00065 L-Serine C01005 O-Phospho-L-serine
+serine O-acetyltransferase [EC:2.3.1.30] [RN:R00586] K00640 M00021 Cysteine biosynthesis, serine => cysteine 0,0 C00979 O-Acetyl-L-serine C00065 L-Serine
+serine O-acetyltransferase [EC:2.3.1.30] [RN:R00586] K23304 M00021 Cysteine biosynthesis, serine => cysteine 0,1 C00979 O-Acetyl-L-serine C00065 L-Serine
+cysteine synthase [EC:2.5.1.47] [RN:R00897] K01738 M00021 Cysteine biosynthesis, serine => cysteine 1,0 C00097 L-Cysteine C00979,C00283 O-Acetyl-L-serine,Hydrogen sulfide
+cysteine synthase [EC:2.5.1.47] [RN:R00897] K13034 M00021 Cysteine biosynthesis, serine => cysteine 1,1 C00097 L-Cysteine C00979,C00283 O-Acetyl-L-serine,Hydrogen sulfide
+cysteine synthase [EC:2.5.1.47] [RN:R00897] K17069 M00021 Cysteine biosynthesis, serine => cysteine 1,2 C00097 L-Cysteine C00979,C00283 O-Acetyl-L-serine,Hydrogen sulfide
+3-deoxy-7-phosphoheptulonate synthase [EC:2.5.1.54] [RN:R01826] K01626 M00022 Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate 0,0 C04691 2-Dehydro-3-deoxy-D-arabino-heptonate 7-phosphate C00074,C00279 Phosphoenolpyruvate,D-Erythrose 4-phosphate
+3-deoxy-7-phosphoheptulonate synthase [EC:2.5.1.54] [RN:R01826] K03856 M00022 Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate 0,1 C04691 2-Dehydro-3-deoxy-D-arabino-heptonate 7-phosphate C00074,C00279 Phosphoenolpyruvate,D-Erythrose 4-phosphate
+3-deoxy-7-phosphoheptulonate synthase [EC:2.5.1.54] [RN:R01826] K13853 M00022 Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate 0,2 C04691 2-Dehydro-3-deoxy-D-arabino-heptonate 7-phosphate C00074,C00279 Phosphoenolpyruvate,D-Erythrose 4-phosphate
+3-dehydroquinate synthase [EC:4.2.3.4] [RN:R03083] K01735 M00022 Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate 1,0,0,0 C00944 3-Dehydroquinate C04691 2-Dehydro-3-deoxy-D-arabino-heptonate 7-phosphate
+3-dehydroquinate synthase [EC:4.2.3.4] [RN:R03083] K13829 M00022 Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate 1,0,0,1 C00944 3-Dehydroquinate C04691 2-Dehydro-3-deoxy-D-arabino-heptonate 7-phosphate
+3-dehydroquinate dehydratase [EC:4.2.1.10] [RN:R03084] K03785 M00022 Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate 1,0,1,0,0,0 C02637 3-Dehydroshikimate C00944 3-Dehydroquinate
+3-dehydroquinate dehydratase [EC:4.2.1.10] [RN:R03084] K03786 M00022 Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate 1,0,1,0,0,1 C02637 3-Dehydroshikimate C00944 3-Dehydroquinate
+shikimate 5-dehydrogenase [EC:1.1.1.25] [RN:R02413] K00014 M00022 Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate 1,0,1,0,1,0 C00493 Shikimate C02637 3-Dehydroshikimate
+3-dehydroquinate dehydratase [EC:4.2.1.10] [RN:R03084] K13832 M00022 Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate 1,0,1,1 C02637 3-Dehydroshikimate C00944 3-Dehydroquinate
+3-dehydroquinate synthase [EC:4.2.3.4] [RN:R03083] K13830 M00022 Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate 1,1 C00944 3-Dehydroquinate C04691 2-Dehydro-3-deoxy-D-arabino-heptonate 7-phosphate
+shikimate kinase [EC:2.7.1.71] [RN:R02412] K00891 M00022 Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate 2,0,0,0 C03175 Shikimate 3-phosphate C00493 Shikimate
+3-dehydroquinate synthase [EC:4.2.3.4] [RN:R03083] K13829 M00022 Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate 2,0,0,1 C00944 3-Dehydroquinate C04691 2-Dehydro-3-deoxy-D-arabino-heptonate 7-phosphate
+3-phosphoshikimate 1-carboxyvinyltransferase [EC:2.5.1.19] [RN:R03460] K00800 M00022 Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate 2,0,1,0 C01269 5-O-(1-Carboxyvinyl)-3-phosphoshikimate C03175 Shikimate 3-phosphate
+3-dehydroquinate synthase [EC:4.2.3.4] [RN:R03083] K13830 M00022 Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate 2,1 C00944 3-Dehydroquinate C04691 2-Dehydro-3-deoxy-D-arabino-heptonate 7-phosphate
+chorismate synthase [EC:4.2.3.5] [RN:R01714] K01736 M00022 Shikimate pathway, phosphoenolpyruvate + erythrose-4P => chorismate 3,0 C00251 Chorismate C01269 5-O-(1-Carboxyvinyl)-3-phosphoshikimate
+anthranilate synthase [EC:4.1.3.27] [RN:R00985 R00986] K01657 M00023 Tryptophan biosynthesis, chorismate => tryptophan 0,0,0,0 C00108 Anthranilate C00251 Chorismate
+anthranilate synthase [EC:4.1.3.27] [RN:R00985 R00986] K01658 M00023 Tryptophan biosynthesis, chorismate => tryptophan 0,0,0,0 C00108 Anthranilate C00251 Chorismate
+anthranilate synthase [EC:4.1.3.27] [RN:R00985 R00986] K13503 M00023 Tryptophan biosynthesis, chorismate => tryptophan 0,0,0,1 C00108 Anthranilate C00251 Chorismate
+anthranilate synthase [EC:4.1.3.27] [RN:R00985 R00986] K13501 M00023 Tryptophan biosynthesis, chorismate => tryptophan 0,0,0,2 C00108 Anthranilate C00251 Chorismate
+anthranilate synthase [EC:4.1.3.27] [RN:R00985 R00986] K01656 M00023 Tryptophan biosynthesis, chorismate => tryptophan 0,0,0,3 C00108 Anthranilate C00251 Chorismate
+anthranilate phosphoribosyltransferase [EC:2.4.2.18] [RN:R01073] K00766 M00023 Tryptophan biosynthesis, chorismate => tryptophan 0,0,1,0 C04302 N-(5-Phospho-D-ribosyl)anthranilate C00108 Anthranilate
+anthranilate synthase [EC:4.1.3.27] [RN:R00985 R00986] K13497 M00023 Tryptophan biosynthesis, chorismate => tryptophan 0,1 C00108 Anthranilate C00251 Chorismate
+phosphoribosylanthranilate isomerase [EC:5.3.1.24] [RN:R03509] K01817 M00023 Tryptophan biosynthesis, chorismate => tryptophan 1,0,0,0 C01302 1-(2-Carboxyphenylamino)-1'-deoxy-D-ribulose 5'-phosphate C04302 N-(5-Phospho-D-ribosyl)anthranilate
+anthranilate synthase [EC:4.1.3.27] [RN:R00985 R00986] K01656 M00023 Tryptophan biosynthesis, chorismate => tryptophan 1,0,1,0 C00108 Anthranilate C00251 Chorismate
+indole-3-glycerol phosphate synthase [EC:4.1.1.48] [RN:R03508] K01609 M00023 Tryptophan biosynthesis, chorismate => tryptophan 1,0,1,1 C03506 Indoleglycerol phosphate C01302 1-(2-Carboxyphenylamino)-1'-deoxy-D-ribulose 5'-phosphate
+phosphoribosylanthranilate isomerase [EC:5.3.1.24] [RN:R03509] K13498 M00023 Tryptophan biosynthesis, chorismate => tryptophan 1,1 C01302 1-(2-Carboxyphenylamino)-1'-deoxy-D-ribulose 5'-phosphate C04302 N-(5-Phospho-D-ribosyl)anthranilate
+anthranilate synthase [EC:4.1.3.27] [RN:R00985 R00986] K13501 M00023 Tryptophan biosynthesis, chorismate => tryptophan 1,2 C00108 Anthranilate C00251 Chorismate
+tryptophan synthase [EC:4.2.1.20] [RN:R02722] K01695 M00023 Tryptophan biosynthesis, chorismate => tryptophan 2,0 C00078 L-Tryptophan C03506 Indoleglycerol phosphate
+tryptophan synthase [EC:4.2.1.20] [RN:R02722] K01696 M00023 Tryptophan biosynthesis, chorismate => tryptophan 2,0 C00078 L-Tryptophan C03506 Indoleglycerol phosphate
+tryptophan synthase [EC:4.2.1.20] [RN:R02722] K06001 M00023 Tryptophan biosynthesis, chorismate => tryptophan 2,0 C00078 L-Tryptophan C03506 Indoleglycerol phosphate
+tryptophan synthase [EC:4.2.1.20] [RN:R02722] K01694 M00023 Tryptophan biosynthesis, chorismate => tryptophan 2,1 C00078 L-Tryptophan C03506 Indoleglycerol phosphate
+chorismate mutase [EC:5.4.99.5] [RN:R01715] K01850 M00024 Phenylalanine biosynthesis, chorismate => phenylalanine 0,0,0,0 C00254 Prephenate C00251 Chorismate
+chorismate mutase [EC:5.4.99.5] [RN:R01715] K04092 M00024 Phenylalanine biosynthesis, chorismate => phenylalanine 0,0,0,1 C00254 Prephenate C00251 Chorismate
+chorismate mutase [EC:5.4.99.5] [RN:R01715] K14187 M00024 Phenylalanine biosynthesis, chorismate => phenylalanine 0,0,0,2 C00254 Prephenate C00251 Chorismate
+chorismate mutase [EC:5.4.99.5] [RN:R01715] K04093 M00024 Phenylalanine biosynthesis, chorismate => phenylalanine 0,0,0,3 C00254 Prephenate C00251 Chorismate
+chorismate mutase [EC:5.4.99.5] [RN:R01715] K04516 M00024 Phenylalanine biosynthesis, chorismate => phenylalanine 0,0,0,4 C00254 Prephenate C00251 Chorismate
+chorismate mutase [EC:5.4.99.5] [RN:R01715] K06208 M00024 Phenylalanine biosynthesis, chorismate => phenylalanine 0,0,0,5 C00254 Prephenate C00251 Chorismate
+chorismate mutase [EC:5.4.99.5] [RN:R01715] K06209 M00024 Phenylalanine biosynthesis, chorismate => phenylalanine 0,0,0,6 C00254 Prephenate C00251 Chorismate
+chorismate mutase [EC:5.4.99.5] [RN:R01715] K13853 M00024 Phenylalanine biosynthesis, chorismate => phenylalanine 0,0,0,7 C00254 Prephenate C00251 Chorismate
+prephenate dehydratase [EC:4.2.1.51] [RN:R01373] K01713 M00024 Phenylalanine biosynthesis, chorismate => phenylalanine 0,0,1,0 C00166 Phenylpyruvate C00254 Prephenate
+prephenate dehydratase [EC:4.2.1.51] [RN:R01373] K04518 M00024 Phenylalanine biosynthesis, chorismate => phenylalanine 0,0,1,1 C00166 Phenylpyruvate C00254 Prephenate
+prephenate dehydratase [EC:4.2.1.51] [RN:R01373] K05359 M00024 Phenylalanine biosynthesis, chorismate => phenylalanine 0,0,1,2 C00166 Phenylpyruvate C00254 Prephenate
+chorismate mutase [EC:5.4.99.5] [RN:R01715] K14170 M00024 Phenylalanine biosynthesis, chorismate => phenylalanine 0,1 C00254 Prephenate C00251 Chorismate
+aromatic-amino-acid transaminase [EC:2.6.1.57] [RN:R00694] K00832 M00024 Phenylalanine biosynthesis, chorismate => phenylalanine 1,0 C00079 L-Phenylalanine C00166 Phenylpyruvate
+aromatic-amino-acid transaminase [EC:2.6.1.57] [RN:R00694] K00838 M00024 Phenylalanine biosynthesis, chorismate => phenylalanine 1,1 C00079 L-Phenylalanine C00166 Phenylpyruvate
+chorismate mutase [EC:5.4.99.5] [RN:R01715] K01850 M00025 Tyrosine biosynthesis, chorismate => tyrosine 0,0,0,0 C00254 Prephenate C00251 Chorismate
+chorismate mutase [EC:5.4.99.5] [RN:R01715] K04092 M00025 Tyrosine biosynthesis, chorismate => tyrosine 0,0,0,1 C00254 Prephenate C00251 Chorismate
+chorismate mutase [EC:5.4.99.5] [RN:R01715] K14170 M00025 Tyrosine biosynthesis, chorismate => tyrosine 0,0,0,2 C00254 Prephenate C00251 Chorismate
+chorismate mutase [EC:5.4.99.5] [RN:R01715] K04093 M00025 Tyrosine biosynthesis, chorismate => tyrosine 0,0,0,3 C00254 Prephenate C00251 Chorismate
+chorismate mutase [EC:5.4.99.5] [RN:R01715] K04516 M00025 Tyrosine biosynthesis, chorismate => tyrosine 0,0,0,4 C00254 Prephenate C00251 Chorismate
+chorismate mutase [EC:5.4.99.5] [RN:R01715] K06208 M00025 Tyrosine biosynthesis, chorismate => tyrosine 0,0,0,5 C00254 Prephenate C00251 Chorismate
+chorismate mutase [EC:5.4.99.5] [RN:R01715] K06209 M00025 Tyrosine biosynthesis, chorismate => tyrosine 0,0,0,6 C00254 Prephenate C00251 Chorismate
+chorismate mutase [EC:5.4.99.5] [RN:R01715] K13853 M00025 Tyrosine biosynthesis, chorismate => tyrosine 0,0,0,7 C00254 Prephenate C00251 Chorismate
+prephenate dehydrogenase [EC:1.3.1.12] [RN:R01728] K00210 M00025 Tyrosine biosynthesis, chorismate => tyrosine 0,0,1,0 C01179 3-(4-Hydroxyphenyl)pyruvate C00254 Prephenate
+prephenate dehydrogenase [EC:1.3.1.12] [RN:R01728] K04517 M00025 Tyrosine biosynthesis, chorismate => tyrosine 0,0,1,1 C01179 3-(4-Hydroxyphenyl)pyruvate C00254 Prephenate
+chorismate mutase [EC:5.4.99.5] [RN:R01715] K14187 M00025 Tyrosine biosynthesis, chorismate => tyrosine 0,1 C00254 Prephenate C00251 Chorismate
+tyrosine aminotransferase [EC:2.6.1.5] [RN:R00734] K00815 M00025 Tyrosine biosynthesis, chorismate => tyrosine 1,0 C00082 L-Tyrosine C01179 3-(4-Hydroxyphenyl)pyruvate
+aromatic-amino-acid transaminase [EC:2.6.1.57] [RN:R00734] K00832 M00025 Tyrosine biosynthesis, chorismate => tyrosine 1,1 C00082 L-Tyrosine C01179 3-(4-Hydroxyphenyl)pyruvate
+aromatic-amino-acid transaminase [EC:2.6.1.57] [RN:R00734] K00838 M00025 Tyrosine biosynthesis, chorismate => tyrosine 1,2 C00082 L-Tyrosine C01179 3-(4-Hydroxyphenyl)pyruvate
+ATP phosphoribosyltransferase [EC:2.4.2.17] [RN:R01071] K00765 M00026 Histidine biosynthesis, PRPP => histidine 0,0 C02739 1-(5-Phospho-D-ribosyl)-ATP C00119 5-Phospho-alpha-D-ribose 1-diphosphate
+ATP phosphoribosyltransferase [EC:2.4.2.17] [RN:R01071] K02502 M00026 Histidine biosynthesis, PRPP => histidine 0,0 C02739 1-(5-Phospho-D-ribosyl)-ATP C00119 5-Phospho-alpha-D-ribose 1-diphosphate
+phosphoribosyl-ATP pyrophosphohydrolase [EC:3.6.1.31] [RN:R04035] K01523 M00026 Histidine biosynthesis, PRPP => histidine 1,0,0,0 C02741 Phosphoribosyl-AMP C02739 1-(5-Phospho-D-ribosyl)-ATP
+phosphoribosyl-AMP cyclohydrolase [EC:3.5.4.19] [RN:R04037] K01496 M00026 Histidine biosynthesis, PRPP => histidine 1,0,1,0 C04896 5-(5-Phospho-D-ribosylaminoformimino)-1-(5-phosphoribosyl)-imidazole-4-carboxamide C02741 Phosphoribosyl-AMP
+phosphoribosyl-ATP pyrophosphohydrolase [EC:3.6.1.31] [RN:R04035] K11755 M00026 Histidine biosynthesis, PRPP => histidine 1,1 C02741 Phosphoribosyl-AMP C02739 1-(5-Phospho-D-ribosyl)-ATP
+phosphoribosyl-ATP pyrophosphohydrolase [EC:3.6.1.31] [RN:R04035] K14152 M00026 Histidine biosynthesis, PRPP => histidine 1,2 C02741 Phosphoribosyl-AMP C02739 1-(5-Phospho-D-ribosyl)-ATP
+phosphoribosylformimino-5-aminoimidazole carboxamide ribotide isomerase [EC:5.3.1.16] [RN:R04640] K01814 M00026 Histidine biosynthesis, PRPP => histidine 2,0 C04916 N-(5'-Phospho-D-1'-ribulosylformimino)-5-amino-1-(5''-phospho-D-ribosyl)-4-imidazolecarboxamide C04896 5-(5-Phospho-D-ribosylaminoformimino)-1-(5-phosphoribosyl)-imidazole-4-carboxamide
+imidazole glycerol-phosphate synthase [EC:4.3.2.10] [RN:R04558] K02501 M00026 Histidine biosynthesis, PRPP => histidine 3,0 C04666 D-erythro-1-(Imidazol-4-yl)glycerol 3-phosphate C04916 N-(5'-Phospho-D-1'-ribulosylformimino)-5-amino-1-(5''-phospho-D-ribosyl)-4-imidazolecarboxamide
+imidazole glycerol-phosphate synthase [EC:4.3.2.10] [RN:R04558] K02500 M00026 Histidine biosynthesis, PRPP => histidine 3,0 C04666 D-erythro-1-(Imidazol-4-yl)glycerol 3-phosphate C04916 N-(5'-Phospho-D-1'-ribulosylformimino)-5-amino-1-(5''-phospho-D-ribosyl)-4-imidazolecarboxamide
+imidazole glycerol-phosphate synthase [EC:4.3.2.10] [RN:R04558] K01663 M00026 Histidine biosynthesis, PRPP => histidine 3,1 C04666 D-erythro-1-(Imidazol-4-yl)glycerol 3-phosphate C04916 N-(5'-Phospho-D-1'-ribulosylformimino)-5-amino-1-(5''-phospho-D-ribosyl)-4-imidazolecarboxamide
+imidazoleglycerol-phosphate dehydratase [EC:4.2.1.19] [RN:R03457] K01693 M00026 Histidine biosynthesis, PRPP => histidine 4,0,0,0 C01267 3-(Imidazol-4-yl)-2-oxopropyl phosphate C04666 D-erythro-1-(Imidazol-4-yl)glycerol 3-phosphate
+histidinol-phosphate aminotransferase [EC:2.6.1.9] [RN:R03243] K00817 M00026 Histidine biosynthesis, PRPP => histidine 4,0,1,0 C01100 L-Histidinol phosphate C01267 3-(Imidazol-4-yl)-2-oxopropyl phosphate
+histidinol-phosphatase [EC:3.1.3.15] [RN:R03013] K04486 M00026 Histidine biosynthesis, PRPP => histidine 4,0,2,0 C00860 L-Histidinol C01100 L-Histidinol phosphate
+histidinol-phosphatase [EC:3.1.3.15] [RN:R03013] K05602 M00026 Histidine biosynthesis, PRPP => histidine 4,0,2,1 C00860 L-Histidinol C01100 L-Histidinol phosphate
+histidinol-phosphatase [EC:3.1.3.15] [RN:R03013] K18649 M00026 Histidine biosynthesis, PRPP => histidine 4,0,2,2 C00860 L-Histidinol C01100 L-Histidinol phosphate
+imidazoleglycerol-phosphate dehydratase / histidinol-phosphatase [EC:4.2.1.19 3.1.3.15] [RN:R03457 R03013] K01089 M00026 Histidine biosynthesis, PRPP => histidine 4,1,0,0 C00860 L-Histidinol C01100 L-Histidinol phosphate
+histidinol-phosphate aminotransferase [EC:2.6.1.9] [RN:R03243] K00817 M00026 Histidine biosynthesis, PRPP => histidine 4,1,1,0 C01100 L-Histidinol phosphate C01267 3-(Imidazol-4-yl)-2-oxopropyl phosphate
+histidinol dehydrogenase [EC:1.1.1.23] [RN:R03012 R01163] K00013 M00026 Histidine biosynthesis, PRPP => histidine 5,0 C00135 L-Histidine C01929 L-Histidinal
+phosphoribosyl-ATP pyrophosphohydrolase [EC:3.6.1.31] [RN:R04035] K14152 M00026 Histidine biosynthesis, PRPP => histidine 5,1 C02741 Phosphoribosyl-AMP C02739 1-(5-Phospho-D-ribosyl)-ATP
+glutamate decarboxylase [EC:4.1.1.15] [RN:R00261] K01580 M00027 GABA (gamma-Aminobutyrate) shunt 0,0 C00334 4-Aminobutanoate C00025 L-Glutamate
+4-aminobutyrate aminotransferase [EC:2.6.1.19] [RN:R01648] K13524 M00027 GABA (gamma-Aminobutyrate) shunt 1,0 C00232 Succinate semialdehyde C00334 4-Aminobutanoate
+4-aminobutyrate aminotransferase [EC:2.6.1.19] [RN:R01648] K07250 M00027 GABA (gamma-Aminobutyrate) shunt 1,1 C00232 Succinate semialdehyde C00334 4-Aminobutanoate
+4-aminobutyrate aminotransferase [EC:2.6.1.19] [RN:R01648] K00823 M00027 GABA (gamma-Aminobutyrate) shunt 1,2 C00232 Succinate semialdehyde C00334 4-Aminobutanoate
+4-aminobutyrate---pyruvate transaminase [EC:2.6.1.96] [RN:R10178] K16871 M00027 GABA (gamma-Aminobutyrate) shunt 1,3 C00232 Succinate semialdehyde C00334 4-Aminobutanoate
+succinate-semialdehyde dehydrogenase [EC:1.2.1.16 1.2.1.24] [RN:R00713 R00714] K00135 M00027 GABA (gamma-Aminobutyrate) shunt 2,0 C00042 Succinate C00232 Succinate semialdehyde
+succinate-semialdehyde dehydrogenase [EC:1.2.1.16 1.2.1.24] [RN:R00713 R00714] K00139 M00027 GABA (gamma-Aminobutyrate) shunt 2,1 C00042 Succinate C00232 Succinate semialdehyde
+succinate-semialdehyde dehydrogenase [EC:1.2.1.16 1.2.1.24] [RN:R00713 R00714] K17761 M00027 GABA (gamma-Aminobutyrate) shunt 2,2 C00042 Succinate C00232 Succinate semialdehyde
+amino-acid N-acetyltransferase [EC:2.3.1.1] [RN:R00259] K00618 M00028 Ornithine biosynthesis, glutamate => ornithine 0,0 C00624 N-Acetyl-L-glutamate C00025 L-Glutamate
+amino-acid N-acetyltransferase [EC:2.3.1.1] [RN:R00259] K00619 M00028 Ornithine biosynthesis, glutamate => ornithine 0,1 C00624 N-Acetyl-L-glutamate C00025 L-Glutamate
+amino-acid N-acetyltransferase [EC:2.3.1.1] [RN:R00259] K14681 M00028 Ornithine biosynthesis, glutamate => ornithine 0,2 C00624 N-Acetyl-L-glutamate C00025 L-Glutamate
+amino-acid N-acetyltransferase [EC:2.3.1.1] [RN:R00259] K14682 M00028 Ornithine biosynthesis, glutamate => ornithine 0,3 C00624 N-Acetyl-L-glutamate C00025 L-Glutamate
+glutamate N-acetyltransferase / amino-acid N-acetyltransferase [EC:2.3.1.35 2.3.1.1] [RN:R00259 R02282] K00620 M00028 Ornithine biosynthesis, glutamate => ornithine 0,4 C00077 L-Ornithine C00437 N-Acetylornithine
+amino-acid N-acetyltransferase [EC:2.3.1.1] [RN:R00259] K22477 M00028 Ornithine biosynthesis, glutamate => ornithine 0,5 C00624 N-Acetyl-L-glutamate C00025 L-Glutamate
+bifunctional N-acetylglutamate synthase/kinase [EC:2.3.1.1 2.7.2.8] [RN:R00259 R02649] K22478 M00028 Ornithine biosynthesis, glutamate => ornithine 0,6 C04133 N-Acetyl-L-glutamate 5-phosphate C00624 N-Acetyl-L-glutamate
+acetylglutamate kinase [EC:2.7.2.8] [RN:R02649] K00930 M00028 Ornithine biosynthesis, glutamate => ornithine 1,0,0,0 C04133 N-Acetyl-L-glutamate 5-phosphate C00624 N-Acetyl-L-glutamate
+bifunctional N-acetylglutamate synthase/kinase [EC:2.3.1.1 2.7.2.8] [RN:R00259 R02649] K22478 M00028 Ornithine biosynthesis, glutamate => ornithine 1,0,0,1 C04133 N-Acetyl-L-glutamate 5-phosphate C00624 N-Acetyl-L-glutamate
+N-acetyl-gamma-glutamyl-phosphate reductase [EC:1.2.1.38] [RN:R03443] K00145 M00028 Ornithine biosynthesis, glutamate => ornithine 1,0,1,0 C01250 N-Acetyl-L-glutamate 5-semialdehyde C04133 N-Acetyl-L-glutamate 5-phosphate
+N-acetyl-gamma-glutamyl-phosphate reductase / acetylglutamate kinase [EC:1.2.1.38 2.7.2.8] [RN:R02649 R03443] K12659 M00028 Ornithine biosynthesis, glutamate => ornithine 1,1 C01250 N-Acetyl-L-glutamate 5-semialdehyde C04133 N-Acetyl-L-glutamate 5-phosphate
+acetylornithine aminotransferase [EC:2.6.1.11] [RN:R02283] K00818 M00028 Ornithine biosynthesis, glutamate => ornithine 2,0 C00437 N-Acetylornithine C01250 N-Acetyl-L-glutamate 5-semialdehyde
+acetylornithine aminotransferase [EC:2.6.1.11] [RN:R02283] K00821 M00028 Ornithine biosynthesis, glutamate => ornithine 2,1 C00437 N-Acetylornithine C01250 N-Acetyl-L-glutamate 5-semialdehyde
+acetylornithine deacetylase [EC:3.5.1.16] [RN:R00669] K01438 M00028 Ornithine biosynthesis, glutamate => ornithine 3,0 C00077 L-Ornithine C00437 N-Acetylornithine
+aminoacylase [EC:3.5.1.14] [RN:R00669] K14677 M00028 Ornithine biosynthesis, glutamate => ornithine 3,1 C00077 L-Ornithine C00437 N-Acetylornithine
+glutamate N-acetyltransferase / amino-acid N-acetyltransferase [EC:2.3.1.35 2.3.1.1] [RN:R00259 R02282] K00620 M00028 Ornithine biosynthesis, glutamate => ornithine 3,2 C00077 L-Ornithine C00437 N-Acetylornithine
+carbamoyl-phosphate synthase (ammonia) [EC:6.3.4.16] [RN:R00149] K01948 M00029 Urea cycle 0,0 C00169 Carbamoyl phosphate C00014 NH3
+ornithine carbamoyltransferase [EC:2.1.3.3] [RN:R01398] K00611 M00029 Urea cycle 1,0 C00327 L-Citrulline C00169,C00077 Carbamoyl phosphate,L-Ornithine
+argininosuccinate synthase [EC:6.3.4.5] [RN:R01954] K01940 M00029 Urea cycle 2,0 C03406 N-(L-Arginino)succinate C00327,C00049 L-Citrulline,L-Aspartate
+argininosuccinate lyase [EC:4.3.2.1] [RN:R01086] K01755 M00029 Urea cycle 3,0 C00062,C00122 L-Arginine,Fumarate C03406 N-(L-Arginino)succinate
+argininosuccinate lyase [EC:4.3.2.1] [RN:R01086] K14681 M00029 Urea cycle 3,1 C00062,C00122 L-Arginine,Fumarate C03406 N-(L-Arginino)succinate
+arginase [EC:3.5.3.1] [RN:R00551] K01476 M00029 Urea cycle 4,0 C00077,C00086 L-Ornithine,Urea C00062 L-Arginine
+homocitrate synthase [EC:2.3.3.14] [RN:R00271] K01655 M00030 Lysine biosynthesis, AAA pathway, 2-oxoglutarate => 2-aminoadipate => lysine 0,0 C01251 (R)-2-Hydroxybutane-1,2,4-tricarboxylate C00026,C00024 2-Oxoglutarate,Acetyl-CoA
+homoaconitase [EC:4.2.1.-] [RN:R03444] K17450 M00030 Lysine biosynthesis, AAA pathway, 2-oxoglutarate => 2-aminoadipate => lysine 1,0 C04002 (Z)-But-1-ene-1,2,4-tricarboxylate C01251 (R)-2-Hydroxybutane-1,2,4-tricarboxylate
+homoaconitate hydratase [EC:4.2.1.36] [RN:R04371] K01705 M00030 Lysine biosynthesis, AAA pathway, 2-oxoglutarate => 2-aminoadipate => lysine 2,0 C05662 Homoisocitrate C04002 (Z)-But-1-ene-1,2,4-tricarboxylate
+homoisocitrate dehydrogenase [EC:1.1.1.87] [RN:R01934] K05824 M00030 Lysine biosynthesis, AAA pathway, 2-oxoglutarate => 2-aminoadipate => lysine 3,0 C00322 2-Oxoadipate C05662 Homoisocitrate
+2-aminoadipate transaminase [EC:2.6.1.39] [RN:R01939] K00838 M00030 Lysine biosynthesis, AAA pathway, 2-oxoglutarate => 2-aminoadipate => lysine 4,0 C00956 L-2-Aminoadipate C00322 2-Oxoadipate
+L-2-aminoadipate reductase [EC:1.2.1.95] [RN:R03098 R04863 R04390] K00143 M00030 Lysine biosynthesis, AAA pathway, 2-oxoglutarate => 2-aminoadipate => lysine 5,0 C04076 L-2-Aminoadipate 6-semialdehyde C05535 alpha-Aminoadipoyl-S-acyl enzyme
+saccharopine dehydrogenase (NADP+, L-glutamate forming) [EC:1.5.1.10] [RN:R02315] K00293 M00030 Lysine biosynthesis, AAA pathway, 2-oxoglutarate => 2-aminoadipate => lysine 6,0 C00449 N6-(L-1,3-Dicarboxypropyl)-L-lysine C04076 L-2-Aminoadipate 6-semialdehyde
+saccharopine dehydrogenase, L-lysine forming [EC:1.5.1.7] [RN:R00715] K00290 M00030 Lysine biosynthesis, AAA pathway, 2-oxoglutarate => 2-aminoadipate => lysine 7,0 C00047 L-Lysine C00449 N6-(L-1,3-Dicarboxypropyl)-L-lysine
+[lysine-biosynthesis-protein LysW]---L-2-aminoadipate ligase [EC:6.3.2.43] [RN:R09775] K05827 M00031 Lysine biosynthesis, mediated by LysW, 2-aminoadipate => lysine 0,0 C19886 LysW-gamma-L-alpha-aminoadipate C00956 L-2-Aminoadipate
+LysW-gamma-L-alpha-aminoadipate kinase [EC:2.7.2.-] [RN:R09776] K05828 M00031 Lysine biosynthesis, mediated by LysW, 2-aminoadipate => lysine 1,0 C19887 LysW-gamma-L-alpha-aminoadipyl 6-phosphate C19886 LysW-gamma-L-alpha-aminoadipate
+LysW-gamma-L-alpha-aminoadipyl-6-phosphate reductase [EC:1.2.1.-] [RN:R09777] K05829 M00031 Lysine biosynthesis, mediated by LysW, 2-aminoadipate => lysine 2,0 C19888 LysW-gamma-L-alpha-aminoadipate 6-semialdehyde C19887 LysW-gamma-L-alpha-aminoadipyl 6-phosphate
+LysW-gamma-L-lysine aminotransferase [EC:2.6.1.-] [RN:R09778] K05830 M00031 Lysine biosynthesis, mediated by LysW, 2-aminoadipate => lysine 3,0 C19889 LysW-gamma-L-lysine C19888 LysW-gamma-L-alpha-aminoadipate 6-semialdehyde
+LysW-gamma-L-lysine carboxypeptidase [RN:R09779] K05831 M00031 Lysine biosynthesis, mediated by LysW, 2-aminoadipate => lysine 4,0 C00047 L-Lysine C19889 LysW-gamma-L-lysine
+saccharopine dehydrogenase [EC:1.5.1.7] [RN:R00715] K00290 M00032 Lysine degradation, lysine => saccharopine => acetoacetyl-CoA 0,0,0,0 C00449 N6-(L-1,3-Dicarboxypropyl)-L-lysine C00047 L-Lysine
+saccharopine dehydrogenase [EC:1.5.1.10] [RN:R02315] K00293 M00032 Lysine degradation, lysine => saccharopine => acetoacetyl-CoA 0,0,1,0 C04076 L-2-Aminoadipate 6-semialdehyde C00449 N6-(L-1,3-Dicarboxypropyl)-L-lysine
+alpha-aminoadipic semialdehyde synthase [EC:1.5.1.8 1.5.1.9] [RN:R00716 R02313] K14157 M00032 Lysine degradation, lysine => saccharopine => acetoacetyl-CoA 0,1 C04076 L-2-Aminoadipate 6-semialdehyde C00449 N6-(L-1,3-Dicarboxypropyl)-L-lysine
+aminoadipate-semialdehyde dehydrogenase [EC:1.2.1.31] [RN:R03102 R03103] K14085 M00032 Lysine degradation, lysine => saccharopine => acetoacetyl-CoA 1,0 C00956 L-2-Aminoadipate C04076 L-2-Aminoadipate 6-semialdehyde
+2-aminoadipate transaminase [EC:2.6.1.39] [RN:R01939] K00825 M00032 Lysine degradation, lysine => saccharopine => acetoacetyl-CoA 2,0 C00322 2-Oxoadipate C00956 L-2-Aminoadipate
+probable 2-oxoglutarate dehydrogenase E1 component DHKTD1 [EC:1.2.4.2] [RN:R01933] K15791 M00032 Lysine degradation, lysine => saccharopine => acetoacetyl-CoA 3,0 C00527 Glutaryl-CoA C00322 2-Oxoadipate
+2-oxoglutarate dehydrogenase E2 component (dihydrolipoamide [EC:2.3.1.61] [RN:R01933] K00658 M00032 Lysine degradation, lysine => saccharopine => acetoacetyl-CoA 3,0 C00527 Glutaryl-CoA C00322 2-Oxoadipate
+dihydrolipoamide dehydrogenase [EC:1.8.1.4] [RN:R01933] K00382 M00032 Lysine degradation, lysine => saccharopine => acetoacetyl-CoA 3,0 C00527 Glutaryl-CoA C00322 2-Oxoadipate
+glutaryl-CoA dehydrogenase [EC:1.3.8.6] [RN:R02488] K00252 M00032 Lysine degradation, lysine => saccharopine => acetoacetyl-CoA 4,0 C00877 Crotonoyl-CoA C00527 Glutaryl-CoA
+enoyl-CoA hydratase / 3-hydroxyacyl-CoA dehydrogenase [EC:4.2.1.17 1.1.1.35] [RN:R03026 R01975] K01825 M00032 Lysine degradation, lysine => saccharopine => acetoacetyl-CoA 5,0 C00332 Acetoacetyl-CoA C01144 (S)-3-Hydroxybutanoyl-CoA
+enoyl-CoA hydratase / 3-hydroxyacyl-CoA dehydrogenase [EC:4.2.1.17 1.1.1.35] [RN:R03026 R01975] K01782 M00032 Lysine degradation, lysine => saccharopine => acetoacetyl-CoA 5,1 C00332 Acetoacetyl-CoA C01144 (S)-3-Hydroxybutanoyl-CoA
+enoyl-CoA hydratase / 3-hydroxyacyl-CoA dehydrogenase [EC:4.2.1.17 1.1.1.35] [RN:R03026 R01975] K07514 M00032 Lysine degradation, lysine => saccharopine => acetoacetyl-CoA 5,2 C00332 Acetoacetyl-CoA C01144 (S)-3-Hydroxybutanoyl-CoA
+enoyl-CoA hydratase [EC:4.2.1.17] [RN:R03026] K01692 M00032 Lysine degradation, lysine => saccharopine => acetoacetyl-CoA 5,3,0,0 C01144 (S)-3-Hydroxybutanoyl-CoA C00877 Crotonoyl-CoA
+enoyl-CoA hydratase [EC:4.2.1.17] [RN:R03026] K07515 M00032 Lysine degradation, lysine => saccharopine => acetoacetyl-CoA 5,3,0,1 C01144 (S)-3-Hydroxybutanoyl-CoA C00877 Crotonoyl-CoA
+enoyl-CoA hydratase [EC:4.2.1.17] [RN:R03026] K07511 M00032 Lysine degradation, lysine => saccharopine => acetoacetyl-CoA 5,3,0,2 C01144 (S)-3-Hydroxybutanoyl-CoA C00877 Crotonoyl-CoA
+3-hydroxyacyl-CoA dehydrogenase [EC:1.1.1.35] [RN:R01975] K00022 M00032 Lysine degradation, lysine => saccharopine => acetoacetyl-CoA 5,3,1,0 C00332 Acetoacetyl-CoA C01144 (S)-3-Hydroxybutanoyl-CoA
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K00928 M00033 Ectoine biosynthesis, aspartate => ectoine 0,0 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate-semialdehyde dehydrogenase [EC:1.2.1.11] [RN:R02291] K00133 M00033 Ectoine biosynthesis, aspartate => ectoine 1,0 C00441 L-Aspartate 4-semialdehyde C03082 4-Phospho-L-aspartate
+diaminobutyrate-2-oxoglutarate transaminase [EC:2.6.1.76] [RN:R06977] K00836 M00033 Ectoine biosynthesis, aspartate => ectoine 2,0 C03283 L-2,4-Diaminobutanoate C00441 L-Aspartate 4-semialdehyde
+L-2,4-diaminobutyric acid acetyltransferase [EC:2.3.1.178] [RN:R06978] K06718 M00033 Ectoine biosynthesis, aspartate => ectoine 3,0 C06442 N-gamma-Acetyldiaminobutyrate C03283 L-2,4-Diaminobutanoate
+L-ectoine synthase [EC:4.2.1.108] [RN:R06979] K06720 M00033 Ectoine biosynthesis, aspartate => ectoine 4,0 C06231 Ectoine C06442 N-gamma-Acetyldiaminobutyrate
+S-adenosylmethionine synthetase [EC:2.5.1.6] [RN:R00177] K00789 M00034 Methionine salvage pathway 0,0 C00019 S-Adenosyl-L-methionine C00073 L-Methionine
+S-adenosylmethionine decarboxylase [EC:4.1.1.50] [RN:R00178] K01611 M00034 Methionine salvage pathway 1,0 C01137 S-Adenosylmethioninamine C00019 S-Adenosyl-L-methionine
+spermidine synthase [EC:2.5.1.16] [RN:R01920] K00797 M00034 Methionine salvage pathway 2,0 C00170 5'-Methylthioadenosine C01137 S-Adenosylmethioninamine
+S-adenosylhomocysteine nucleosidase [EC:3.2.2.9] [RN:R01401] K01243 M00034 Methionine salvage pathway 3,0,0,0 C03089 5-Methylthio-D-ribose C00170 5'-Methylthioadenosine
+S-adenosylhomocysteine nucleosidase [EC:3.2.2.9] [RN:R01401] K18284 M00034 Methionine salvage pathway 3,0,0,1 C03089 5-Methylthio-D-ribose C00170 5'-Methylthioadenosine
+5'-methylthioadenosine nucleosidase [EC:3.2.2.16] [RN:R01401] K01244 M00034 Methionine salvage pathway 3,0,0,2 C03089 5-Methylthio-D-ribose C00170 5'-Methylthioadenosine
+5-methylthioribose kinase [EC:2.7.1.100] [RN:R04143] K00899 M00034 Methionine salvage pathway 3,0,1,0 C04188 S-Methyl-5-thio-D-ribose 1-phosphate C03089 5-Methylthio-D-ribose
+5'-methylthioadenosine phosphorylase [EC:2.4.2.28] [RN:R01402] K00772 M00034 Methionine salvage pathway 3,1 C00147 Adenine; 6-Aminopurine C00170 5'-Methylthioadenosine
+methylthioribose-1-phosphate isomerase [EC:5.3.1.23] [RN:R04420] K08963 M00034 Methionine salvage pathway 4,0 C04582 S-Methyl-5-thio-D-ribulose 1-phosphate C04188 S-Methyl-5-thio-D-ribose 1-phosphate
+methylthioribulose-1-phosphate dehydratase [EC:4.2.1.109] [RN:R07392] K16054 M00034 Methionine salvage pathway 5,0 C15650 2,3-Diketo-5-methylthiopentyl-1-phosphate C04582 S-Methyl-5-thio-D-ribulose 1-phosphate
+methylthioribulose-1-phosphate dehydratase [EC:4.2.1.109] [RN:R07392] K08964 M00034 Methionine salvage pathway 5,1,0,0 C15650 2,3-Diketo-5-methylthiopentyl-1-phosphate C04582 S-Methyl-5-thio-D-ribulose 1-phosphate
+enolase-phosphatase E1 [EC:3.1.3.77] [RN:R07395] K09880 M00034 Methionine salvage pathway 5,1,1,0 C15606 1,2-Dihydroxy-5-(methylthio)pent-1-en-3-one C15650 2,3-Diketo-5-methylthiopentyl-1-phosphate
+2,3-diketo-5-methylthiopentyl-1-phosphate enolase [EC:5.3.2.5] [RN:R07393] K08965 M00034 Methionine salvage pathway 5,1,1,1,0,0 C15651 2-Hydroxy-3-keto-5-methylthiopentenyl-1-phosphate C15650 2,3-Diketo-5-methylthiopentyl-1-phosphate
+2-hydroxy-3-keto-5-methylthiopentenyl-1-phosphate phosphatase [EC:3.1.3.87] [RN:R07394] K08966 M00034 Methionine salvage pathway 5,1,1,1,1,0 C15606 1,2-Dihydroxy-5-(methylthio)pent-1-en-3-one C15651 2-Hydroxy-3-keto-5-methylthiopentenyl-1-phosphate
+1,2-dihydroxy-3-keto-5-methylthiopentene dioxygenase [EC:1.13.11.53] [RN:R07364] K08967 M00034 Methionine salvage pathway 6,0 C01180 4-Methylthio-2-oxobutanoic acid C15606 1,2-Dihydroxy-5-(methylthio)pent-1-en-3-one
+tyrosine aminotransferase [EC:2.6.1.5] [RN:R07396] K00815 M00034 Methionine salvage pathway 7,0 C00073 L-Methionine C01180 4-Methylthio-2-oxobutanoic acid
+aminotransferase [EC:2.6.1.-] [RN:R07396] K08969 M00034 Methionine salvage pathway 7,1 C00073 L-Methionine C01180 4-Methylthio-2-oxobutanoic acid
+aromatic-amino-acid transaminase [EC:2.6.1.57] [RN:R07396] K00832 M00034 Methionine salvage pathway 7,2 C00073 L-Methionine C01180 4-Methylthio-2-oxobutanoic acid
+aromatic amino acid aminotransferase [EC:2.6.1.57] [RN:R07396] K00838 M00034 Methionine salvage pathway 7,3 C00073 L-Methionine C01180 4-Methylthio-2-oxobutanoic acid
+S-adenosylmethionine synthetase [EC:2.5.1.6] [RN:R00177] K00789 M00035 Methionine degradation 0,0 C00019 S-Adenosyl-L-methionine C00073 L-Methionine
+DNA (cytosine-5-)-methyltransferase [EC:2.1.1.37] [RN:R04858] K00558 M00035 Methionine degradation 1,0 C00021 S-Adenosyl-L-homocysteine C00019 S-Adenosyl-L-methionine
+DNA (cytosine-5-)-methyltransferase [EC:2.1.1.37] [RN:R04858] K17398 M00035 Methionine degradation 1,1 C00021 S-Adenosyl-L-homocysteine C00019 S-Adenosyl-L-methionine
+DNA (cytosine-5-)-methyltransferase [EC:2.1.1.37] [RN:R04858] K17399 M00035 Methionine degradation 1,2 C00021 S-Adenosyl-L-homocysteine C00019 S-Adenosyl-L-methionine
+adenosylhomocysteinase [EC:3.3.1.1] [RN:R00192] K01251 M00035 Methionine degradation 2,0 C00155 L-Homocysteine C00021 S-Adenosyl-L-homocysteine
+cystathionine beta-synthase [EC:4.2.1.22] [RN:R01290] K01697 M00035 Methionine degradation 3,0 C02291 L-Cystathionine C00065,C00155 L-Serine,L-Homocysteine
+cystathionine beta-synthase [EC:4.2.1.22] [RN:R01290] K10150 M00035 Methionine degradation 3,1 C02291 L-Cystathionine C00065,C00155 L-Serine,L-Homocysteine
+branched-chain amino acid aminotransferase [EC:2.6.1.42] [RN:R01090] K00826 M00036 Leucine degradation, leucine => acetoacetate + acetyl-CoA 0,0 C00233 4-Methyl-2-oxopentanoate C00123 L-Leucine
+2-oxoisovalerate dehydrogenase [EC:1.2.4.4] [RN:R07601 R07602] K00166 M00036 Leucine degradation, leucine => acetoacetate + acetyl-CoA 1,0 C15975 [Dihydrolipoyllysine-residue (2-methylpropanoyl)transferase] S-(3-methylbutanoyl)dihydrolipoyllysine C00233,C15972 4-Methyl-2-oxopentanoate,Enzyme N6-(lipoyl)lysine
+2-oxoisovalerate dehydrogenase [EC:1.2.4.4] [RN:R07601 R07602] K00167 M00036 Leucine degradation, leucine => acetoacetate + acetyl-CoA 1,0 C15975 [Dihydrolipoyllysine-residue (2-methylpropanoyl)transferase] S-(3-methylbutanoyl)dihydrolipoyllysine C00233,C15972 4-Methyl-2-oxopentanoate,Enzyme N6-(lipoyl)lysine
+2-oxoisovalerate dehydrogenase [EC:1.2.4.4] [RN:R07601 R07602] K11381 M00036 Leucine degradation, leucine => acetoacetate + acetyl-CoA 1,0 C15975 [Dihydrolipoyllysine-residue (2-methylpropanoyl)transferase] S-(3-methylbutanoyl)dihydrolipoyllysine C00233,C15972 4-Methyl-2-oxopentanoate,Enzyme N6-(lipoyl)lysine
+2-oxoisovalerate dehydrogenase [EC:2.3.1.168] [RN:R04097] K09699 M00036 Leucine degradation, leucine => acetoacetate + acetyl-CoA 1,0 C02939,C15973 3-Methylbutanoyl-CoA,Enzyme N6-(dihydrolipoyl)lysine C15975 [Dihydrolipoyllysine-residue (2-methylpropanoyl)transferase] S-(3-methylbutanoyl)dihydrolipoyllysine
+dihydrolipoamide dehydrogenase [EC:1.8.1.4] [RN:R07618] K00382 M00036 Leucine degradation, leucine => acetoacetate + acetyl-CoA 1,0 C15972 Enzyme N6-(lipoyl)lysine C15973 Enzyme N6-(dihydrolipoyl)lysine
+isovaleryl-CoA dehydrogenase [EC:1.3.99.10] [RN:R04095] K00253 M00036 Leucine degradation, leucine => acetoacetate + acetyl-CoA 2,0 C03069 3-Methylcrotonyl-CoA C02939 3-Methylbutanoyl-CoA
+acyl-CoA dehydrogenase [EC:1.3.8.7] [RN:R04095] K00249 M00036 Leucine degradation, leucine => acetoacetate + acetyl-CoA 2,1 C03069 3-Methylcrotonyl-CoA C02939 3-Methylbutanoyl-CoA
+3-methylcrotonyl-CoA carboxylase [EC:6.4.1.4] [RN:R04138] K01968 M00036 Leucine degradation, leucine => acetoacetate + acetyl-CoA 3,0 C03231 3-Methylglutaconyl-CoA C03069 3-Methylcrotonyl-CoA
+3-methylcrotonyl-CoA carboxylase [EC:6.4.1.4] [RN:R04138] K01969 M00036 Leucine degradation, leucine => acetoacetate + acetyl-CoA 3,0 C03231 3-Methylglutaconyl-CoA C03069 3-Methylcrotonyl-CoA
+methylglutaconyl-CoA hydratase [EC:4.2.1.18] [RN:R02085] K05607 M00036 Leucine degradation, leucine => acetoacetate + acetyl-CoA 4,0 C00356 (S)-3-Hydroxy-3-methylglutaryl-CoA C03231 3-Methylglutaconyl-CoA
+methylglutaconyl-CoA hydratase [EC:4.2.1.18] [RN:R02085] K13766 M00036 Leucine degradation, leucine => acetoacetate + acetyl-CoA 4,1 C00356 (S)-3-Hydroxy-3-methylglutaryl-CoA C03231 3-Methylglutaconyl-CoA
+hydroxymethylglutaryl-CoA lyase [EC:4.1.3.4] [RN:R01360] K01640 M00036 Leucine degradation, leucine => acetoacetate + acetyl-CoA 5,0 C00164 Acetoacetate C00356 (S)-3-Hydroxy-3-methylglutaryl-CoA
+tryptophan 5-monooxygenase [EC:1.14.16.4] [RN:R01814] K00502 M00037 Melatonin biosynthesis, tryptophan => serotonin => melatonin 0,0 C00643 5-Hydroxy-L-tryptophan C00078 L-Tryptophan
+aromatic-L-amino-acid decarboxylase [EC:4.1.1.28] [RN:R02701] K01593 M00037 Melatonin biosynthesis, tryptophan => serotonin => melatonin 1,0 C00780 Serotonin C00643 5-Hydroxy-L-tryptophan
+arylalkylamine N-acetyltransferase [EC:2.3.1.87] [RN:R02911] K00669 M00037 Melatonin biosynthesis, tryptophan => serotonin => melatonin 2,0 C00978 N-Acetylserotonin C00780 Serotonin
+arylalkylamine N-acetyltransferase [EC:2.3.1.87] [RN:R02911] K22450 M00037 Melatonin biosynthesis, tryptophan => serotonin => melatonin 2,1 C00978 N-Acetylserotonin C00780 Serotonin
+acetylserotonin N-methyltransferase [EC:2.1.1.4] [RN:R03130] K00543 M00037 Melatonin biosynthesis, tryptophan => serotonin => melatonin 3,0 C01598 Melatonin C00978 N-Acetylserotonin
+tryptophan 2,3-dioxygenase [EC:1.13.11.11] [RN:R00678] K00453 M00038 Tryptophan metabolism, tryptophan => kynurenine => 2-aminomuconate 0,0 C02700 L-Formylkynurenine C00078 L-Tryptophan
+indoleamine 2,3-dioxygenase [EC:1.13.11.52] [RN:R00678] K00463 M00038 Tryptophan metabolism, tryptophan => kynurenine => 2-aminomuconate 0,1 C02700 L-Formylkynurenine C00078 L-Tryptophan
+arylformamidase [EC:3.5.1.9] [RN:R01959] K01432 M00038 Tryptophan metabolism, tryptophan => kynurenine => 2-aminomuconate 1,0 C00328 L-Kynurenine C02700 L-Formylkynurenine
+arylformamidase [EC:3.5.1.9] [RN:R01959] K14263 M00038 Tryptophan metabolism, tryptophan => kynurenine => 2-aminomuconate 1,1 C00328 L-Kynurenine C02700 L-Formylkynurenine
+arylformamidase [EC:3.5.1.9] [RN:R01959] K07130 M00038 Tryptophan metabolism, tryptophan => kynurenine => 2-aminomuconate 1,2 C00328 L-Kynurenine C02700 L-Formylkynurenine
+kynurenine 3-monooxygenase [EC:1.14.13.9] [RN:R01960] K00486 M00038 Tryptophan metabolism, tryptophan => kynurenine => 2-aminomuconate 2,0 C03227 3-Hydroxy-L-kynurenine C00328 L-Kynurenine
+kynureninase [EC:3.7.1.3] [RN:R02668] K01556 M00038 Tryptophan metabolism, tryptophan => kynurenine => 2-aminomuconate 3,0 C00632 3-Hydroxyanthranilate C03227 3-Hydroxy-L-kynurenine
+3-hydroxyanthranilate 3,4-dioxygenase [EC:1.13.11.6] [RN:R02665] K00452 M00038 Tryptophan metabolism, tryptophan => kynurenine => 2-aminomuconate 4,0 C04409 2-Amino-3-carboxymuconate semialdehyde C00632 3-Hydroxyanthranilate
+aminocarboxymuconate-semialdehyde decarboxylase [EC:4.1.1.45] [RN:R04323] K03392 M00038 Tryptophan metabolism, tryptophan => kynurenine => 2-aminomuconate 5,0 C03824 2-Aminomuconate semialdehyde C04409 2-Amino-3-carboxymuconate semialdehyde
+aminomuconate-semialdehyde dehydrogenase [EC:1.2.1.32] [RN:R03889] K10217 M00038 Tryptophan metabolism, tryptophan => kynurenine => 2-aminomuconate 6,0 C02220 2-Aminomuconate C03824 2-Aminomuconate semialdehyde
+aminomuconate-semialdehyde dehydrogenase [EC:1.2.1.32] [RN:R03889] K23234 M00038 Tryptophan metabolism, tryptophan => kynurenine => 2-aminomuconate 6,1 C02220 2-Aminomuconate C03824 2-Aminomuconate semialdehyde
+phenylalanine ammonia-lyase [EC:4.3.1.24] [RN:R00679] K10775 M00039 Monolignol biosynthesis, phenylalanine/tyrosine => monolignol 0,0
+phenylalanine/tyrosine ammonia-lyase [EC:4.3.1.25] [RN:R00697 R00737] K13064 M00039 Monolignol biosynthesis, phenylalanine/tyrosine => monolignol 0,1 C00811 4-Coumarate C00082 L-Tyrosine
+trans-cinnamate 4-monooxygenase [EC:1.14.14.91] [RN:R02253] K00487 M00039 Monolignol biosynthesis, phenylalanine/tyrosine => monolignol 1,0 C00811 4-Coumarate C00423 trans-Cinnamate
+4-coumarate--CoA ligase [EC:6.2.1.12] [RN:R01616 R01943] K01904 M00039 Monolignol biosynthesis, phenylalanine/tyrosine => monolignol 2,0 C00223 p-Coumaroyl-CoA C00811 4-Coumarate
+shikimate O-hydroxycinnamoyltransferase [EC:2.3.1.133] [RN:R02416 R07433] K13065 M00039 Monolignol biosynthesis, phenylalanine/tyrosine => monolignol 3,0 C00323 Caffeoyl-CoA C10434 5-O-Caffeoylshikimic acid
+5-O-(4-coumaroyl)-D-quinate 3'-monooxygenase [EC:1.14.14.96] [RN:R06582] K09754 M00039 Monolignol biosynthesis, phenylalanine/tyrosine => monolignol 4,0 C10434 5-O-Caffeoylshikimic acid C02947 4-Coumaroylshikimate
+caffeoyl-CoA O-methyltransferase [EC:2.1.1.104] [RN:R01942] K00588 M00039 Monolignol biosynthesis, phenylalanine/tyrosine => monolignol 5,0 C00406 Feruloyl-CoA C00323 Caffeoyl-CoA
+cinnamoyl-CoA reductase [EC:1.2.1.44] [RN:R01615 R02193] K09753 M00039 Monolignol biosynthesis, phenylalanine/tyrosine => monolignol 6,0 C02666 Coniferyl aldehyde C00406 Feruloyl-CoA
+ferulate-5-hydroxylase [EC:1.14.-.-] [RN:R06572] K09755 M00039 Monolignol biosynthesis, phenylalanine/tyrosine => monolignol 7,0 C12204 5-Hydroxyconiferaldehyde C02666 Coniferyl aldehyde
+caffeic acid 3-O-methyltransferase [EC:2.1.1.68] [RN:R06576] K13066 M00039 Monolignol biosynthesis, phenylalanine/tyrosine => monolignol 8,0 C05610 Sinapoyl aldehyde C12204 5-Hydroxyconiferaldehyde
+cinnamyl-alcohol dehydrogenase [EC:1.1.1.195] [RN:R07437 R02593 R03918] K00083 M00039 Monolignol biosynthesis, phenylalanine/tyrosine => monolignol 9,0 C02325 Sinapyl alcohol C05610 Sinapoyl aldehyde
+cinnamyl-alcohol dehydrogenase [EC:1.1.1.195] [RN:R07437 R02593 R03918] K22395 M00039 Monolignol biosynthesis, phenylalanine/tyrosine => monolignol 9,1 C02325 Sinapyl alcohol C05610 Sinapoyl aldehyde
+aromatic-amino-acid transaminase [EC:2.6.1.57] [RN:R01731] K00832 M00040 Tyrosine biosynthesis, prephanate => pretyrosine => tyrosine 0,0 C00826 L-Arogenate C00254 Prephenate
+aspartate-prephenate aminotransferase [EC:2.6.1.78] [RN:R01731] K15849 M00040 Tyrosine biosynthesis, prephanate => pretyrosine => tyrosine 0,1 C00826 L-Arogenate C00254 Prephenate
+cyclohexadienyl dehydrogenase [EC:1.3.1.43] [RN:R00732] K00220 M00040 Tyrosine biosynthesis, prephanate => pretyrosine => tyrosine 1,0 C00082 L-Tyrosine C00826 L-Arogenate
+arogenate dehydrogenase (NADP+) [EC:1.3.1.78] [RN:R00733] K15226 M00040 Tyrosine biosynthesis, prephanate => pretyrosine => tyrosine 1,1 C00082 L-Tyrosine C00826 L-Arogenate
+arogenate dehydrogenase (NADP+) [EC:1.3.1.78] [RN:R00733] K15227 M00040 Tyrosine biosynthesis, prephanate => pretyrosine => tyrosine 1,2 C00082 L-Tyrosine C00826 L-Arogenate
+tyrosinase [EC:1.14.18.1] [RN:R00731] K00505 M00042 Catecholamine biosynthesis, tyrosine => dopamine => noradrenaline => adrenaline 0,0 C00355 3,4-Dihydroxy-L-phenylalanine C00082 L-Tyrosine
+tyrosine 3-monooxygenase [EC:1.14.16.2] [RN:R01815] K00501 M00042 Catecholamine biosynthesis, tyrosine => dopamine => noradrenaline => adrenaline 0,1 C00355 3,4-Dihydroxy-L-phenylalanine C00082 L-Tyrosine
+tyrosine decarboxylase [EC:4.1.1.25] [RN:R02080] K01592 M00042 Catecholamine biosynthesis, tyrosine => dopamine => noradrenaline => adrenaline 1,0 C03758 4-(2-Aminoethyl)-1,2-benzenediol C00355 3,4-Dihydroxy-L-phenylalanine
+aromatic-L-amino-acid decarboxylase [EC:4.1.1.28] [RN:R02080] K01593 M00042 Catecholamine biosynthesis, tyrosine => dopamine => noradrenaline => adrenaline 1,1 C03758 4-(2-Aminoethyl)-1,2-benzenediol C00355 3,4-Dihydroxy-L-phenylalanine
+dopamine beta-monooxygenase [EC:1.14.17.1] [RN:R02535] K00503 M00042 Catecholamine biosynthesis, tyrosine => dopamine => noradrenaline => adrenaline 2,0 C00547 L-Noradrenaline C03758 4-(2-Aminoethyl)-1,2-benzenediol
+phenylethanolamine N-methyltransferase [EC:2.1.1.28] [RN:R02533] K00553 M00042 Catecholamine biosynthesis, tyrosine => dopamine => noradrenaline => adrenaline 3,0 C00788 L-Adrenaline C00547 L-Noradrenaline
+thyroid peroxidase [EC:1.11.1.8] [RN:R03539 R03973 R03953] K00431 M00043 Thyroid hormone biosynthesis, tyrosine => triiodothyronine/thyroxine 0,0 C02465 Triiodothyronine C01060 3,5-Diiodo-L-tyrosine
+tyrosine aminotransferase [EC:2.6.1.5] [RN:R00734] K00815 M00044 Tyrosine degradation, tyrosine => homogentisate 0,0 C01179 3-(4-Hydroxyphenyl)pyruvate C00082 L-Tyrosine
+tyrosine aminotransferase [EC:2.6.1.5] [RN:R00734] K00838 M00044 Tyrosine degradation, tyrosine => homogentisate 0,1 C01179 3-(4-Hydroxyphenyl)pyruvate C00082 L-Tyrosine
+L-amino-acid oxidase [EC:1.4.3.2] [RN:R00729] K03334 M00044 Tyrosine degradation, tyrosine => homogentisate 0,2 C01179 3-(4-Hydroxyphenyl)pyruvate C00082 L-Tyrosine
+4-hydroxyphenylpyruvate dioxygenase [EC:1.13.11.27] [RN:R02521] K00457 M00044 Tyrosine degradation, tyrosine => homogentisate 1,0 C00544 Homogentisate C01179 3-(4-Hydroxyphenyl)pyruvate
+homogentisate 1,2-dioxygenase [EC:1.13.11.5] [RN:R02519] K00451 M00044 Tyrosine degradation, tyrosine => homogentisate 2,0 C01036 4-Maleylacetoacetate C00544 Homogentisate
+maleylacetoacetate isomerase [EC:5.2.1.2] [RN:R03181] K01800 M00044 Tyrosine degradation, tyrosine => homogentisate 3,0 C01061 4-Fumarylacetoacetate C01036 4-Maleylacetoacetate
+fumarylacetoacetase [EC:3.7.1.2] [RN:R01364] K01555 M00044 Tyrosine degradation, tyrosine => homogentisate 4,0 C00164,C00122 Acetoacetate,Fumarate C01061 4-Fumarylacetoacetate
+fumarylacetoacetate (FAA) hydrolase [EC:3.7.1.2] [RN:R01364] K16171 M00044 Tyrosine degradation, tyrosine => homogentisate 4,1 C00164,C00122 Acetoacetate,Fumarate C01061 4-Fumarylacetoacetate
+histidine ammonia-lyase [EC:4.3.1.3] [RN:R01168] K01745 M00045 Histidine degradation, histidine => N-formiminoglutamate => glutamate 0,0 C00785 Urocanate C00135 L-Histidine
+urocanate hydratase [EC:4.2.1.49] [RN:R02914] K01712 M00045 Histidine degradation, histidine => N-formiminoglutamate => glutamate 1,0 C03680 4-Imidazolone-5-propanoate C00785 Urocanate
+imidazolonepropionase [EC:3.5.2.7] [RN:R02288] K01468 M00045 Histidine degradation, histidine => N-formiminoglutamate => glutamate 2,0 C00439 N-Formimino-L-glutamate C03680 4-Imidazolone-5-propanoate
+formiminoglutamase [EC:3.5.3.8] [RN:R02285] K01479 M00045 Histidine degradation, histidine => N-formiminoglutamate => glutamate 3,0 C00025 L-Glutamate C00439 N-Formimino-L-glutamate
+glutamate formiminotransferase [EC:2.1.2.5] [RN:R02287] K00603 M00045 Histidine degradation, histidine => N-formiminoglutamate => glutamate 3,1 C00025 L-Glutamate C00439 N-Formimino-L-glutamate
+glutamate formiminotransferase [EC:2.1.2.5] [RN:R02287] K13990 M00045 Histidine degradation, histidine => N-formiminoglutamate => glutamate 3,2 C00025 L-Glutamate C00439 N-Formimino-L-glutamate
+formimidoylglutamate deiminase [EC:3.5.3.13] [RN:R02286] K05603 M00045 Histidine degradation, histidine => N-formiminoglutamate => glutamate 3,3,0,0 C01045 N-Formyl-L-glutamate C00439 N-Formimino-L-glutamate
+N-formylglutamate deformylase [EC:3.5.1.68] [RN:R00525] K01458 M00045 Histidine degradation, histidine => N-formiminoglutamate => glutamate 3,3,1,0 C00025 L-Glutamate C01045 N-Formyl-L-glutamate
+dihydropyrimidine dehydrogenase (NADP+) [EC:1.3.1.2] [RN:R00978 R01415] K00207 M00046 Pyrimidine degradation, uracil => beta-alanine, thymine => 3-aminoisobutanoate 0,0 C21028 (R)-5,6-Dihydrothymine C00178 Thymine
+dihydropyrimidine dehydrogenase (NAD+) [EC:1.3.1.1] [RN:R00977 R11026] K17722 M00046 Pyrimidine degradation, uracil => beta-alanine, thymine => 3-aminoisobutanoate 0,1 C21028 (R)-5,6-Dihydrothymine C00178 Thymine
+dihydropyrimidine dehydrogenase (NAD+) [EC:1.3.1.1] [RN:R00977 R11026] K17723 M00046 Pyrimidine degradation, uracil => beta-alanine, thymine => 3-aminoisobutanoate 0,1 C21028 (R)-5,6-Dihydrothymine C00178 Thymine
+dihydropyrimidinase [EC:3.5.2.2] [RN:R02269 R03055] K01464 M00046 Pyrimidine degradation, uracil => beta-alanine, thymine => 3-aminoisobutanoate 1,0 C21029 (R)-3-Ureidoisobutyrate C21028 (R)-5,6-Dihydrothymine
+beta-ureidopropionase [EC:3.5.1.6] [RN:R00905 R04666] K01431 M00046 Pyrimidine degradation, uracil => beta-alanine, thymine => 3-aminoisobutanoate 2,0 C01205 (R)-3-Amino-2-methylpropanoate C21029 (R)-3-Ureidoisobutyrate
+beta-ureidopropionase [EC:3.5.1.6] [RN:R00905 R04666] K06016 M00046 Pyrimidine degradation, uracil => beta-alanine, thymine => 3-aminoisobutanoate 2,1 C01205 (R)-3-Amino-2-methylpropanoate C21029 (R)-3-Ureidoisobutyrate
+glycine amidinotransferase [EC:2.1.4.1] [RN:R00565] K00613 M00047 Creatine pathway 0,0 C00581 Guanidinoacetate C00062 L-Arginine
+guanidinoacetate N-methyltransferase [EC:2.1.1.2] [RN:R01883] K00542 M00047 Creatine pathway 1,0 C00300 Creatine C00581 Guanidinoacetate
+creatine kinase [EC:2.7.3.2] [RN:R01881] K00933 M00047 Creatine pathway 2,0 C02305 Phosphocreatine C00300 Creatine
+amidophosphoribosyltransferase [EC:2.4.2.14] [RN:R01072] K00764 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 0,0 C03090 5-Phosphoribosylamine C00119,C00064 5-Phospho-alpha-D-ribose 1-diphosphate,L-Glutamine
+phosphoribosylamine--glycine ligase [EC:6.3.4.13] [RN:R04144] K01945 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 1,0 C03838 5'-Phosphoribosylglycinamide C03090 5-Phosphoribosylamine
+phosphoribosylamine--glycine ligase [EC:6.3.4.13] [RN:R04144] K11787 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 1,1 C03838 5'-Phosphoribosylglycinamide C03090 5-Phosphoribosylamine
+phosphoribosylamine--glycine ligase [EC:6.3.4.13] [RN:R04144] K11788 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 1,2 C03838 5'-Phosphoribosylglycinamide C03090 5-Phosphoribosylamine
+fusion protein PurCD [EC:6.3.2.6 6.3.4.13] [RN:R04144 R04591] K13713 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 1,3 C04823 1-(5'-Phosphoribosyl)-5-amino-4-(N-succinocarboxamide)-imidazole C04751 1-(5-Phospho-D-ribosyl)-5-amino-4-imidazolecarboxylate
+phosphoribosylglycinamide formyltransferase [EC:2.1.2.2] [RN:R04325] K00601 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 2,0 C04376 5'-Phosphoribosyl-N-formylglycinamide C03838 5'-Phosphoribosylglycinamide
+phosphoribosylglycinamide formyltransferase [EC:2.1.2.2] [RN:R04325] K11175 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 2,1 C04376 5'-Phosphoribosyl-N-formylglycinamide C03838 5'-Phosphoribosylglycinamide
+phosphoribosylglycinamide formyltransferase [EC:2.1.2.2] [RN:R04325] K08289 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 2,2 C04376 5'-Phosphoribosyl-N-formylglycinamide C03838 5'-Phosphoribosylglycinamide
+phosphoribosylamine--glycine ligase [EC:6.3.4.13] [RN:R04144] K11787 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 2,3 C03838 5'-Phosphoribosylglycinamide C03090 5-Phosphoribosylamine
+phosphoribosylglycinamide formyltransferase [EC:2.1.2.2] [RN:R04325] K01492 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 2,4 C04376 5'-Phosphoribosyl-N-formylglycinamide C03838 5'-Phosphoribosylglycinamide
+phosphoribosylformylglycinamidine synthase [EC:6.3.5.3] [RN:R04463] K01952 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 3,0 C04640 2-(Formamido)-N1-(5'-phosphoribosyl)acetamidine C04376 5'-Phosphoribosyl-N-formylglycinamide
+phosphoribosylformylglycinamidine synthase [EC:6.3.5.3] [RN:R04463] K23269 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 3,1 C04640 2-(Formamido)-N1-(5'-phosphoribosyl)acetamidine C04376 5'-Phosphoribosyl-N-formylglycinamide
+phosphoribosylformylglycinamidine synthase [EC:6.3.5.3] [RN:R04463] K23264 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 3,1 C04640 2-(Formamido)-N1-(5'-phosphoribosyl)acetamidine C04376 5'-Phosphoribosyl-N-formylglycinamide
+phosphoribosylformylglycinamidine synthase [EC:6.3.5.3] [RN:R04463] K23265 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 3,1 C04640 2-(Formamido)-N1-(5'-phosphoribosyl)acetamidine C04376 5'-Phosphoribosyl-N-formylglycinamide
+phosphoribosylformylglycinamidine synthase [EC:6.3.5.3] [RN:R04463] K23270 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 3,2 C04640 2-(Formamido)-N1-(5'-phosphoribosyl)acetamidine C04376 5'-Phosphoribosyl-N-formylglycinamide
+phosphoribosylformylglycinamidine synthase [EC:6.3.5.3] [RN:R04463] K23265 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 3,2 C04640 2-(Formamido)-N1-(5'-phosphoribosyl)acetamidine C04376 5'-Phosphoribosyl-N-formylglycinamide
+phosphoribosylformylglycinamidine cyclo-ligase [EC:6.3.3.1] [RN:R04208] K01933 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 4,0 C03373 Aminoimidazole ribotide C04640 2-(Formamido)-N1-(5'-phosphoribosyl)acetamidine
+phosphoribosylamine--glycine ligase [EC:6.3.4.13] [RN:R04144] K11787 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 4,1 C03838 5'-Phosphoribosylglycinamide C03090 5-Phosphoribosylamine
+phosphoribosylamine--glycine ligase [EC:6.3.4.13] [RN:R04144] K11788 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 4,2,0,0 C03838 5'-Phosphoribosylglycinamide C03090 5-Phosphoribosylamine
+phosphoribosylaminoimidazole carboxylase [EC:4.1.1.21] [RN:R04209] K01587 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 4,2,1,0 C04751 1-(5-Phospho-D-ribosyl)-5-amino-4-imidazolecarboxylate C03373 Aminoimidazole ribotide
+phosphoribosylaminoimidazole carboxylase [EC:4.1.1.21] [RN:R04209] K11808 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 4,2,1,1 C04751 1-(5-Phospho-D-ribosyl)-5-amino-4-imidazolecarboxylate C03373 Aminoimidazole ribotide
+5-(carboxyamino)imidazole ribonucleotide synthase [EC:6.3.4.18] [RN:R07405] K01589 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 4,2,1,2,0,0 C04751 1-(5-Phospho-D-ribosyl)-5-amino-4-imidazolecarboxylate C15667 5-Carboxyamino-1-(5-phospho-D-ribosyl)imidazole
+5-(carboxyamino)imidazole ribonucleotide mutase [EC:5.4.99.18] [RN:R07404] K01588 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 4,2,1,2,1,0 C15667 5-Carboxyamino-1-(5-phospho-D-ribosyl)imidazole C03373 Aminoimidazole ribotide
+phosphoribosylaminoimidazole-succinocarboxamide synthase [EC:6.3.2.6] [RN:R04591] K01923 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 5,0 C04823 1-(5'-Phosphoribosyl)-5-amino-4-(N-succinocarboxamide)-imidazole C04751 1-(5-Phospho-D-ribosyl)-5-amino-4-imidazolecarboxylate
+phosphoribosylaminoimidazole carboxylase [EC:4.1.1.21] [RN:R04209] K01587 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 5,1 C04751 1-(5-Phospho-D-ribosyl)-5-amino-4-imidazolecarboxylate C03373 Aminoimidazole ribotide
+fusion protein PurCD [EC:6.3.2.6 6.3.4.13] [RN:R04144 R04591] K13713 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 5,2 C04823 1-(5'-Phosphoribosyl)-5-amino-4-(N-succinocarboxamide)-imidazole C04751 1-(5-Phospho-D-ribosyl)-5-amino-4-imidazolecarboxylate
+adenylosuccinate lyase [EC:4.3.2.2] [RN:R04559] K01756 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 6,0 C04677 1-(5'-Phosphoribosyl)-5-amino-4-imidazolecarboxamide C04823 1-(5'-Phosphoribosyl)-5-amino-4-(N-succinocarboxamide)-imidazole
+phosphoribosylaminoimidazolecarboxamide formyltransferase / IMP cyclohydrolase [EC:2.1.2.3 3.5.4.10] [RN:R04560 R01127] K00602 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 7,0 C00130 IMP C04734 1-(5'-Phosphoribosyl)-5-formamido-4-imidazolecarboxamide
+phosphoribosylglycinamide formyltransferase [EC:2.1.2.2] [RN:R04325] K01492 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 7,1,0,0 C04376 5'-Phosphoribosyl-N-formylglycinamide C03838 5'-Phosphoribosylglycinamide
+5-formaminoimidazole-4-carboxamide-1-(beta)-D-ribofuranosyl 5'-monophosphate synthetase [EC:6.3.4.23] [RN:R06975] K06863 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 7,1,0,1 C04734 1-(5'-Phosphoribosyl)-5-formamido-4-imidazolecarboxamide C04677 1-(5'-Phosphoribosyl)-5-amino-4-imidazolecarboxamide
+IMP cyclohydrolase [EC:3.5.4.10] [RN:R01127] K11176 M00048 Inosine monophosphate biosynthesis, PRPP + glutamine => IMP 7,1,1,0 C00130 IMP C04734 1-(5'-Phosphoribosyl)-5-formamido-4-imidazolecarboxamide
+adenylosuccinate synthase [EC:6.3.4.4] [RN:R01135] K01939 M00049 Adenine ribonucleotide biosynthesis, IMP => ADP,ATP 0,0 C03794 N6-(1,2-Dicarboxyethyl)-AMP C00130 IMP
+adenylosuccinate lyase [EC:4.3.2.2] [RN:R01083] K01756 M00049 Adenine ribonucleotide biosynthesis, IMP => ADP,ATP 1,0 C00020 AMP C03794 N6-(1,2-Dicarboxyethyl)-AMP
+adenylate kinase [EC:2.7.4.3] [RN:R00127] K00939 M00049 Adenine ribonucleotide biosynthesis, IMP => ADP,ATP 2,0 C00008 ADP C00020 AMP
+adenylate kinase [EC:2.7.4.3] [RN:R00127] K18532 M00049 Adenine ribonucleotide biosynthesis, IMP => ADP,ATP 2,1 C00008 ADP C00020 AMP
+adenylate kinase [EC:2.7.4.3] [RN:R00127] K18533 M00049 Adenine ribonucleotide biosynthesis, IMP => ADP,ATP 2,2 C00008 ADP C00020 AMP
+nucleoside-triphosphate--adenylate kinase [EC:2.7.4.10] [RN:R00333] K00944 M00049 Adenine ribonucleotide biosynthesis, IMP => ADP,ATP 2,3 C00008 ADP C00020 AMP
+nucleoside-diphosphate kinase [EC:2.7.4.6] [RN:R00124] K00940 M00049 Adenine ribonucleotide biosynthesis, IMP => ADP,ATP 3,0 C00002 ATP C00008 ADP
+pyruvate kinase [EC:2.7.1.40] [RN:R00200] K00873 M00049 Adenine ribonucleotide biosynthesis, IMP => ADP,ATP 3,1 C00002 ATP C00008 ADP
+pyruvate kinase [EC:2.7.1.40] [RN:R00200] K12406 M00049 Adenine ribonucleotide biosynthesis, IMP => ADP,ATP 3,2 C00002 ATP C00008 ADP
+IMP dehydrogenase [EC:1.1.1.205] [RN:R01130] K00088 M00050 Guanine ribonucleotide biosynthesis IMP => GDP,GTP 0,0 C00655 Xanthosine 5'-phosphate C00130 IMP
+GMP synthase [EC:6.3.5.2] [RN:R01230 R01231] K01951 M00050 Guanine ribonucleotide biosynthesis IMP => GDP,GTP 1,0 C00144 GMP C00655 Xanthosine 5'-phosphate
+guanylate kinase [EC:2.7.4.8] [RN:R00332] K00942 M00050 Guanine ribonucleotide biosynthesis IMP => GDP,GTP 2,0 C00035 GDP C00144 GMP
+nucleoside-diphosphate kinase [EC:2.7.4.6] [RN:R00330] K00940 M00050 Guanine ribonucleotide biosynthesis IMP => GDP,GTP 3,0 C00044 GTP C00035 GDP
+pyruvate kinase [EC:2.7.1.40] [RN:R00430] K00873 M00050 Guanine ribonucleotide biosynthesis IMP => GDP,GTP 3,1 C00044 GTP C00035 GDP
+pyruvate kinase [EC:2.7.1.40] [RN:R00430] K12406 M00050 Guanine ribonucleotide biosynthesis IMP => GDP,GTP 3,2 C00044 GTP C00035 GDP
+carbamoyl-phosphate synthase [EC:6.3.5.5] [RN:R00575] K11540 M00051 Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP 0,0 C00169 Carbamoyl phosphate C00064 L-Glutamine
+carbamoyl-phosphate synthase [EC:6.3.5.5] [RN:R00575] K11541 M00051 Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP 0,1,0,0 C00169 Carbamoyl phosphate C00064 L-Glutamine
+dihydroorotase [EC:3.5.2.3] [RN:R01993] K01465 M00051 Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP 0,1,1,0 C00337 (S)-Dihydroorotate C00438 N-Carbamoyl-L-aspartate
+carbamoyl-phosphate synthase [EC:6.3.5.5] [RN:R00575] K01954 M00051 Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP 0,2,0,0 C00169 Carbamoyl phosphate C00064 L-Glutamine
+carbamoyl-phosphate synthase [EC:6.3.5.5] [RN:R00575] K01955 M00051 Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP 0,2,0,1 C00169 Carbamoyl phosphate C00064 L-Glutamine
+carbamoyl-phosphate synthase [EC:6.3.5.5] [RN:R00575] K01956 M00051 Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP 0,2,0,1 C00169 Carbamoyl phosphate C00064 L-Glutamine
+aspartate carbamoyltransferase [EC:2.1.3.2] [RN:R01397] K00609 M00051 Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP 0,2,1,0 C00438 N-Carbamoyl-L-aspartate C00169 Carbamoyl phosphate
+aspartate carbamoyltransferase [EC:2.1.3.2] [RN:R01397] K00610 M00051 Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP 0,2,1,0 C00438 N-Carbamoyl-L-aspartate C00169 Carbamoyl phosphate
+aspartate carbamoyltransferase [EC:2.1.3.2] [RN:R01397] K00608 M00051 Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP 0,2,1,1 C00438 N-Carbamoyl-L-aspartate C00169 Carbamoyl phosphate
+dihydroorotase [EC:3.5.2.3] [RN:R01993] K01465 M00051 Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP 0,2,2,0 C00337 (S)-Dihydroorotate C00438 N-Carbamoyl-L-aspartate
+dihydroorotate dehydrogenase [EC:1.3.98.1] [RN:R01867] K00226 M00051 Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP 1,0 C00295 Orotate C00337 (S)-Dihydroorotate
+dihydroorotate dehydrogenase [EC:1.3.5.2] [RN:R01868] K00254 M00051 Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP 1,1 C00295 Orotate C00337 (S)-Dihydroorotate
+dihydroorotate dehydrogenase [EC:1.3.1.14] [RN:R01869] K17828 M00051 Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP 1,2 C00295 Orotate C00337 (S)-Dihydroorotate
+orotate phosphoribosyltransferase [EC:2.4.2.10] [RN:R01870] K13421 M00051 Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP 2,0 C01103 Orotidine 5'-phosphate C00295,C00119 Orotate,5-Phospho-alpha-D-ribose 1-diphosphate
+orotate phosphoribosyltransferase [EC:2.4.2.10] [RN:R01870] K00762 M00051 Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP 2,1,0,0 C01103 Orotidine 5'-phosphate C00295,C00119 Orotate,5-Phospho-alpha-D-ribose 1-diphosphate
+orotidine-5'-phosphate decarboxylase [EC:4.1.1.23] [RN:R00965] K01591 M00051 Uridine monophosphate biosynthesis, glutamine (+ PRPP) => UMP 2,1,1,0 C00105 UMP C01103 Orotidine 5'-phosphate
+cytidylate kinase [EC:2.7.4.14] [RN:R00158] K13800 M00052 Pyrimidine ribonucleotide biosynthesis, UMP => UDP/UTP,CDP/CTP 0,0 C00015 UDP C00105 UMP
+cytidylate kinase [EC:2.7.4.14] [RN:R00158] K13809 M00052 Pyrimidine ribonucleotide biosynthesis, UMP => UDP/UTP,CDP/CTP 0,1 C00015 UDP C00105 UMP
+cytidylate kinase [EC:2.7.4.14] [RN:R00158] K00945 M00052 Pyrimidine ribonucleotide biosynthesis, UMP => UDP/UTP,CDP/CTP 0,2 C00015 UDP C00105 UMP
+cytidylate kinase [EC:2.7.4.14] [RN:R00158] K13799 M00052 Pyrimidine ribonucleotide biosynthesis, UMP => UDP/UTP,CDP/CTP 0,3 C00015 UDP C00105 UMP
+nucleoside-diphosphate kinase [EC:2.7.4.6] [RN:R00156] K00940 M00052 Pyrimidine ribonucleotide biosynthesis, UMP => UDP/UTP,CDP/CTP 1,0 C00075 UTP C00015 UDP
+nucleoside-diphosphate kinase [EC:2.7.4.6] [RN:R00156] K18533 M00052 Pyrimidine ribonucleotide biosynthesis, UMP => UDP/UTP,CDP/CTP 1,1 C00075 UTP C00015 UDP
+CTP synthase [EC:6.3.4.2] [RN:R00571 R00573] K01937 M00052 Pyrimidine ribonucleotide biosynthesis, UMP => UDP/UTP,CDP/CTP 2,0 C00063 CTP C00075 UTP
+ribonucleoside-diphosphate reductase [EC:1.17.4.1] [RN:R02024] K00524 M00053 Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP 0,0 C00705 dCDP C00112 CDP
+ribonucleoside-diphosphate reductase [EC:1.17.4.1] [RN:R02024] K00525 M00053 Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP 0,1 C00705 dCDP C00112 CDP
+ribonucleoside-diphosphate reductase [EC:1.17.4.1] [RN:R02024] K00526 M00053 Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP 0,1 C00705 dCDP C00112 CDP
+ribonucleoside-diphosphate reductase [EC:1.17.4.1] [RN:R02024] K10807 M00053 Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP 0,2 C00705 dCDP C00112 CDP
+ribonucleoside-diphosphate reductase [EC:1.17.4.1] [RN:R02024] K10808 M00053 Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP 0,2 C00705 dCDP C00112 CDP
+nucleoside-diphosphate kinase [EC:2.7.4.6] [RN:R02326 R02093] K00940 M00053 Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP 1,0 C00459 dTTP C00363 dTDP
+nucleoside-diphosphate kinase [EC:2.7.4.6] [RN:R02326 R02093] K18533 M00053 Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP 1,1 C00459 dTTP C00363 dTDP
+ribonucleoside-triphosphate reductase [EC:1.17.4.2 1.1.98.6] [RN:R02022 R11636] K00527 M00053 Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP 2,0 C00458 dCTP C00063 CTP
+ribonucleoside-triphosphate reductase [EC:1.17.4.2 1.1.98.6] [RN:R02022 R11636] K21636 M00053 Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP 2,1 C00458 dCTP C00063 CTP
+dCTP deaminase [EC:3.5.4.13] [RN:R02325] K01494 M00053 Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP 3,0 C00460 dUTP C00458 dCTP
+dUTP pyrophosphatase [EC:3.6.1.23] [RN:R02100] K01520 M00053 Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP 4,0 C00365 dUMP C00460 dUTP
+thymidylate synthase [EC:2.1.1.45] [RN:R02101] K00560 M00053 Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP 5,0 C00364 dTMP C00365 dUMP
+thymidylate synthase [EC:2.1.1.45] [RN:R02101] K13998 M00053 Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP 5,1 C00364 dTMP C00365 dUMP
+dTMP kinase [EC:2.7.4.9] [RN:R02094] K00943 M00053 Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP 6,0 C00363 dTDP C00364 dTMP
+nucleoside-diphosphate kinase [EC:2.7.4.6] [RN:R02326 R02093] K00940 M00053 Pyrimidine deoxyribonuleotide biosynthesis, CDP/CTP => dCDP/dCTP,dTDP/dTTP 7,0 C00459 dTTP C00363 dTDP
+ALG7 [EC:2.7.8.15] [RN:R05969] K01001 M00055 N-glycan precursor biosynthesis 0,0 G00001 (GlcNAc)1 (PP-Dol)1 C00110 Dolichyl phosphate
+ALG13+ALG14 [EC:2.4.1.141] [RN:R05970] K07432 M00055 N-glycan precursor biosynthesis 1,0 G00002 (GlcNAc)2 (PP-Dol)1 G00001 (GlcNAc)1 (PP-Dol)1
+ALG13+ALG14 [EC:2.4.1.141] [RN:R05970] K07441 M00055 N-glycan precursor biosynthesis 1,0 G00002 (GlcNAc)2 (PP-Dol)1 G00001 (GlcNAc)1 (PP-Dol)1
+ALG1 [EC:2.4.1.142] [RN:R05972] K03842 M00055 N-glycan precursor biosynthesis 2,0 G00003 (GlcNAc)2 (Man)1 (PP-Dol)1 G00002 (GlcNAc)2 (PP-Dol)1
+ALG2 [EC:2.4.1.132 2.4.1.257] [RN:R05973 R06238] K03843 M00055 N-glycan precursor biosynthesis 3,0 G00005 (GlcNAc)2 (Man)3 (PP-Dol)1 G00004 (GlcNAc)2 (Man)2 (PP-Dol)1
+ALG11 [EC:2.4.1.131] [RN:R06127 R06128] K03844 M00055 N-glycan precursor biosynthesis 4,0 G00006 (GlcNAc)2 (Man)5 (PP-Dol)1 G10526 (GlcNAc)2 (Man)4 (PP-Dol)1
+ALG3 [EC:2.4.1.130] [RN:R06258] K03845 M00055 N-glycan precursor biosynthesis 5,0 G10595 (GlcNAc)2 (Man)6 (PP-Dol)1 G00006 (GlcNAc)2 (Man)5 (PP-Dol)1
+ALG9 [EC:2.4.1.261] [RN:R06261] K03846 M00055 N-glycan precursor biosynthesis 6,0 G00007 (GlcNAc)2 (Man)9 (PP-Dol)1 G10597 (GlcNAc)2 (Man)8 (PP-Dol)1
+ALG12 [EC:2.4.1.130] [RN:R06260] K03847 M00055 N-glycan precursor biosynthesis 7,0 G10597 (GlcNAc)2 (Man)8 (PP-Dol)1 G10596 (GlcNAc)2 (Man)7 (PP-Dol)1
+ALG9 [EC:2.4.1.261] [RN:R06261] K03846 M00055 N-glycan precursor biosynthesis 8,0 G00007 (GlcNAc)2 (Man)9 (PP-Dol)1 G10597 (GlcNAc)2 (Man)8 (PP-Dol)1
+ALG5 [EC:2.4.1.117] [RN:R01005] K00729 M00055 N-glycan precursor biosynthesis 9,0 C01246 (Glc)1 (P-Dol)1 C00110 Dolichyl phosphate
+ALG6 [EC:2.4.1.267] [RN:R06262] K03848 M00055 N-glycan precursor biosynthesis 10,0 G10598 (Glc)1 (GlcNAc)2 (Man)9 (PP-Dol)1 C01246,G00007 (Glc)1 (P-Dol)1,(GlcNAc)2 (Man)9 (PP-Dol)1
+ALG8 [EC:2.4.1.265] [RN:R06263] K03849 M00055 N-glycan precursor biosynthesis 11,0 G10599 (Glc)2 (GlcNAc)2 (Man)9 (PP-Dol)1 G10598 (Glc)1 (GlcNAc)2 (Man)9 (PP-Dol)1
+ALG10 [EC:2.4.1.256] [RN:R06264] K03850 M00055 N-glycan precursor biosynthesis 12,0 G00008 (Glc)3 (GlcNAc)2 (Man)9 (PP-Dol)1 G10599 (Glc)2 (GlcNAc)2 (Man)9 (PP-Dol)1
+GALNT [EC:2.4.1.41] [RN:R05907] K00710 M00056 O-glycan biosynthesis, mucin type core 0,0 G00023 Tn antigen; (GalNAc)1 (Ser/Thr)1 C02189,G10611 Protein serine,UDP-N-acetyl-D-galactosamine; (UDP-GalNAc)1
+C1GALT1,C1GALT2 [EC:2.4.1.122 2.4.1.-] [RN:R05908] K00731 M00056 O-glycan biosynthesis, mucin type core 1,0 G00024 T antigen; (Gal)1 (GalNAc)1 (Ser/Thr)1 G00023 Tn antigen; (GalNAc)1 (Ser/Thr)1
+C1GALT1,C1GALT2 [EC:2.4.1.122 2.4.1.-] [RN:R05908] K09653 M00056 O-glycan biosynthesis, mucin type core 1,1 G00024 T antigen; (Gal)1 (GalNAc)1 (Ser/Thr)1 G00023 Tn antigen; (GalNAc)1 (Ser/Thr)1
+GCNT1,GCNT3,GCNT4 [EC:2.4.1.102 2.4.1.-] [RN:R05912 R05915 R05910] K00727 M00056 O-glycan biosynthesis, mucin type core 2,0 G00031 (GalNAc)1 (GlcNAc)1 (Ser/Thr)1 G00023 Tn antigen; (GalNAc)1 (Ser/Thr)1
+GCNT1,GCNT3,GCNT4 [EC:2.4.1.102 2.4.1.-] [RN:R05912 R05915 R05910] K09662 M00056 O-glycan biosynthesis, mucin type core 2,1 G00031 (GalNAc)1 (GlcNAc)1 (Ser/Thr)1 G00023 Tn antigen; (GalNAc)1 (Ser/Thr)1
+GCNT1,GCNT3,GCNT4 [EC:2.4.1.102 2.4.1.-] [RN:R05912 R05915 R05910] K09663 M00056 O-glycan biosynthesis, mucin type core 2,2 G00031 (GalNAc)1 (GlcNAc)1 (Ser/Thr)1 G00023 Tn antigen; (GalNAc)1 (Ser/Thr)1
+B3GNT6 [EC:2.4.1.147] [RN:R05909] K00739 M00056 O-glycan biosynthesis, mucin type core 3,0 G00028 (GalNAc)1 (GlcNAc)1 (Ser/Thr)1 G00023 Tn antigen; (GalNAc)1 (Ser/Thr)1
+protein xylosyltransferase [EC:2.4.2.26] [RN:R05925] K00771 M00057 Glycosaminoglycan biosynthesis, linkage tetrasaccharide 0,0 G00154 (Xyl)1 (Ser)1 C02189 Protein serine
+xylosylprotein 4-beta-galactosyltransferase [EC:2.4.1.133] [RN:R05926] K00733 M00057 Glycosaminoglycan biosynthesis, linkage tetrasaccharide 1,0 G00155 (Gal)1 (Xyl)1 (Ser)1 G00154 (Xyl)1 (Ser)1
+galactosylxylosylprotein 3-beta-galactosyltransferase [EC:2.4.1.134] [RN:R05927] K00734 M00057 Glycosaminoglycan biosynthesis, linkage tetrasaccharide 2,0 G00156 (Gal)2 (Xyl)1 (Ser)1 G00155 (Gal)1 (Xyl)1 (Ser)1
+galactosylgalactosylxylosylprotein 3-beta-glucuronosyltransferase [EC:2.4.1.135] [RN:R05928] K10158 M00057 Glycosaminoglycan biosynthesis, linkage tetrasaccharide 3,0 G00157 (Gal)2 (GlcA)1 (Xyl)1 (Ser)1 G00156 (Gal)2 (Xyl)1 (Ser)1
+N-acetylgalactosaminyltransferase I [EC:2.4.1.174] [RN:R05929] K00746 M00058 Glycosaminoglycan biosynthesis, chondroitin sulfate backbone 0,0 G00158 (Gal)2 (GalNAc)1 (GlcA)1 (Xyl)1 (Ser)1 G00157 (Gal)2 (GlcA)1 (Xyl)1 (Ser)1
+chondroitin synthase [EC:2.4.1.175 2.4.1.226] [RN:R05931 R05932] K13499 M00058 Glycosaminoglycan biosynthesis, chondroitin sulfate backbone 1,0 G00160 (Gal)2 (GalNAc)2 (GlcA)2 (Xyl)1 (Ser)1 G00159 (Gal)2 (GalNAc)1 (GlcA)2 (Xyl)1 (Ser)1
+chondroitin synthase [EC:2.4.1.175 2.4.1.226] [RN:R05931 R05932] K00747 M00058 Glycosaminoglycan biosynthesis, chondroitin sulfate backbone 1,1 G00160 (Gal)2 (GalNAc)2 (GlcA)2 (Xyl)1 (Ser)1 G00159 (Gal)2 (GalNAc)1 (GlcA)2 (Xyl)1 (Ser)1
+N-acetylgalactosaminyl-proteoglycan 3-beta-glucuronosyltransferase [EC:2.4.1.226] [RN:R05931] K03419 M00058 Glycosaminoglycan biosynthesis, chondroitin sulfate backbone 1,2 G00159 (Gal)2 (GalNAc)1 (GlcA)2 (Xyl)1 (Ser)1 G00158 (Gal)2 (GalNAc)1 (GlcA)1 (Xyl)1 (Ser)1
+alpha-1,4-N-acetylglucosaminyltransferase [EC:2.4.1.223] [RN:R05930] K02369 M00059 Glycosaminoglycan biosynthesis, heparan sulfate backbone 0,0 G00162 (Gal)2 (GlcA)1 (GlcNAc)1 (Xyl)1 (Ser)1 G00157 (Gal)2 (GlcA)1 (Xyl)1 (Ser)1
+alpha-1,4-N-acetylglucosaminyltransferase [EC:2.4.1.223] [RN:R05930] K02370 M00059 Glycosaminoglycan biosynthesis, heparan sulfate backbone 0,1 G00162 (Gal)2 (GlcA)1 (GlcNAc)1 (Xyl)1 (Ser)1 G00157 (Gal)2 (GlcA)1 (Xyl)1 (Ser)1
+glucuronyltransferase [EC:2.4.1.225] [RN:R05935] K02366 M00059 Glycosaminoglycan biosynthesis, heparan sulfate backbone 1,0 G00163 (Gal)2 (GlcA)2 (GlcNAc)1 (Xyl)1 (Ser)1 G00162 (Gal)2 (GlcA)1 (GlcNAc)1 (Xyl)1 (Ser)1
+glucuronyltransferase [EC:2.4.1.225] [RN:R05935] K02367 M00059 Glycosaminoglycan biosynthesis, heparan sulfate backbone 1,1 G00163 (Gal)2 (GlcA)2 (GlcNAc)1 (Xyl)1 (Ser)1 G00162 (Gal)2 (GlcA)1 (GlcNAc)1 (Xyl)1 (Ser)1
+alpha-1,4-N-acetylglucosaminyltransferase [EC:2.4.1.224] [RN:R05936] K02368 M00059 Glycosaminoglycan biosynthesis, heparan sulfate backbone 2,0 G00164 (Gal)2 (GlcA)2 (GlcNAc)2 (Xyl)1 (Ser)1 G00163 (Gal)2 (GlcA)2 (GlcNAc)1 (Xyl)1 (Ser)1
+alpha-1,4-N-acetylglucosaminyltransferase [EC:2.4.1.223] [RN:R05930] K02370 M00059 Glycosaminoglycan biosynthesis, heparan sulfate backbone 2,1 G00162 (Gal)2 (GlcA)1 (GlcNAc)1 (Xyl)1 (Ser)1 G00157 (Gal)2 (GlcA)1 (Xyl)1 (Ser)1
+heparan sulfate N-deacetylase/N-sulfotransferase NDST [EC:3.1.1.- 2.8.2.-] K02576 M00059 Glycosaminoglycan biosynthesis, heparan sulfate backbone 3,0
+heparan sulfate N-deacetylase/N-sulfotransferase NDST [EC:3.1.1.- 2.8.2.-] K02577 M00059 Glycosaminoglycan biosynthesis, heparan sulfate backbone 3,1
+heparan sulfate N-deacetylase/N-sulfotransferase NDST [EC:3.1.1.- 2.8.2.-] K02578 M00059 Glycosaminoglycan biosynthesis, heparan sulfate backbone 3,2
+heparan sulfate N-deacetylase/N-sulfotransferase NDST [EC:3.1.1.- 2.8.2.-] K02579 M00059 Glycosaminoglycan biosynthesis, heparan sulfate backbone 3,3
+heparosan-N-sulfate-glucuronate 5-epimerase [EC:5.1.3.17] K01793 M00059 Glycosaminoglycan biosynthesis, heparan sulfate backbone 4,0
+lpxA; UDP-N-acetylglucosamine acyltransferase [EC:2.3.1.129] [RN:R04567] K00677 M00060 KDO2-lipid A biosynthesis, Raetz pathway, LpxL-LpxM type 0,0 C04738 UDP-3-O-(3-hydroxytetradecanoyl)-N-acetylglucosamine C00043 UDP-N-acetyl-D-glucosamine
+lpxC; UDP-3-O-[3-hydroxymyristoyl] N-acetylglucosamine deacetylase [EC:3.5.1.108] [RN:R04587] K02535 M00060 KDO2-lipid A biosynthesis, Raetz pathway, LpxL-LpxM type 1,0 C06022 UDP-3-O-(3-hydroxytetradecanoyl)-D-glucosamine C04738 UDP-3-O-(3-hydroxytetradecanoyl)-N-acetylglucosamine
+lpxD; UDP-3-O-[3-hydroxymyristoyl] glucosamine N-acyltransferase [EC:2.3.1.191] [RN:R04550] K02536 M00060 KDO2-lipid A biosynthesis, Raetz pathway, LpxL-LpxM type 2,0 C04652 UDP-2,3-bis(3-hydroxytetradecanoyl)glucosamine C06022 UDP-3-O-(3-hydroxytetradecanoyl)-D-glucosamine
+lpxH; UDP-2,3-diacylglucosamine hydrolase [EC:3.6.1.54] [RN:R04549] K03269 M00060 KDO2-lipid A biosynthesis, Raetz pathway, LpxL-LpxM type 3,0 C04824 2,3-Bis(3-hydroxytetradecanoyl)-beta-D-glucosaminyl 1-phosphate C04652 UDP-2,3-bis(3-hydroxytetradecanoyl)glucosamine
+lpxB; lipid-A-disaccharide synthase [EC:2.4.1.182] [RN:R04606] K00748 M00060 KDO2-lipid A biosynthesis, Raetz pathway, LpxL-LpxM type 4,0 C04932 2,3,2',3'-Tetrakis(3-hydroxytetradecanoyl)-D-glucosaminyl-1,6-beta-D-glucosamine 1-phosphate C04652,C04824 UDP-2,3-bis(3-hydroxytetradecanoyl)glucosamine,2,3-Bis(3-hydroxytetradecanoyl)-beta-D-glucosaminyl 1-phosphate
+lpxK; tetraacyldisaccharide 4'-kinase [EC:2.7.1.130] [RN:R04657] K00912 M00060 KDO2-lipid A biosynthesis, Raetz pathway, LpxL-LpxM type 5,0 C04919 2,3,2'3'-Tetrakis(3-hydroxytetradecanoyl)-D-glucosaminyl-1,6-beta-D-glucosamine 1,4'-bisphosphate C04932 2,3,2',3'-Tetrakis(3-hydroxytetradecanoyl)-D-glucosaminyl-1,6-beta-D-glucosamine 1-phosphate
+kdtA, waaA; 3-deoxy-D-manno-octulosonic-acid transferase [EC:2.4.99.12 2.4.99.13] [RN:R04658] K02527 M00060 KDO2-lipid A biosynthesis, Raetz pathway, LpxL-LpxM type 6,0 C06024 3-Deoxy-D-manno-octulosonyl-lipid IV(A) C04919 2,3,2'3'-Tetrakis(3-hydroxytetradecanoyl)-D-glucosaminyl-1,6-beta-D-glucosamine 1,4'-bisphosphate
+lpxL, htrB; Kdo2-lipid IVA lauroyltransferase [EC:2.3.1.241] [RN:R05146] K02517 M00060 KDO2-lipid A biosynthesis, Raetz pathway, LpxL-LpxM type 7,0 C06251 Lauroyl-KDO2-lipid IV(A) C06025 Di[3-deoxy-D-manno-octulosonyl]-lipid IV(A)
+lpxM, msbB; lauroyl-Kdo2-lipid IVA myristoyltransferase [EC:2.3.1.243] [RN:R05075] K02560 M00060 KDO2-lipid A biosynthesis, Raetz pathway, LpxL-LpxM type 8,0 C06026 Di[3-deoxy-D-manno-octulosonyl]-lipid A C06251 Lauroyl-KDO2-lipid IV(A)
+glucuronate isomerase [EC:5.3.1.12] [RN:R01482] K01812 M00061 D-Glucuronate degradation, D-glucuronate => pyruvate + D-glyceraldehyde 3P 0,0 C00905 D-Fructuronate C00191 D-Glucuronate
+fructuronate reductase [EC:1.1.1.57] [RN:R02454] K00040 M00061 D-Glucuronate degradation, D-glucuronate => pyruvate + D-glyceraldehyde 3P 1,0 C00514 D-Mannonate C00905 D-Fructuronate
+mannonate dehydratase [EC:4.2.1.8] [RN:R05606] K01686 M00061 D-Glucuronate degradation, D-glucuronate => pyruvate + D-glyceraldehyde 3P 2,0 C00204 2-Dehydro-3-deoxy-D-gluconate C00514 D-Mannonate
+mannonate dehydratase [EC:4.2.1.8] [RN:R05606] K08323 M00061 D-Glucuronate degradation, D-glucuronate => pyruvate + D-glyceraldehyde 3P 2,1 C00204 2-Dehydro-3-deoxy-D-gluconate C00514 D-Mannonate
+2-dehydro-3-deoxygluconokinase [EC:2.7.1.45] [RN:R01541] K00874 M00061 D-Glucuronate degradation, D-glucuronate => pyruvate + D-glyceraldehyde 3P 3,0 C04442 2-Dehydro-3-deoxy-6-phospho-D-gluconate C00204 2-Dehydro-3-deoxy-D-gluconate
+2-dehydro-3-deoxy-phosphogluconate aldolase [EC:4.1.2.14] [RN:R05605] K01625 M00061 D-Glucuronate degradation, D-glucuronate => pyruvate + D-glyceraldehyde 3P 4,0 C00022,C00118 Pyruvate,D-Glyceraldehyde 3-phosphate C04442 2-Dehydro-3-deoxy-6-phospho-D-gluconate
+2-dehydro-3-deoxy-phosphogluconate aldolase [EC:4.1.2.14] [RN:R05605] K17463 M00061 D-Glucuronate degradation, D-glucuronate => pyruvate + D-glyceraldehyde 3P 4,1 C00022,C00118 Pyruvate,D-Glyceraldehyde 3-phosphate C04442 2-Dehydro-3-deoxy-6-phospho-D-gluconate
+arabinose-5-phosphate isomerase [EC:5.3.1.13] [RN:R01530] K06041 M00063 CMP-KDO biosynthesis 0,0 C01112 D-Arabinose 5-phosphate C00199 D-Ribulose 5-phosphate
+2-dehydro-3-deoxyphosphooctonate aldolase (KDO 8-P synthase) [EC:2.5.1.55] [RN:R03254] K01627 M00063 CMP-KDO biosynthesis 1,0 C04478 3-Deoxy-D-manno-octulosonate 8-phosphate C01112 D-Arabinose 5-phosphate
+3-deoxy-D-manno-octulosonate 8-phosphate phosphatase (KDO 8-P phosphatase) [EC:3.1.3.45] [RN:R03350] K03270 M00063 CMP-KDO biosynthesis 2,0 C01187 3-Deoxy-D-manno-octulosonate C04478 3-Deoxy-D-manno-octulosonate 8-phosphate
+3-deoxy-manno-octulosonate cytidylyltransferase (CMP-KDO synthetase) [EC:2.7.7.38] [RN:R03351] K00979 M00063 CMP-KDO biosynthesis 3,0 C04121 CMP-3-deoxy-D-manno-octulosonate C01187 3-Deoxy-D-manno-octulosonate
+D-sedoheptulose 7-phosphate isomerase [EC:5.3.1.28] [RN:R05645] K03271 M00064 ADP-L-glycero-D-manno-heptose biosynthesis 0,0 C07836 D-glycero-D-manno-Heptose 7-phosphate C05382 Sedoheptulose 7-phosphate
+D-beta-D-heptose 7-phosphate kinase [EC:2.7.1.167] [RN:R05646] K03272 M00064 ADP-L-glycero-D-manno-heptose biosynthesis 1,0 C11472 D-glycero-D-manno-Heptose 1,7-bisphosphate C07836 D-glycero-D-manno-Heptose 7-phosphate
+D-beta-D-heptose 7-phosphate kinase [EC:2.7.1.167] [RN:R05646] K21344 M00064 ADP-L-glycero-D-manno-heptose biosynthesis 1,1 C11472 D-glycero-D-manno-Heptose 1,7-bisphosphate C07836 D-glycero-D-manno-Heptose 7-phosphate
+D-glycero-D-manno-heptose 1,7-bisphosphate phosphatase [EC:3.1.3.82] [RN:R05647] K03273 M00064 ADP-L-glycero-D-manno-heptose biosynthesis 2,0 C07838 D-glycero-D-manno-Heptose 1-phosphate C11472 D-glycero-D-manno-Heptose 1,7-bisphosphate
+D-beta-D-heptose 7-phosphate kinase [EC:2.7.1.167] [RN:R05646] K03272 M00064 ADP-L-glycero-D-manno-heptose biosynthesis 3,0 C11472 D-glycero-D-manno-Heptose 1,7-bisphosphate C07836 D-glycero-D-manno-Heptose 7-phosphate
+D-beta-D-heptose 1-phosphate adenosyltransferase [EC:2.7.7.70] [RN:R05644] K21345 M00064 ADP-L-glycero-D-manno-heptose biosynthesis 3,1 C06397 ADP-D-glycero-D-manno-heptose C07838 D-glycero-D-manno-Heptose 1-phosphate
+ADP-L-glycero-D-manno-heptose 6-epimerase [EC:5.1.3.20] [RN:R05176] K03274 M00064 ADP-L-glycero-D-manno-heptose biosynthesis 4,0 C06398 ADP-L-glycero-D-manno-heptose C06397 ADP-D-glycero-D-manno-heptose
+PIGA [EC:2.4.1.198] [RN:R05916] K03857 M00065 GPI-anchor biosynthesis, core oligosaccharide 0,0 G00143 (GlcNAc)1 (Ino-P)1 C01194 1-Phosphatidyl-D-myo-inositol
+PIGC [RN:R05916] K03859 M00065 GPI-anchor biosynthesis, core oligosaccharide 0,0 G00143 (GlcNAc)1 (Ino-P)1 C01194 1-Phosphatidyl-D-myo-inositol
+PIGH [RN:R05916] K03858 M00065 GPI-anchor biosynthesis, core oligosaccharide 0,0 G00143 (GlcNAc)1 (Ino-P)1 C01194 1-Phosphatidyl-D-myo-inositol
+PIGP [RN:R05916] K03861 M00065 GPI-anchor biosynthesis, core oligosaccharide 0,0 G00143 (GlcNAc)1 (Ino-P)1 C01194 1-Phosphatidyl-D-myo-inositol
+PIGQ [RN:R05916] K03860 M00065 GPI-anchor biosynthesis, core oligosaccharide 0,0 G00143 (GlcNAc)1 (Ino-P)1 C01194 1-Phosphatidyl-D-myo-inositol
+PIGY [RN:R05916] K11001 M00065 GPI-anchor biosynthesis, core oligosaccharide 0,0 G00143 (GlcNAc)1 (Ino-P)1 C01194 1-Phosphatidyl-D-myo-inositol
+ERI1 [RN:R05916] K11002 M00065 GPI-anchor biosynthesis, core oligosaccharide 0,0 G00143 (GlcNAc)1 (Ino-P)1 C01194 1-Phosphatidyl-D-myo-inositol
+DPM2 [RN:R05916] K09658 M00065 GPI-anchor biosynthesis, core oligosaccharide 0,0 G00143 (GlcNAc)1 (Ino-P)1 C01194 1-Phosphatidyl-D-myo-inositol
+PIGL [EC:3.5.1.89] [RN:R05917] K03434 M00065 GPI-anchor biosynthesis, core oligosaccharide 1,0 G00144 (GlcN)1 (Ino-P)1 G00143 (GlcNAc)1 (Ino-P)1
+PIGW [EC:2.3.-.-] [RN:R05918] K05283 M00065 GPI-anchor biosynthesis, core oligosaccharide 2,0 G00145 (GlcN)1 (Ino(acyl)-P)1 G00144 (GlcN)1 (Ino-P)1
+PIGM [EC:2.4.1.-] [RN:R05919] K05284 M00065 GPI-anchor biosynthesis, core oligosaccharide 3,0 G00146 (GlcN)1 (Ino(acyl)-P)1 (Man)1 G00145 (GlcN)1 (Ino(acyl)-P)1
+PIGX [RN:R05919] K07541 M00065 GPI-anchor biosynthesis, core oligosaccharide 3,0 G00146 (GlcN)1 (Ino(acyl)-P)1 (Man)1 G00145 (GlcN)1 (Ino(acyl)-P)1
+PIGV [EC:2.4.1.-] [RN:R12350] K07542 M00065 GPI-anchor biosynthesis, core oligosaccharide 4,0 G13128 (GlcN)1 (Ino(acyl)-P)1 (Man)2 G00146 (GlcN)1 (Ino(acyl)-P)1 (Man)1
+PIGN [EC:2.7.-.-] [RN:R12351] K05285 M00065 GPI-anchor biosynthesis, core oligosaccharide 5,0 G00148 (GlcN)1 (Ino(acyl)-P)1 (Man)2 (EtN)1 (P)1 G13128 (GlcN)1 (Ino(acyl)-P)1 (Man)2
+PIGB [EC:2.4.1.-] [RN:R05922] K05286 M00065 GPI-anchor biosynthesis, core oligosaccharide 6,0 G00149 (GlcN)1 (Ino(acyl)-P)1 (Man)3 (EtN)1 (P)1 G00148 (GlcN)1 (Ino(acyl)-P)1 (Man)2 (EtN)1 (P)1
+PIGO [EC:2.7.-.-] [RN:R08107] K05288 M00065 GPI-anchor biosynthesis, core oligosaccharide 7,0 G13044 (GlcN)1 (Ino(acyl)-P)1 (Man)3 (EtN)2 (P)2 G00149 (GlcN)1 (Ino(acyl)-P)1 (Man)3 (EtN)1 (P)1
+PIGF [RN:R08107] K05287 M00065 GPI-anchor biosynthesis, core oligosaccharide 7,0 G13044 (GlcN)1 (Ino(acyl)-P)1 (Man)3 (EtN)2 (P)2 G00149 (GlcN)1 (Ino(acyl)-P)1 (Man)3 (EtN)1 (P)1
+ceramide glucosyltransferase [EC:2.4.1.80] [RN:R01497] K00720 M00066 Lactosylceramide biosynthesis 0,0 C01190 Glucosylceramide C00195 N-Acylsphingosine
+beta-1,4-galactosyltransferase 6 [EC:2.4.1.274] [RN:R03354] K07553 M00066 Lactosylceramide biosynthesis 1,0 C01290 beta-D-Galactosyl-1,4-beta-D-glucosylceramide C01190 Glucosylceramide
+ceramide galactosyltransferase [EC:2.4.1.47] [RN:R01500 R10804] K04628 M00067 Sulfoglycolipids biosynthesis, ceramide/1-alkyl-2-acylglycerol => sulfatide/seminolipid 0,0 C20859 Galactosyl-1-alkyl-2-acylglycerol C03201 1-Alkyl-2-acylglycerol
+galactosylceramide sulfotransferase [EC:2.8.2.11] [RN:R04017 R10805] K01019 M00067 Sulfoglycolipids biosynthesis, ceramide/1-alkyl-2-acylglycerol => sulfatide/seminolipid 1,0 C20825 Seminolipid C20859 Galactosyl-1-alkyl-2-acylglycerol
+A4GALT [EC:2.4.1.228] [RN:R05960] K01988 M00068 Glycosphingolipid biosynthesis, globo-series, LacCer => Gb4Cer 0,0 G00093 Globotriaosylceramide; Gb3Cer; (Gal)2 (Glc)1 (Cer)1 G00092 Lactosylceramide; LacCer; (Gal)1 (Glc)1 (Cer)1
+B3GALNT1 [EC:2.4.1.79] [RN:R05962] K00719 M00068 Glycosphingolipid biosynthesis, globo-series, LacCer => Gb4Cer 1,0 G00094 Globoside; Gb4Cer; (Gal)2 (GalNAc)1 (Glc)1 (Cer)1 G00093 Globotriaosylceramide; Gb3Cer; (Gal)2 (Glc)1 (Cer)1
+SIAT9 [EC:2.4.99.9] [RN:R05937] K03370 M00069 Glycosphingolipid biosynthesis, ganglio series, LacCer => GT3 0,0 G00108 GM3; (Gal)1 (Glc)1 (Neu5Ac)1 (Cer)1 G00092 Lactosylceramide; LacCer; (Gal)1 (Glc)1 (Cer)1
+SIAT8A [EC:2.4.99.8 2.4.99.-] [RN:R05940 R05947] K03371 M00069 Glycosphingolipid biosynthesis, ganglio series, LacCer => GT3 1,0 G00118 GT3; (Gal)1 (Glc)1 (Neu5Ac)3 (Cer)1 G00113 GD3; (Gal)1 (Glc)1 (Neu5Ac)2 (Cer)1
+SIAT8E [EC:2.4.99.-] [RN:R05947] K03369 M00069 Glycosphingolipid biosynthesis, ganglio series, LacCer => GT3 1,1 G00118 GT3; (Gal)1 (Glc)1 (Neu5Ac)3 (Cer)1 G00113 GD3; (Gal)1 (Glc)1 (Neu5Ac)2 (Cer)1
+B3GNT5 [EC:2.4.1.206] [RN:R05971] K03766 M00070 Glycosphingolipid biosynthesis, lacto-series, LacCer => Lc4Cer 0,0 G00036 Lc3Cer; (Gal)1 (Glc)1 (GlcNAc)1 (Cer)1 G00092 Lactosylceramide; LacCer; (Gal)1 (Glc)1 (Cer)1
+B3GALT1,B3GALT2,B3GALT5 [EC:2.4.1.86 2.4.1.-] [RN:R06006] K07819 M00070 Glycosphingolipid biosynthesis, lacto-series, LacCer => Lc4Cer 1,0 G00037 Lc4Cer; (Gal)2 (Glc)1 (GlcNAc)1 (Cer)1 G00036 Lc3Cer; (Gal)1 (Glc)1 (GlcNAc)1 (Cer)1
+B3GALT1,B3GALT2,B3GALT5 [EC:2.4.1.86 2.4.1.-] [RN:R06006] K07820 M00070 Glycosphingolipid biosynthesis, lacto-series, LacCer => Lc4Cer 1,1 G00037 Lc4Cer; (Gal)2 (Glc)1 (GlcNAc)1 (Cer)1 G00036 Lc3Cer; (Gal)1 (Glc)1 (GlcNAc)1 (Cer)1
+B3GALT1,B3GALT2,B3GALT5 [EC:2.4.1.86 2.4.1.-] [RN:R06006] K03877 M00070 Glycosphingolipid biosynthesis, lacto-series, LacCer => Lc4Cer 1,2 G00037 Lc4Cer; (Gal)2 (Glc)1 (GlcNAc)1 (Cer)1 G00036 Lc3Cer; (Gal)1 (Glc)1 (GlcNAc)1 (Cer)1
+B3GNT5 [EC:2.4.1.206] [RN:R05971] K03766 M00071 Glycosphingolipid biosynthesis, neolacto-series, LacCer => nLc4Cer 0,0 G00036 Lc3Cer; (Gal)1 (Glc)1 (GlcNAc)1 (Cer)1 G00092 Lactosylceramide; LacCer; (Gal)1 (Glc)1 (Cer)1
+B4GALT1,B4GALT2,B4GALT3,B4GALT4 [EC:2.4.1.275 2.4.1.-] [RN:R05977] K07966 M00071 Glycosphingolipid biosynthesis, neolacto-series, LacCer => nLc4Cer 1,0 G00050 nLc4Cer; (Gal)2 (Glc)1 (GlcNAc)1 (Cer)1 G00036 Lc3Cer; (Gal)1 (Glc)1 (GlcNAc)1 (Cer)1
+B4GALT1,B4GALT2,B4GALT3,B4GALT4 [EC:2.4.1.275 2.4.1.-] [RN:R05977] K07967 M00071 Glycosphingolipid biosynthesis, neolacto-series, LacCer => nLc4Cer 1,1 G00050 nLc4Cer; (Gal)2 (Glc)1 (GlcNAc)1 (Cer)1 G00036 Lc3Cer; (Gal)1 (Glc)1 (GlcNAc)1 (Cer)1
+B4GALT1,B4GALT2,B4GALT3,B4GALT4 [EC:2.4.1.275 2.4.1.-] [RN:R05977] K07968 M00071 Glycosphingolipid biosynthesis, neolacto-series, LacCer => nLc4Cer 1,2 G00050 nLc4Cer; (Gal)2 (Glc)1 (GlcNAc)1 (Cer)1 G00036 Lc3Cer; (Gal)1 (Glc)1 (GlcNAc)1 (Cer)1
+B4GALT1,B4GALT2,B4GALT3,B4GALT4 [EC:2.4.1.275 2.4.1.-] [RN:R05977] K07969 M00071 Glycosphingolipid biosynthesis, neolacto-series, LacCer => nLc4Cer 1,3 G00050 nLc4Cer; (Gal)2 (Glc)1 (GlcNAc)1 (Cer)1 G00036 Lc3Cer; (Gal)1 (Glc)1 (GlcNAc)1 (Cer)1
+STT3; dolichyl-diphosphooligosaccharide--protein glycosyltransferase [EC:2.4.99.18] [RN:R05976] K07151 M00072 N-glycosylation by oligosaccharyltransferase 0,0 C00621,G00009 Dolichyl diphosphate, G00008,C03021 ,Protein asparagine
+OST1; oligosaccharyltransferase complex subunit alpha (ribophorin I) K12666 M00072 N-glycosylation by oligosaccharyltransferase 0,0 C00621,G00009 Dolichyl diphosphate, G00008,C03021 ,Protein asparagine
+SWP1; oligosaccharyltransferase complex subunit delta (ribophorin II) K12667 M00072 N-glycosylation by oligosaccharyltransferase 0,0 C00621,G00009 Dolichyl diphosphate, G00008,C03021 ,Protein asparagine
+OST2; oligosaccharyltransferase complex subunit epsilon K12668 M00072 N-glycosylation by oligosaccharyltransferase 0,0 C00621,G00009 Dolichyl diphosphate, G00008,C03021 ,Protein asparagine
+OST3; oligosaccharyltransferase complex subunit gamma K12669 M00072 N-glycosylation by oligosaccharyltransferase 0,0 C00621,G00009 Dolichyl diphosphate, G00008,C03021 ,Protein asparagine
+WBP1; oligosaccharyltransferase complex subunit beta K12670 M00072 N-glycosylation by oligosaccharyltransferase 0,0 C00621,G00009 Dolichyl diphosphate, G00008,C03021 ,Protein asparagine
+OST4; oligosaccharyl transferase complex subunit OST4 K00730 M00072 N-glycosylation by oligosaccharyltransferase 0,0 C00621,G00009 Dolichyl diphosphate, G00008,C03021 ,Protein asparagine
+OST5; oligosaccharyl transferase complex subunit OST5 K12691 M00072 N-glycosylation by oligosaccharyltransferase 0,0 C00621,G00009 Dolichyl diphosphate, G00008,C03021 ,Protein asparagine
+mannosyl-oligosaccharide glucosidase [EC:3.2.1.106] [RN:R05979] K01228 M00073 N-glycan precursor trimming 0,0 G00171 G00009
+alpha 1,3-glucosidase [EC:3.2.1.84] [RN:R05980 R05981] K05546 M00073 N-glycan precursor trimming 1,0 G00011 G00010
+mannosyl-oligosaccharide alpha-1,2-mannosidase [EC:3.2.1.113] [RN:R05982] K01230 M00073 N-glycan precursor trimming 2,0 G00012 G00011
+alpha 1,3-glucosidase [EC:3.2.1.84] [RN:R05980 R05981] K05546 M00074 N-glycan biosynthesis, high-mannose type 0,0 G00011 G00010
+mannosyl-oligosaccharide alpha-1,2-mannosidase [EC:3.2.1.113] [RN:R05982 R06722] K01230 M00074 N-glycan biosynthesis, high-mannose type 1,0 G10694 G00011
+alpha 1,6-mannosyltransferase [EC:2.4.1.232] [RN:R08599] K05528 M00074 N-glycan biosynthesis, high-mannose type 2,0 G01813 G10694
+mannan polymerase I complexes [EC:2.4.1.232] K05529 M00074 N-glycan biosynthesis, high-mannose type 3,0
+mannan polymerase I complexes [EC:2.4.1.232] K05530 M00074 N-glycan biosynthesis, high-mannose type 3,0
+mannan polymerase I complexes [EC:2.4.1.232] K05529 M00074 N-glycan biosynthesis, high-mannose type 4,0
+mannan polymerase II complex [EC:2.4.1.232] K05531 M00074 N-glycan biosynthesis, high-mannose type 4,0
+mannan polymerase II complex [EC:2.4.1.232] K05532 M00074 N-glycan biosynthesis, high-mannose type 4,0
+mannan polymerase II complex [EC:2.4.1.232] K05533 M00074 N-glycan biosynthesis, high-mannose type 4,0
+mannan polymerase II complex [EC:2.4.1.232] K05534 M00074 N-glycan biosynthesis, high-mannose type 4,0
+alpha 1,2-mannosyltransferase [EC:2.4.1.-] K05535 M00074 N-glycan biosynthesis, high-mannose type 5,0
+glycoprotein 6-alpha-L-fucosyltransferase [EC:2.4.1.68] [RN:R05988] K00717 M00075 N-glycan biosynthesis, complex type 0,0 G00016 G00015
+beta-1,4-galactosyltransferase [EC:2.4.1.38] [RN:R05989] K07966 M00075 N-glycan biosynthesis, complex type 1,0 G00017 G00016
+beta-1,4-galactosyltransferase [EC:2.4.1.38] [RN:R05989] K07967 M00075 N-glycan biosynthesis, complex type 1,1 G00017 G00016
+beta-1,4-galactosyltransferase [EC:2.4.1.38] [RN:R05989] K07968 M00075 N-glycan biosynthesis, complex type 1,2 G00017 G00016
+beta-galactoside alpha-2,6-sialyltransferase [EC:2.4.99.1] [RN:R05990] K00778 M00075 N-glycan biosynthesis, complex type 2,0 G00018 G00017
+beta-galactoside alpha-2,6-sialyltransferase [EC:2.4.99.1] [RN:R05990] K00779 M00075 N-glycan biosynthesis, complex type 2,1 G00018 G00017
+iduronate 2-sulfatase [EC:3.1.6.13] [RN:R07821] K01136 M00076 Dermatan sulfate degradation 1,0 G13042 G13041
+L-iduronidase [EC:3.2.1.76] [RN:R07822] K01217 M00076 Dermatan sulfate degradation 2,0 G12336 G13042
+arylsulfatase B [EC:3.1.6.12] [RN:R07823] K01135 M00076 Dermatan sulfate degradation 3,0 G13043 G12336
+hyaluronoglucosaminidase [EC:3.2.1.35] [RN:R07824] K01197 M00076 Dermatan sulfate degradation 4,0 G00872 DWA-2 G13043
+beta-glucuronidase [EC:3.2.1.31] K01195 M00076 Dermatan sulfate degradation 5,0
+arylsulfatase B [EC:3.1.6.12] [RN:R07823] K01135 M00077 Chondroitin sulfate degradation 0,0 G13043 G12336
+hyaluronoglucosaminidase [EC:3.2.1.35] [RN:R07824] K01197 M00077 Chondroitin sulfate degradation 1,0 G00872 DWA-2 G13043
+beta-glucuronidase [EC:3.2.1.31] K01195 M00077 Chondroitin sulfate degradation 2,0
+N-acetylgalactosamine-6-sulfatase [EC:3.1.6.4] K01132 M00077 Chondroitin sulfate degradation 3,0
+heparanase [EC:3.2.1.166 3.2.1.-] [RN:R07811] K07964 M00078 Heparan sulfate degradation 0,0 G13034 C00925 Heparan sulfate
+heparanase [EC:3.2.1.166 3.2.1.-] [RN:R07811] K07965 M00078 Heparan sulfate degradation 0,1 G13034 C00925 Heparan sulfate
+iduronate 2-sulfatase [EC:3.1.6.13] [RN:R07812] K01136 M00078 Heparan sulfate degradation 1,0 G13035 G13034
+L-iduronidase [EC:3.2.1.76] [RN:R07813] K01217 M00078 Heparan sulfate degradation 2,0 G13036 G13035
+N-sulfoglucosamine sulfohydrolase [EC:3.10.1.1] [RN:R07814] K01565 M00078 Heparan sulfate degradation 3,0 G13037 G13036
+heparan-alpha-glucosaminide N-acetyltransferase [EC:2.3.1.78] [RN:R07815] K10532 M00078 Heparan sulfate degradation 4,0 G13038 G13037
+alpha-N-acetylglucosaminidase [EC:3.2.1.50] [RN:R07816] K01205 M00078 Heparan sulfate degradation 5,0 G13039 G13038
+beta-glucuronidase [EC:3.2.1.31] [RN:R07818] K01195 M00078 Heparan sulfate degradation 7,0 G09660 G13040
+N-acetylglucosamine-6-sulfatase [EC:3.1.6.14] [RN:R07819] K01137 M00078 Heparan sulfate degradation 8,0 G02632 G09660
+N-acetylgalactosamine-6-sulfatase [EC:3.1.6.4] [RN:R07806] K01132 M00079 Keratan sulfate degradation 1,0 G01977 G01945
+beta-galactosidase [EC:3.2.1.23] [RN:R07807] K12309 M00079 Keratan sulfate degradation 2,0 G13073 G01977
+N-acetylglucosamine-6-sulfatase [EC:3.1.6.14] [RN:R07808] K01137 M00079 Keratan sulfate degradation 3,0 G13074 G13073
+beta-hexosaminidase [EC:3.2.1.52] [RN:R07809 R07810] K12373 M00079 Keratan sulfate degradation 4,0 G01391 G13073
+pectinesterase [EC:3.1.1.11] [RN:R02362] K01051 M00081 Pectin degradation 0,0 C00470 Pectate C00714 Pectin
+polygalacturonase [EC:3.2.1.15] [RN:R02360] K01184 M00081 Pectin degradation 1,0 C02273 Digalacturonate C00470 Pectate
+galacturan 1,4-alpha-galacturonidase [EC:3.2.1.67] [RN:R07413] K01213 M00081 Pectin degradation 2,0 C00333 D-Galacturonate C02273 Digalacturonate
+acetyl-CoA carboxylase / biotin carboxylase [EC:6.4.1.2] [RN:R00742] K11262 M00082 Fatty acid biosynthesis, initiation 0,0 C00083 Malonyl-CoA C00024 Acetyl-CoA
+acetyl-CoA carboxylase biotin carboxyl carrier protein [RN:R00742] K02160 M00082 Fatty acid biosynthesis, initiation 0,1 C00083 Malonyl-CoA C00024 Acetyl-CoA
+acetyl-CoA carboxylase, biotin carboxylase subunit [EC:6.4.1.2] [RN:R00742] K01961 M00082 Fatty acid biosynthesis, initiation 0,1 C00083 Malonyl-CoA C00024 Acetyl-CoA
+acetyl-/propionyl-CoA carboxylase, biotin carboxylase, biotin carboxyl carrier protein [EC:6.4.1.2] [RN:R00742] K11263 M00082 Fatty acid biosynthesis, initiation 0,1 C00083 Malonyl-CoA C00024 Acetyl-CoA
+acetyl-CoA carboxylase carboxyl transferase subunit [EC:6.4.1.2] [RN:R00742] K01962 M00082 Fatty acid biosynthesis, initiation 0,1 C00083 Malonyl-CoA C00024 Acetyl-CoA
+acetyl-CoA carboxylase carboxyl transferase subunit [EC:6.4.1.2] [RN:R00742] K01963 M00082 Fatty acid biosynthesis, initiation 0,1 C00083 Malonyl-CoA C00024 Acetyl-CoA
+acetyl/propionyl-CoA carboxylase carboxyl transferase subunit [EC:6.4.1.2] [RN:R00742] K18472 M00082 Fatty acid biosynthesis, initiation 0,1 C00083 Malonyl-CoA C00024 Acetyl-CoA
+fatty-acid synthase [EC:2.3.1.85] [RN:R01626 R01624 R04355] K00665 M00082 Fatty acid biosynthesis, initiation 1,0 C05744 Acetoacetyl-[acp] C03939,C01209 Acetyl-[acyl-carrier protein],Malonyl-[acyl-carrier protein]
+fatty-acyl-CoA synthase [EC:2.3.1.86] [RN:R01626 R01624 R04355] K00667 M00082 Fatty acid biosynthesis, initiation 1,1 C05744 Acetoacetyl-[acp] C03939,C01209 Acetyl-[acyl-carrier protein],Malonyl-[acyl-carrier protein]
+fatty-acyl-CoA synthase [EC:2.3.1.86] [RN:R01626 R01624 R04355] K00668 M00082 Fatty acid biosynthesis, initiation 1,1 C05744 Acetoacetyl-[acp] C03939,C01209 Acetyl-[acyl-carrier protein],Malonyl-[acyl-carrier protein]
+fatty acid synthase, bacteria type [EC:2.3.1.-] [RN:R01626 R01624 R04355] K11533 M00082 Fatty acid biosynthesis, initiation 1,2 C05744 Acetoacetyl-[acp] C03939,C01209 Acetyl-[acyl-carrier protein],Malonyl-[acyl-carrier protein]
+[acyl-carrier-protein] S-malonyltransferase [EC:2.3.1.39] [RN:R01626] K00645 M00082 Fatty acid biosynthesis, initiation 1,3,0,0 C01209 Malonyl-[acyl-carrier protein] C00083 Malonyl-CoA
+acetoacetyl-[acyl-carrier protein] synthase [EC:2.3.1.180] [RN:R10707] K00648 M00082 Fatty acid biosynthesis, initiation 1,3,1,0 C05744 Acetoacetyl-[acp] C00024,C01209 Acetyl-CoA,Malonyl-[acyl-carrier protein]
+acetoacetyl-[acyl-carrier protein] synthase [EC:2.3.1.180] [RN:R10707] K18473 M00082 Fatty acid biosynthesis, initiation 1,3,1,1 C05744 Acetoacetyl-[acp] C00024,C01209 Acetyl-CoA,Malonyl-[acyl-carrier protein]
+fatty acid synthase, animal type [EC:2.3.1.85] [RN:R04355 R04533 R04428 R04430 R04952 R04953 R04954 R04956 R04957 R04536 R04537 R04959 R04960 R04534 R04535 R04962 R04963 R04964 R04965 R04725 R04726 R04566 R04568 R04967 R04968 R04543 R04544 R04970] K00665 M00083 Fatty acid biosynthesis, elongation 0,0 C05764 Hexadecanoyl-[acp] C05763 trans-Hexadec-2-enoyl-[acp]
+fatty acid synthase, fungi type [EC:2.3.1.86] [RN:R04355 R04533 R04428 R04430 R04952 R04953 R04954 R04956 R04957 R04536 R04537 R04959 R04960 R04534 R04535 R04962 R04963 R04964 R04965 R04725 R04726 R04566 R04568 R04967 R04968 R04543 R04544 R04970] K00667 M00083 Fatty acid biosynthesis, elongation 0,1,0,0 C05764 Hexadecanoyl-[acp] C05763 trans-Hexadec-2-enoyl-[acp]
+fatty acid synthase, fungi type [EC:2.3.1.86] [RN:R04355 R04533 R04428 R04430 R04952 R04953 R04954 R04956 R04957 R04536 R04537 R04959 R04960 R04534 R04535 R04962 R04963 R04964 R04965 R04725 R04726 R04566 R04568 R04967 R04968 R04543 R04544 R04970] K00668 M00083 Fatty acid biosynthesis, elongation 0,1,1,0 C05764 Hexadecanoyl-[acp] C05763 trans-Hexadec-2-enoyl-[acp]
+fatty acid synthase, actinobacteria type [EC:2.3.1.-] [RN:R04355 R04533 R04428 R04429 R04952 R04953 R04954 R04955 R04957 R04536 R04537 R04958 R04960 R04534 R04535 R04961 R04963 R04964 R04965 R04724 R04726 R04566 R04568 R04966 R04968 R04543 R04544 R04969] K11533 M00083 Fatty acid biosynthesis, elongation 0,2 C05764 Hexadecanoyl-[acp] C05763 trans-Hexadec-2-enoyl-[acp]
+3-oxoacyl-[acyl-carrier-protein] synthase I [EC:2.3.1.41] [RN:R04355 R04952 R04957 R04960 R04963 R04726 R04968] K00647 M00083 Fatty acid biosynthesis, elongation 0,3,0,0 C05762 3-Oxohexadecanoyl-[acp] C05761,C01209 Tetradecanoyl-[acp],Malonyl-[acyl-carrier protein]
+3-oxoacyl-[acyl-carrier-protein] synthase II [EC:2.3.1.179] [RN:R04355 R04952 R04957 R04960 R04963 R04726 R04968] K09458 M00083 Fatty acid biosynthesis, elongation 0,3,0,1 C05762 3-Oxohexadecanoyl-[acp] C05761,C01209 Tetradecanoyl-[acp],Malonyl-[acyl-carrier protein]
+3-oxoacyl-[acyl-carrier protein] reductase [EC:1.1.1.100] [RN:R04533 R04953 R04536 R04534 R04964 R04566 R04543] K00059 M00083 Fatty acid biosynthesis, elongation 0,3,1,0 C04633 (3R)-3-Hydroxypalmitoyl-[acyl-carrier protein] C05762 3-Oxohexadecanoyl-[acp]
+3-hydroxyacyl-[acyl-carrier-protein] dehydratase [EC:4.2.1.59] [RN:R04428 R04954 R04537 R04535 R04965 R04568 R04544] K02372 M00083 Fatty acid biosynthesis, elongation 0,3,2,0 C05763 trans-Hexadec-2-enoyl-[acp] C04633 (3R)-3-Hydroxypalmitoyl-[acyl-carrier protein]
+3-hydroxyacyl-[acyl-carrier-protein] dehydratase [EC:4.2.1.59] [RN:R04428 R04954 R04537 R04535 R04965 R04568 R04544] K01716 M00083 Fatty acid biosynthesis, elongation 0,3,2,1 C05763 trans-Hexadec-2-enoyl-[acp] C04633 (3R)-3-Hydroxypalmitoyl-[acyl-carrier protein]
+3-hydroxyacyl-[acyl-carrier-protein] dehydratase [EC:4.2.1.59] [RN:R04428 R04954 R04537 R04535 R04965 R04568 R04544] K16363 M00083 Fatty acid biosynthesis, elongation 0,3,2,2 C05763 trans-Hexadec-2-enoyl-[acp] C04633 (3R)-3-Hydroxypalmitoyl-[acyl-carrier protein]
+enoyl-[acyl-carrier protein] reductase [EC:1.3.1.9 1.3.1.104] [RN:R04429 R04430 R04955 R04956 R04958 R04959 R04961 R04962 R04724 R04725 R04966 R04967 R04969 R04970] K00208 M00083 Fatty acid biosynthesis, elongation 0,3,3,0 C05764 Hexadecanoyl-[acp] C05763 trans-Hexadec-2-enoyl-[acp]
+enoyl-[acyl-carrier protein] reductase [EC:1.3.1.9 1.3.1.104] [RN:R04429 R04430 R04955 R04956 R04958 R04959 R04961 R04962 R04724 R04725 R04966 R04967 R04969 R04970] K02371 M00083 Fatty acid biosynthesis, elongation 0,3,3,1 C05764 Hexadecanoyl-[acp] C05763 trans-Hexadec-2-enoyl-[acp]
+enoyl-[acyl-carrier protein] reductase [EC:1.3.1.9 1.3.1.104] [RN:R04429 R04430 R04955 R04956 R04958 R04959 R04961 R04962 R04724 R04725 R04966 R04967 R04969 R04970] K10780 M00083 Fatty acid biosynthesis, elongation 0,3,3,2 C05764 Hexadecanoyl-[acp] C05763 trans-Hexadec-2-enoyl-[acp]
+enoyl-[acyl-carrier protein] reductase [EC:1.3.1.9 1.3.1.104] [RN:R04429 R04430 R04955 R04956 R04958 R04959 R04961 R04962 R04724 R04725 R04966 R04967 R04969 R04970] K00209 M00083 Fatty acid biosynthesis, elongation 0,3,3,3 C05764 Hexadecanoyl-[acp] C05763 trans-Hexadec-2-enoyl-[acp]
+acetyl-CoA acyltransferase [EC:2.3.1.16] [RN:R00391 R01177 R04747 R03778 R04742 R03858 R03991] K07508 M00085 Fatty acid elongation in mitochondria 0,0 C05259 3-Oxopalmitoyl-CoA C02593,C00024 Tetradecanoyl-CoA,Acetyl-CoA
+acetyl-CoA acyltransferase [EC:2.3.1.16] [RN:R00391 R01177 R04747 R03778 R04742 R03858 R03991] K07509 M00085 Fatty acid elongation in mitochondria 0,1 C05259 3-Oxopalmitoyl-CoA C02593,C00024 Tetradecanoyl-CoA,Acetyl-CoA
+3-hydroxyacyl-CoA dehydrogenase [EC:1.1.1.35] [RN:R01778 R04748 R04745 R04743] K00022 M00085 Fatty acid elongation in mitochondria 1,0,0,0 C05264 (S)-Hydroxydecanoyl-CoA C05265 3-Oxodecanoyl-CoA
+enoyl-CoA hydratase [EC:4.2.1.17] [RN:R02685 R04749 R04746 R04744 R04170 R04740 R04738] K07511 M00085 Fatty acid elongation in mitochondria 1,0,1,0 C05272 trans-Hexadec-2-enoyl-CoA C05258 (S)-3-Hydroxyhexadecanoyl-CoA
+enoyl-CoA hydratase / long-chain 3-hydroxyacyl-CoA dehydrogenase [EC:4.2.1.17 1.1.1.211] [RN:R02685 R01778 R04749 R04748 R04746 R04745 R04744 R04743 R04170 R04741 R04740 R04739 R04738 R04737] K07515 M00085 Fatty acid elongation in mitochondria 1,1 C05258 (S)-3-Hydroxyhexadecanoyl-CoA C05259 3-Oxopalmitoyl-CoA
+trans-2-enoyl-CoA reductase [EC:1.3.1.38] [RN:R07162 R06985 R03776 R04753 R03856 R03989 R01278] K07512 M00085 Fatty acid elongation in mitochondria 2,0 C00154 Palmitoyl-CoA C05272 trans-Hexadec-2-enoyl-CoA
+long-chain fatty-acid-CoA ligase [EC:6.2.1.3] [RN:R01280] K01897 M00086 beta-Oxidation, acyl-CoA synthesis 0,0 C00154 Palmitoyl-CoA C00249 Hexadecanoic acid
+long-chain-fatty-acid--CoA ligase ACSBG [EC:6.2.1.3] [RN:R01280] K15013 M00086 beta-Oxidation, acyl-CoA synthesis 0,1 C00154 Palmitoyl-CoA C00249 Hexadecanoic acid
+acyl-CoA oxidase [EC:1.3.3.6] [RN:R01279 R03990 R03857 R04754 R03777 R04751 R01175] K00232 M00087 beta-Oxidation 0,0 C00877 Crotonoyl-CoA C00136 Butanoyl-CoA
+acyl-CoA dehydrogenase [EC:1.3.8.7] [RN:R01279 R03990 R03857 R04754 R03777 R04751 R01175] K00249 M00087 beta-Oxidation 0,1 C00877 Crotonoyl-CoA C00136 Butanoyl-CoA
+long-chain-acyl-CoA dehydrogenase [EC:1.3.8.8] [RN:R01279 R03990 R03857 R04754 R03777 R04751 R01175] K00255 M00087 beta-Oxidation 0,2 C00877 Crotonoyl-CoA C00136 Butanoyl-CoA
+acyl-CoA dehydrogenase [EC:1.3.99.-] [RN:R01279 R03990 R03857 R04754 R03777 R04751 R01175] K06445 M00087 beta-Oxidation 0,3 C00877 Crotonoyl-CoA C00136 Butanoyl-CoA
+very long chain acyl-CoA dehydrogenase [EC:1.3.8.9] [RN:R01279 R03990 R03857 R04754 R03777 R04751 R01175] K09479 M00087 beta-Oxidation 0,4 C00877 Crotonoyl-CoA C00136 Butanoyl-CoA
+enoyl-CoA hydratase [EC:4.2.1.17] [RN:R04738 R04740 R04170 R04744 R04746 R04749 R03026] K01692 M00087 beta-Oxidation 1,0,0,0 C01144 (S)-3-Hydroxybutanoyl-CoA C00877 Crotonoyl-CoA
+enoyl-CoA hydratase [EC:4.2.1.17] [RN:R04738 R04740 R04170 R04744 R04746 R04749 R03026] K07511 M00087 beta-Oxidation 1,0,0,1 C01144 (S)-3-Hydroxybutanoyl-CoA C00877 Crotonoyl-CoA
+enoyl-CoA hydratase [EC:4.2.1.17] [RN:R04738 R04740 R04170 R04744 R04746 R04749 R03026] K13767 M00087 beta-Oxidation 1,0,0,2 C01144 (S)-3-Hydroxybutanoyl-CoA C00877 Crotonoyl-CoA
+3-hydroxyacyl-CoA dehydrogenase [EC:1.1.1.35] [RN:R04737 R04739 R04741 R04743 R04745 R04748 R01975] K00022 M00087 beta-Oxidation 1,0,1,0 C00332 Acetoacetyl-CoA C01144 (S)-3-Hydroxybutanoyl-CoA
+3-hydroxyacyl-CoA dehydrogenase [EC:1.1.1.35] [RN:R04737 R04739 R04741 R04743 R04745 R04748 R01975] K07516 M00087 beta-Oxidation 1,0,1,1 C00332 Acetoacetyl-CoA C01144 (S)-3-Hydroxybutanoyl-CoA
+3-hydroxyacyl-CoA dehydrogenase / enoyl-CoA hydratase / 3-hydroxybutyryl-CoA epimerase / enoyl-CoA isomerase [EC:1.1.1.35 4.2.1.17 5.1.2.3 5.3.3.8] [RN:R04738 R04737 R04740 R04739 R04170 R04741 R04744 R04743 R04746 R04745 R04749 R04748 R03026 R01975] K01825 M00087 beta-Oxidation 1,1 C00332 Acetoacetyl-CoA C01144 (S)-3-Hydroxybutanoyl-CoA
+3-hydroxyacyl-CoA dehydrogenase / enoyl-CoA hydratase / 3-hydroxybutyryl-CoA epimerase / enoyl-CoA isomerase [EC:1.1.1.35 4.2.1.17 5.1.2.3 5.3.3.8] [RN:R04738 R04737 R04740 R04739 R04170 R04741 R04744 R04743 R04746 R04745 R04749 R04748 R03026 R01975] K01782 M00087 beta-Oxidation 1,2 C00332 Acetoacetyl-CoA C01144 (S)-3-Hydroxybutanoyl-CoA
+enoyl-CoA hydratase / 3-hydroxyacyl-CoA dehydrogenase / 3,2-trans-enoyl-CoA isomerase [EC:4.2.1.17 1.1.1.35 5.3.3.8] [RN:R04738 R04737 R04740 R04739 R04170 R04741 R04744 R04743 R04746 R04745 R04749 R04748 R03026 R01975] K07514 M00087 beta-Oxidation 1,3 C00332 Acetoacetyl-CoA C01144 (S)-3-Hydroxybutanoyl-CoA
+enoyl-CoA hydratase / long-chain 3-hydroxyacyl-CoA dehydrogenase [EC:4.2.1.17 1.1.1.211] [RN:R04738 R04737 R04740 R04739 R04170 R04741 R04744 R04743 R04746 R04745 R04749 R04748 R03026 R01975] K07515 M00087 beta-Oxidation 1,4 C00332 Acetoacetyl-CoA C01144 (S)-3-Hydroxybutanoyl-CoA
+enoyl-CoA hydratase/3-hydroxyacyl-CoA dehydrogenase [EC:4.2.1.17 1.1.1.35 1.1.1.211] [RN:R04738 R04737 R04740 R04739 R04170 R04741 R04744 R04743 R04746 R04745 R04749 R04748 R03026 R01975] K10527 M00087 beta-Oxidation 1,5 C00332 Acetoacetyl-CoA C01144 (S)-3-Hydroxybutanoyl-CoA
+acetyl-CoA acyltransferase [EC:2.3.1.16] [RN:R03991 R03858 R04742 R03778 R04747 R01177 R00238] K00632 M00087 beta-Oxidation 2,0 C00024 Acetyl-CoA C00332 Acetoacetyl-CoA
+acetyl-CoA acyltransferase [EC:2.3.1.16] [RN:R03991 R03858 R04742 R03778 R04747 R01177 R00238] K07508 M00087 beta-Oxidation 2,1 C00024 Acetyl-CoA C00332 Acetoacetyl-CoA
+acetyl-CoA acyltransferase [EC:2.3.1.16] [RN:R03991 R03858 R04742 R03778 R04747 R01177 R00238] K07509 M00087 beta-Oxidation 2,2 C00024 Acetyl-CoA C00332 Acetoacetyl-CoA
+acetyl-CoA acyltransferase [EC:2.3.1.16] [RN:R03991 R03858 R04742 R03778 R04747 R01177 R00238] K07513 M00087 beta-Oxidation 2,3 C00024 Acetyl-CoA C00332 Acetoacetyl-CoA
+acetoacetate decarboxylase [EC:4.1.1.4] [RN:R01366] K01574 M00088 Ketone body biosynthesis, acetyl-CoA => acetoacetate/3-hydroxybutyrate/acetone 0,0 C00207 Acetone C00164 Acetoacetate
+glycerol 3-phosphate acyltransferase [EC:2.3.1.15] [RN:R00851] K00629 M00089 Triacylglycerol biosynthesis 0,0 C00681 1-Acyl-sn-glycerol 3-phosphate C00093 sn-Glycerol 3-phosphate
+glycerol 3-phosphate acyltransferase [EC:2.3.1.15] [RN:R00851] K13506 M00089 Triacylglycerol biosynthesis 0,0 C00681 1-Acyl-sn-glycerol 3-phosphate C00093 sn-Glycerol 3-phosphate
+glycerol 3-phosphate acyltransferase [EC:2.3.1.15] [RN:R00851] K13507 M00089 Triacylglycerol biosynthesis 0,0 C00681 1-Acyl-sn-glycerol 3-phosphate C00093 sn-Glycerol 3-phosphate
+glycerol 3-phosphate acyltransferase [EC:2.3.1.15] [RN:R00851] K00630 M00089 Triacylglycerol biosynthesis 0,0 C00681 1-Acyl-sn-glycerol 3-phosphate C00093 sn-Glycerol 3-phosphate
+glycerol 3-phosphate acyltransferase [EC:2.3.1.15] [RN:R00851] K13508 M00089 Triacylglycerol biosynthesis 0,0 C00681 1-Acyl-sn-glycerol 3-phosphate C00093 sn-Glycerol 3-phosphate
+glycerol 3-phosphate acyltransferase [EC:2.3.1.15] [RN:R00851] K00631 M00089 Triacylglycerol biosynthesis 0,0 C00681 1-Acyl-sn-glycerol 3-phosphate C00093 sn-Glycerol 3-phosphate
+phosphate acyltransferase [EC:2.3.1.274] [RN:R12240] K03621 M00089 Triacylglycerol biosynthesis 0,1,0,0 C02133 Acyl phosphate C00173 Acyl-[acyl-carrier protein]
+acyl phosphate:glycerol-3-phosphate acyltransferase [EC:2.3.1.275] [RN:R12241] K08591 M00089 Triacylglycerol biosynthesis 0,1,1,0 C00681 1-Acyl-sn-glycerol 3-phosphate C00093,C02133 sn-Glycerol 3-phosphate,Acyl phosphate
+1-acyl-sn-glycerol-3-phosphate acyltransferase [EC:2.3.1.51] [RN:R02241] K00655 M00089 Triacylglycerol biosynthesis 1,0 C00416 Phosphatidate C00681 1-Acyl-sn-glycerol 3-phosphate
+1-acyl-sn-glycerol-3-phosphate acyltransferase [EC:2.3.1.51] [RN:R02241] K13509 M00089 Triacylglycerol biosynthesis 1,1 C00416 Phosphatidate C00681 1-Acyl-sn-glycerol 3-phosphate
+1-acyl-sn-glycerol-3-phosphate acyltransferase [EC:2.3.1.51] [RN:R02241] K13523 M00089 Triacylglycerol biosynthesis 1,2 C00416 Phosphatidate C00681 1-Acyl-sn-glycerol 3-phosphate
+1-acyl-sn-glycerol-3-phosphate acyltransferase [EC:2.3.1.51] [RN:R02241] K19007 M00089 Triacylglycerol biosynthesis 1,3 C00416 Phosphatidate C00681 1-Acyl-sn-glycerol 3-phosphate
+1-acyl-sn-glycerol-3-phosphate acyltransferase [EC:2.3.1.51] [RN:R02241] K13513 M00089 Triacylglycerol biosynthesis 1,4 C00416 Phosphatidate C00681 1-Acyl-sn-glycerol 3-phosphate
+1-acyl-sn-glycerol-3-phosphate acyltransferase [EC:2.3.1.51] [RN:R02241] K13517 M00089 Triacylglycerol biosynthesis 1,5 C00416 Phosphatidate C00681 1-Acyl-sn-glycerol 3-phosphate
+1-acyl-sn-glycerol-3-phosphate acyltransferase [EC:2.3.1.51] [RN:R02241] K13519 M00089 Triacylglycerol biosynthesis 1,6 C00416 Phosphatidate C00681 1-Acyl-sn-glycerol 3-phosphate
+1-acyl-sn-glycerol-3-phosphate acyltransferase [EC:2.3.1.51] [RN:R02241] K14674 M00089 Triacylglycerol biosynthesis 1,7 C00416 Phosphatidate C00681 1-Acyl-sn-glycerol 3-phosphate
+1-acyl-sn-glycerol-3-phosphate acyltransferase [EC:2.3.1.51] [RN:R02241] K22831 M00089 Triacylglycerol biosynthesis 1,8 C00416 Phosphatidate C00681 1-Acyl-sn-glycerol 3-phosphate
+phosphatidate phosphatase [EC:3.1.3.4] [RN:R02239] K01080 M00089 Triacylglycerol biosynthesis 2,0 C00641 1,2-Diacyl-sn-glycerol C00416 Phosphatidate
+phosphatidate phosphatase [EC:3.1.3.4] [RN:R02239] K15728 M00089 Triacylglycerol biosynthesis 2,1 C00641 1,2-Diacyl-sn-glycerol C00416 Phosphatidate
+diacylglycerol diphosphate phosphatase / phosphatidate phosphatase [EC:3.1.3.81 3.1.3.4] [RN:R02239] K18693 M00089 Triacylglycerol biosynthesis 2,2 C00641 1,2-Diacyl-sn-glycerol C00416 Phosphatidate
+diacylglycerol O-acyltransferase [EC:2.3.1.20] [RN:R02251] K11155 M00089 Triacylglycerol biosynthesis 3,0 C00422 Triacylglycerol C00641 1,2-Diacyl-sn-glycerol
+diacylglycerol O-acyltransferase [EC:2.3.1.20] [RN:R02251] K11160 M00089 Triacylglycerol biosynthesis 3,1 C00422 Triacylglycerol C00641 1,2-Diacyl-sn-glycerol
+diacylglycerol O-acyltransferase [EC:2.3.1.20] [RN:R02251] K14456 M00089 Triacylglycerol biosynthesis 3,2 C00422 Triacylglycerol C00641 1,2-Diacyl-sn-glycerol
+diacylglycerol O-acyltransferase [EC:2.3.1.20] [RN:R02251] K22848 M00089 Triacylglycerol biosynthesis 3,3 C00422 Triacylglycerol C00641 1,2-Diacyl-sn-glycerol
+diacylglycerol O-acyltransferase [EC:2.3.1.20] [RN:R02251] K22849 M00089 Triacylglycerol biosynthesis 3,4 C00422 Triacylglycerol C00641 1,2-Diacyl-sn-glycerol
+diacylglycerol O-acyltransferase [EC:2.3.1.20] [RN:R02251] K00635 M00089 Triacylglycerol biosynthesis 3,5 C00422 Triacylglycerol C00641 1,2-Diacyl-sn-glycerol
+diacylglycerol O-acyltransferase [EC:2.3.1.20] [RN:R02251] K18851 M00089 Triacylglycerol biosynthesis 3,6 C00422 Triacylglycerol C00641 1,2-Diacyl-sn-glycerol
+choline kinase [EC:2.7.1.32] [RN:R01021] K00866 M00090 Phosphatidylcholine (PC) biosynthesis, choline => PC 0,0 C00588 Choline phosphate C00114 Choline
+choline kinase [EC:2.7.1.32] [RN:R01021] K14156 M00090 Phosphatidylcholine (PC) biosynthesis, choline => PC 0,1 C00588 Choline phosphate C00114 Choline
+choline-phosphate cytidylyltransferase [EC:2.7.7.15] [RN:R01890] K00968 M00090 Phosphatidylcholine (PC) biosynthesis, choline => PC 1,0 C00307 CDP-choline C00588 Choline phosphate
+diacylglycerol cholinephosphotransferase [EC:2.7.8.2] [RN:R01321] K00994 M00090 Phosphatidylcholine (PC) biosynthesis, choline => PC 2,0 C00157 Phosphatidylcholine C00307 CDP-choline
+diacylglycerol cholinephosphotransferase [EC:2.7.8.2] [RN:R01321] K13644 M00090 Phosphatidylcholine (PC) biosynthesis, choline => PC 2,1 C00157 Phosphatidylcholine C00307 CDP-choline
+phosphatidylethanolamine N-methyltransferase [EC:2.1.1.17] [RN:R02056] K00551 M00091 Phosphatidylcholine (PC) biosynthesis, PE => PC 0,0 C01241 Phosphatidyl-N-methylethanolamine C00350 Phosphatidylethanolamine
+phosphatidylethanolamine N-methyltransferase [EC:2.1.1.17] [RN:R02056] K16369 M00091 Phosphatidylcholine (PC) biosynthesis, PE => PC 0,1,0,0 C01241 Phosphatidyl-N-methylethanolamine C00350 Phosphatidylethanolamine
+phosphatidyl-N-methylethanolamine N-methyltransferase [EC:2.1.1.71] [RN:R03424 R01320] K00550 M00091 Phosphatidylcholine (PC) biosynthesis, PE => PC 0,1,1,0 C00157 Phosphatidylcholine C04308 Phosphatidyl-N-dimethylethanolamine
+phosphatidylethanolamine N-methyltransferase [EC:2.1.1.17] [RN:R02056] K00570 M00091 Phosphatidylcholine (PC) biosynthesis, PE => PC 0,2 C01241 Phosphatidyl-N-methylethanolamine C00350 Phosphatidylethanolamine
+ethanolamine kinase [EC:2.7.1.82] [RN:R01468] K00894 M00092 Phosphatidylethanolamine (PE) biosynthesis, ethanolamine => PE 0,0 C00346 Ethanolamine phosphate C00189 Ethanolamine
+ethanolamine kinase [EC:2.7.1.82] [RN:R01468] K14156 M00092 Phosphatidylethanolamine (PE) biosynthesis, ethanolamine => PE 0,1 C00346 Ethanolamine phosphate C00189 Ethanolamine
+ethanolamine-phosphate cytidylyltransferase [EC:2.7.7.14] [RN:R02038] K00967 M00092 Phosphatidylethanolamine (PE) biosynthesis, ethanolamine => PE 1,0 C00570 CDP-ethanolamine C00346 Ethanolamine phosphate
+ethanolaminephosphotransferase [EC:2.7.8.1] [RN:R02057] K00993 M00092 Phosphatidylethanolamine (PE) biosynthesis, ethanolamine => PE 2,0 C00350 Phosphatidylethanolamine C00570 CDP-ethanolamine
+ethanolaminephosphotransferase [EC:2.7.8.1] [RN:R02057] K13644 M00092 Phosphatidylethanolamine (PE) biosynthesis, ethanolamine => PE 2,1 C00350 Phosphatidylethanolamine C00570 CDP-ethanolamine
+phosphatidate cytidylyltransferase [EC:2.7.7.41] [RN:R01799] K00981 M00093 Phosphatidylethanolamine (PE) biosynthesis, PA => PS => PE 0,0 C00269 CDP-diacylglycerol C00416 Phosphatidate
+phosphatidylserine synthase [EC:2.7.8.8] [RN:R01800] K00998 M00093 Phosphatidylethanolamine (PE) biosynthesis, PA => PS => PE 1,0 C02737 Phosphatidylserine C00269 CDP-diacylglycerol
+phosphatidylserine synthase [EC:2.7.8.8] [RN:R01800] K17103 M00093 Phosphatidylethanolamine (PE) biosynthesis, PA => PS => PE 1,1 C02737 Phosphatidylserine C00269 CDP-diacylglycerol
+phosphatidylserine decarboxylase [EC:4.1.1.65] [RN:R02055] K01613 M00093 Phosphatidylethanolamine (PE) biosynthesis, PA => PS => PE 2,0 C00350 Phosphatidylethanolamine C02737 Phosphatidylserine
+serine palmitoyltransferase [EC:2.3.1.50] [RN:R01281] K00654 M00094 Ceramide biosynthesis 0,0 C02934 3-Dehydrosphinganine C00154,C00065 Palmitoyl-CoA,L-Serine
+3-dehydrosphinganine reductase [EC:1.1.1.102] [RN:R02978] K04708 M00094 Ceramide biosynthesis 1,0 C00836 Sphinganine C02934 3-Dehydrosphinganine
+acyl-CoA-dependent ceramide synthase [EC:2.3.1.24] [RN:R06517] K04709 M00094 Ceramide biosynthesis 2,0 C12126 Dihydroceramide C00836 Sphinganine
+acyl-CoA-dependent ceramide synthase [EC:2.3.1.24] [RN:R06517] K04710 M00094 Ceramide biosynthesis 2,1 C12126 Dihydroceramide C00836 Sphinganine
+sphingolipid 4-desaturase [EC:1.14.19.17] [RN:R06519] K04712 M00094 Ceramide biosynthesis 3,0 C00195 N-Acylsphingosine C12126 Dihydroceramide
+acetyl-CoA C-acetyltransferase [EC:2.3.1.9] [RN:R00238] K00626 M00095 C5 isoprenoid biosynthesis, mevalonate pathway 0,0 C00332 Acetoacetyl-CoA C00024 Acetyl-CoA
+hydroxymethylglutaryl-CoA synthase [EC:2.3.3.10] [RN:R01978] K01641 M00095 C5 isoprenoid biosynthesis, mevalonate pathway 1,0 C00356 (S)-3-Hydroxy-3-methylglutaryl-CoA C00332,C00024 Acetoacetyl-CoA,Acetyl-CoA
+3-hydroxy-3-methylglutaryl-CoA reductase [EC:1.1.1.34] [RN:R02082] K00021 M00095 C5 isoprenoid biosynthesis, mevalonate pathway 2,0 C00418 (R)-Mevalonate C00356 (S)-3-Hydroxy-3-methylglutaryl-CoA
+mevalonate kinase [EC:2.7.1.36] [RN:R02245] K00869 M00095 C5 isoprenoid biosynthesis, mevalonate pathway 3,0 C01107 (R)-5-Phosphomevalonate C00418 (R)-Mevalonate
+phosphomevalonate kinase [EC:2.7.4.2] [RN:R03245] K00938 M00095 C5 isoprenoid biosynthesis, mevalonate pathway 4,0 C01143 (R)-5-Diphosphomevalonate C01107 (R)-5-Phosphomevalonate
+phosphomevalonate kinase [EC:2.7.4.2] [RN:R03245] K13273 M00095 C5 isoprenoid biosynthesis, mevalonate pathway 4,1 C01143 (R)-5-Diphosphomevalonate C01107 (R)-5-Phosphomevalonate
+diphosphomevalonate decarboxylase [EC:4.1.1.33] [RN:R01121] K01597 M00095 C5 isoprenoid biosynthesis, mevalonate pathway 5,0 C00129 Isopentenyl diphosphate C01143 (R)-5-Diphosphomevalonate
+isopentenyl-diphosphate delta-isomerase [EC:5.3.3.2] [RN:R01123] K01823 M00095 C5 isoprenoid biosynthesis, mevalonate pathway 6,0 C00235 Dimethylallyl diphosphate C00129 Isopentenyl diphosphate
+1-deoxy-D-xylulose-5-phosphate synthase [EC:2.2.1.7] [RN:R05636] K01662 M00096 C5 isoprenoid biosynthesis, non-mevalonate pathway 0,0 C11437 1-Deoxy-D-xylulose 5-phosphate C00118,C00022 (2R)-2-Hydroxy-3-(phosphonooxy)-propanal,Pyruvate
+1-deoxy-D-xylulose-5-phosphate reductoisomerase [EC:1.1.1.267] [RN:R05688] K00099 M00096 C5 isoprenoid biosynthesis, non-mevalonate pathway 1,0 C11434 2-C-Methyl-D-erythritol 4-phosphate C11437 1-Deoxy-D-xylulose 5-phosphate
+2-C-methyl-D-erythritol 4-phosphate cytidylyltransferase [EC:2.7.7.60] [RN:R05633] K00991 M00096 C5 isoprenoid biosynthesis, non-mevalonate pathway 2,0 C11435 4-(Cytidine 5'-diphospho)-2-C-methyl-D-erythritol C11434 2-C-Methyl-D-erythritol 4-phosphate
+2-C-methyl-D-erythritol 4-phosphate cytidylyltransferase [EC:2.7.7.60] [RN:R05633] K12506 M00096 C5 isoprenoid biosynthesis, non-mevalonate pathway 2,1 C11435 4-(Cytidine 5'-diphospho)-2-C-methyl-D-erythritol C11434 2-C-Methyl-D-erythritol 4-phosphate
+4-diphosphocytidyl-2-C-methyl-D-erythritol kinase [EC:2.7.1.148] [RN:R05634] K00919 M00096 C5 isoprenoid biosynthesis, non-mevalonate pathway 3,0 C11436 2-Phospho-4-(cytidine 5'-diphospho)-2-C-methyl-D-erythritol C11435 4-(Cytidine 5'-diphospho)-2-C-methyl-D-erythritol
+2-C-methyl-D-erythritol 2,4-cyclodiphosphate synthase [EC:4.6.1.12] [RN:R05637] K01770 M00096 C5 isoprenoid biosynthesis, non-mevalonate pathway 4,0 C11453 2-C-Methyl-D-erythritol 2,4-cyclodiphosphate C11436 2-Phospho-4-(cytidine 5'-diphospho)-2-C-methyl-D-erythritol
+2-C-methyl-D-erythritol 4-phosphate cytidylyltransferase [EC:2.7.7.60] [RN:R05633] K12506 M00096 C5 isoprenoid biosynthesis, non-mevalonate pathway 4,1 C11435 4-(Cytidine 5'-diphospho)-2-C-methyl-D-erythritol C11434 2-C-Methyl-D-erythritol 4-phosphate
+(E)-4-hydroxy-3-methylbut-2-enyl-diphosphate synthase [EC:1.17.7.1 1.17.7.3] [RN:R08689 R10859] K03526 M00096 C5 isoprenoid biosynthesis, non-mevalonate pathway 5,0 C11811 1-Hydroxy-2-methyl-2-butenyl 4-diphosphate C11453 2-C-Methyl-D-erythritol 2,4-cyclodiphosphate
+4-hydroxy-3-methylbut-2-enyl diphosphate reductase [EC:1.17.7.4] [RN:R05884] K03527 M00096 C5 isoprenoid biosynthesis, non-mevalonate pathway 6,0 C00129 Isopentenyl diphosphate C11811 1-Hydroxy-2-methyl-2-butenyl 4-diphosphate
+isopentenyl-diphosphate delta-isomerase [EC:5.3.3.2] [RN:R01123] K01823 M00096 C5 isoprenoid biosynthesis, non-mevalonate pathway 7,0 C00235 Dimethylallyl diphosphate C00129 Isopentenyl diphosphate
+phytoene synthase [EC:2.5.1.32] [RN:R02065 R04218] K02291 M00097 beta-Carotene biosynthesis, GGAP => beta-carotene 0,0 C05421 15-cis-Phytoene C03427 Prephytoene diphosphate
+15-cis-phytoene desaturase [EC:1.3.5.5] [RN:R09653 R09654] K02293 M00097 beta-Carotene biosynthesis, GGAP => beta-carotene 1,0 C19764 9,15,9'-tricis-zeta-Carotene C19765 15,9'-dicis-Phytofluene
+zeta-carotene isomerase [EC:5.2.1.12] [RN:R09655] K15744 M00097 beta-Carotene biosynthesis, GGAP => beta-carotene 2,0 C15857 9,9'-dicis-zeta-Carotene C19764 9,15,9'-tricis-zeta-Carotene
+zeta-carotene desaturase [EC:1.3.5.6] [RN:R09656 R09658] K00514 M00097 beta-Carotene biosynthesis, GGAP => beta-carotene 3,0 C15858 7,9,7',9'-tetracis-Lycopene C19759 7,9,9'-tricis-Neurosporene
+prolycopene isomerase [EC:5.2.1.13] [RN:R07512] K09835 M00097 beta-Carotene biosynthesis, GGAP => beta-carotene 4,0 C05432 Lycopene C15858 7,9,7',9'-tetracis-Lycopene
+lycopene beta-cyclase [EC:5.5.1.19] [RN:R05341 R03824] K06443 M00097 beta-Carotene biosynthesis, GGAP => beta-carotene 5,0 C02094 beta-Carotene C05435 gamma-Carotene
+triacylglycerol lipase [EC:3.1.1.3] [RN:R02250 R02687] K01046 M00098 Acylglycerol degradation 0,0 C01885 1-Acylglycerol C00641 1,2-Diacyl-sn-glycerol
+triacylglycerol lipase [EC:3.1.1.3] [RN:R02250 R02687] K12298 M00098 Acylglycerol degradation 0,1 C01885 1-Acylglycerol C00641 1,2-Diacyl-sn-glycerol
+triacylglycerol lipase [EC:3.1.1.3] [RN:R02250 R02687] K16816 M00098 Acylglycerol degradation 0,2 C01885 1-Acylglycerol C00641 1,2-Diacyl-sn-glycerol
+triacylglycerol lipase [EC:3.1.1.3] [RN:R02250 R02687] K13534 M00098 Acylglycerol degradation 0,3 C01885 1-Acylglycerol C00641 1,2-Diacyl-sn-glycerol
+triacylglycerol lipase [EC:3.1.1.3] [RN:R02250 R02687] K14073 M00098 Acylglycerol degradation 0,4 C01885 1-Acylglycerol C00641 1,2-Diacyl-sn-glycerol
+triacylglycerol lipase [EC:3.1.1.3] [RN:R02250 R02687] K14074 M00098 Acylglycerol degradation 0,5 C01885 1-Acylglycerol C00641 1,2-Diacyl-sn-glycerol
+triacylglycerol lipase [EC:3.1.1.3] [RN:R02250 R02687] K14075 M00098 Acylglycerol degradation 0,6 C01885 1-Acylglycerol C00641 1,2-Diacyl-sn-glycerol
+triacylglycerol lipase [EC:3.1.1.3] [RN:R02250 R02687] K14076 M00098 Acylglycerol degradation 0,7 C01885 1-Acylglycerol C00641 1,2-Diacyl-sn-glycerol
+triacylglycerol lipase [EC:3.1.1.3] [RN:R02250 R02687] K22283 M00098 Acylglycerol degradation 0,8 C01885 1-Acylglycerol C00641 1,2-Diacyl-sn-glycerol
+triacylglycerol lipase [EC:3.1.1.3] [RN:R02250 R02687] K14452 M00098 Acylglycerol degradation 0,9 C01885 1-Acylglycerol C00641 1,2-Diacyl-sn-glycerol
+triacylglycerol lipase [EC:3.1.1.3] [RN:R02250 R02687] K22284 M00098 Acylglycerol degradation 0,10 C01885 1-Acylglycerol C00641 1,2-Diacyl-sn-glycerol
+triacylglycerol lipase [EC:3.1.1.3] [RN:R02250 R02687] K14674 M00098 Acylglycerol degradation 0,11 C01885 1-Acylglycerol C00641 1,2-Diacyl-sn-glycerol
+triacylglycerol lipase [EC:3.1.1.3] [RN:R02250 R02687] K14675 M00098 Acylglycerol degradation 0,12 C01885 1-Acylglycerol C00641 1,2-Diacyl-sn-glycerol
+triacylglycerol lipase [EC:3.1.1.3] [RN:R02250 R02687] K17900 M00098 Acylglycerol degradation 0,13 C01885 1-Acylglycerol C00641 1,2-Diacyl-sn-glycerol
+acylglycerol lipase [EC:3.1.1.23] [RN:R01351] K01054 M00098 Acylglycerol degradation 1,0 C00116 Glycerol C01885 1-Acylglycerol
+serine palmitoyltransferase [EC:2.3.1.50] [RN:R01281] K00654 M00099 Sphingosine biosynthesis 0,0 C02934 3-Dehydrosphinganine C00154 Palmitoyl-CoA
+3-dehydrosphinganine reductase [EC:1.1.1.102] [RN:R02978] K04708 M00099 Sphingosine biosynthesis 1,0 C00836 Sphinganine C02934 3-Dehydrosphinganine
+Acyl-CoA-dependent ceramide synthase [EC:2.3.1.24] [RN:R06517] K04709 M00099 Sphingosine biosynthesis 2,0 C12126 Dihydroceramide C00836 Sphinganine
+Acyl-CoA-dependent ceramide synthase [EC:2.3.1.24] [RN:R06517] K04710 M00099 Sphingosine biosynthesis 2,1 C12126 Dihydroceramide C00836 Sphinganine
+sphingolipid 4-desaturase [EC:1.14.19.17] [RN:R06519] K04712 M00099 Sphingosine biosynthesis 3,0 C00195 N-Acylsphingosine C12126 Dihydroceramide
+ceramidase [EC:3.5.1.23] [RN:R01494] K01441 M00099 Sphingosine biosynthesis 4,0 C00319 Sphingosine C00195 N-Acylsphingosine
+ceramidase [EC:3.5.1.23] [RN:R01494] K12348 M00099 Sphingosine biosynthesis 4,1 C00319 Sphingosine C00195 N-Acylsphingosine
+ceramidase [EC:3.5.1.23] [RN:R01494] K12349 M00099 Sphingosine biosynthesis 4,2 C00319 Sphingosine C00195 N-Acylsphingosine
+sphingosine kinase [EC:2.7.1.91] [RN:R01926] K04718 M00100 Sphingosine degradation 0,0 C06124 Sphingosine 1-phosphate C00319 Sphingosine
+sphinganine-1-phosphate aldolase [EC:4.1.2.27] [RN:R06516] K01634 M00100 Sphingosine degradation 1,0 C00346 Ethanolamine phosphate C06124 Sphingosine 1-phosphate
+lanosterol synthase [EC:5.4.99.7] [RN:R03199] K01852 M00101 Cholesterol biosynthesis, squalene 2,3-epoxide => cholesterol 0,0 C01724 Lanosterol C01054 (S)-2,3-Epoxysqualene
+sterol 14alpha-demethylase [EC:1.14.14.154] [RN:R05640] K05917 M00101 Cholesterol biosynthesis, squalene 2,3-epoxide => cholesterol 1,0 C11455 4,4-Dimethyl-5alpha-cholesta-8,14,24-trien-3beta-ol C01724 Lanosterol
+delta14-sterol reductase [EC:1.3.1.70] [RN:R05639] K00222 M00101 Cholesterol biosynthesis, squalene 2,3-epoxide => cholesterol 2,0 C05108 14-Demethyllanosterol C11455 4,4-Dimethyl-5alpha-cholesta-8,14,24-trien-3beta-ol
+methylsterol monooxygenase [EC:1.14.18.9] [RN:R07509] K07750 M00101 Cholesterol biosynthesis, squalene 2,3-epoxide => cholesterol 3,0 C15808 4alpha-Methylzymosterol-4-carboxylate C05108 14-Demethyllanosterol
+sterol-4alpha-carboxylate 3-dehydrogenase (decarboxylating) [EC:1.1.1.170] [RN:R07494] K07748 M00101 Cholesterol biosynthesis, squalene 2,3-epoxide => cholesterol 4,0 C15816 3-Keto-4-methylzymosterol C15808 4alpha-Methylzymosterol-4-carboxylate
+3-keto steroid reductase [EC:1.1.1.270] [RN:R07495] K09827 M00101 Cholesterol biosynthesis, squalene 2,3-epoxide => cholesterol 5,0 C05103 4alpha-Methylzymosterol C15816 3-Keto-4-methylzymosterol
+3-keto steroid reductase [EC:1.1.1.270] [RN:R07495] K13373 M00101 Cholesterol biosynthesis, squalene 2,3-epoxide => cholesterol 5,1 C05103 4alpha-Methylzymosterol C15816 3-Keto-4-methylzymosterol
+delta24-sterol reductase [EC:1.3.1.72] [RN:R07498] K09828 M00101 Cholesterol biosynthesis, squalene 2,3-epoxide => cholesterol 6,0 C03845 5alpha-Cholest-8-en-3beta-ol C05437 Zymosterol
+cholestenol delta-isomerase [EC:5.3.3.5] [RN:R03353] K01824 M00101 Cholesterol biosynthesis, squalene 2,3-epoxide => cholesterol 7,0 C01189 Lathosterol C03845 5alpha-Cholest-8-en-3beta-ol
+delta7-sterol 5-desaturase [EC:1.14.19.20] [RN:R07215] K00227 M00101 Cholesterol biosynthesis, squalene 2,3-epoxide => cholesterol 8,0 C01164 7-Dehydrocholesterol C01189 Lathosterol
+7-dehydrocholesterol reductase [EC:1.3.1.21] [RN:R01451 R01456] K00213 M00101 Cholesterol biosynthesis, squalene 2,3-epoxide => cholesterol 9,0 C00187 Cholesterol C01164 7-Dehydrocholesterol
+sterol 24-C-methyltransferase [EC:2.1.1.41] [RN:R04427] K00559 M00102 Ergocalciferol biosynthesis 0,0 C04525 Fecosterol C05437 Zymosterol
+C-8 sterol isomerase [EC:5.-.-.-] [RN:R07497] K09829 M00102 Ergocalciferol biosynthesis 1,0 C15777 Episterol C04525 Fecosterol
+Delta7-sterol 5-desaturase [EC:1.14.19.20] [RN:R07505] K00227 M00102 Ergocalciferol biosynthesis 2,0 C15778 5,7,24(28)-Ergostatrienol C15777 Episterol
+sterol 22-desaturase [EC:1.14.19.41] [RN:R07506] K09831 M00102 Ergocalciferol biosynthesis 3,0 C05440 Ergosta-5,7,22,24(28)-tetraen-3beta-ol C15778 5,7,24(28)-Ergostatrienol
+Delta24(24(1))-sterol reductase [EC:1.3.1.71] [RN:R05641] K00223 M00102 Ergocalciferol biosynthesis 4,0 C01694 Ergosterol C05440 Ergosta-5,7,22,24(28)-tetraen-3beta-ol
+cytochrome P450, family 2, subfamily R, polypeptide 1 (vitamin D 25-hydroxylase [EC:1.14.14.24] [RN:R03611] K07419 M00103 Cholecalciferol biosynthesis 0,0 C01561 Calcidiol C05443 Vitamin D3
+cytochrome P450, family 27, subfamily B (25-hydroxyvitamin D3 [EC:1.14.13.13] [RN:R03610] K07438 M00103 Cholecalciferol biosynthesis 1,0 C01673 Calcitriol C01561 Calcidiol
+cholesterol 7alpha-monooxygenase [EC:1.14.14.23] [RN:R01463] K00489 M00104 Bile acid biosynthesis, cholesterol => cholate/chenodeoxycholate 0,0 C03594 7alpha-Hydroxycholesterol C00187 Cholesterol
+cholest-5-ene-3beta,7alpha-diol 3beta-dehydrogenase [EC:1.1.1.181] [RN:R04263] K12408 M00104 Bile acid biosynthesis, cholesterol => cholate/chenodeoxycholate 1,0 C05455 7alpha-Hydroxycholest-4-en-3-one C03594 7alpha-Hydroxycholesterol
+sterol 12-alpha-hydroxylase [EC:1.14.18.8] [RN:R04826] K07431 M00104 Bile acid biosynthesis, cholesterol => cholate/chenodeoxycholate 2,0 C17339 4-Cholesten-7alpha,12alpha-diol-3-one C05455 7alpha-Hydroxycholest-4-en-3-one
+3-oxo-5-beta-steroid 4-dehydrogenase [EC:1.3.1.3] [RN:R04823 R04817] K00251 M00104 Bile acid biosynthesis, cholesterol => cholate/chenodeoxycholate 3,0 C05451 7alpha-Hydroxy-5beta-cholestan-3-one C05455 7alpha-Hydroxycholest-4-en-3-one
+3-alpha-hydroxysteroid dehydrogenase [EC:1.1.1.50] [RN:R04824 R04825 R04818 R04819] K00037 M00104 Bile acid biosynthesis, cholesterol => cholate/chenodeoxycholate 4,0 C05452 3alpha,7alpha-Dihydroxy-5beta-cholestane C05451 7alpha-Hydroxy-5beta-cholestan-3-one
+cholestanetriol 26-monooxygenase [EC:1.14.15.15] [RN:R04807 R08759 R08761 R04806 R08758 R08760] K00488 M00104 Bile acid biosynthesis, cholesterol => cholate/chenodeoxycholate 5,0 C04554 3alpha,7alpha-Dihydroxy-5beta-cholestanate C05445 3alpha,7alpha-Dihydroxy-5beta-cholestan-26-al
+solute carrier family 27 (fatty acid transporter), member 5 [EC:6.2.1.7] [RN:R08733 R08738] K08748 M00104 Bile acid biosynthesis, cholesterol => cholate/chenodeoxycholate 6,0 C17345 (25R)-3alpha,7alpha-Dihydroxy-5beta-cholestanoyl-CoA C04554 3alpha,7alpha-Dihydroxy-5beta-cholestanate
+alpha-methylacyl-CoA racemase [EC:5.1.99.4] [RN:R08734 R08739] K01796 M00104 Bile acid biosynthesis, cholesterol => cholate/chenodeoxycholate 7,0 C17346 (25S)-3alpha,7alpha-Dihydroxy-5beta-cholestanoyl-CoA C17345 (25R)-3alpha,7alpha-Dihydroxy-5beta-cholestanoyl-CoA
+3alpha,7alpha,12alpha-trihydroxy-5beta-cholestanoyl-CoA 24-hydroxylase [EC:1.17.99.3] [RN:R08735 R08740] K10214 M00104 Bile acid biosynthesis, cholesterol => cholate/chenodeoxycholate 8,0 C05447 (24E)-3alpha,7alpha-Dihydroxy-5beta-cholest-24-enoyl-CoA C17346 (25S)-3alpha,7alpha-Dihydroxy-5beta-cholestanoyl-CoA
+(3R)-hydroxyacyl-CoA dehydrogenase / 3a,7a,12a-trihydroxy-5b-cholest-24-enoyl-CoA hydratase [EC:1.1.1.- 4.2.1.107] [RN:R04813 R04812 R04809 R04810] K12405 M00104 Bile acid biosynthesis, cholesterol => cholate/chenodeoxycholate 9,0 C05449 3alpha,7alpha-Dihydroxy-5beta-24-oxocholestanoyl-CoA C05448 (24R,25R)-3alpha,7alpha,24-Trihydroxy-5beta-cholestanoyl-CoA
+sterol carrier protein 2 [EC:2.3.1.176] [RN:R03719 R04811] K08764 M00104 Bile acid biosynthesis, cholesterol => cholate/chenodeoxycholate 10,0 C05337 Chenodeoxycholoyl-CoA C05449 3alpha,7alpha-Dihydroxy-5beta-24-oxocholestanoyl-CoA
+acyl-CoA thioesterase 8 [EC:3.1.2.27] [RN:R07296 R03974] K11992 M00104 Bile acid biosynthesis, cholesterol => cholate/chenodeoxycholate 11,0 C02528 Chenodeoxycholate C05337 Chenodeoxycholoyl-CoA
+solute carrier family 27 (fatty acid transporter), member 5 [EC:6.2.1.7] [RN:R02794] K08748 M00106 Conjugated bile acid biosynthesis, cholate => taurocholate/glycocholate 0,0 C01794 Choloyl-CoA C00695 Cholic acid
+bile acid-CoA:amino acid N-acyltransferase [EC:2.3.1.65] [RN:R03720 R03718] K00659 M00106 Conjugated bile acid biosynthesis, cholate => taurocholate/glycocholate 1,0 C01921 Glycocholate C01794 Choloyl-CoA
+cytochrome P450, family 11, subfamily A (cholesterol monooxygenase [EC:1.14.15.6] [RN:R01454 R04854 R02723 R04855 R03933] K00498 M00107 Steroid hormone biosynthesis, cholesterol => prognenolone => progesterone 0,0 C01953 Pregnenolone C05501 20alpha,22beta-Dihydroxycholesterol
+3beta-hydroxy-delta5-steroid dehydrogenase [EC:1.1.1.145] [RN:R02216] K00070 M00107 Steroid hormone biosynthesis, cholesterol => prognenolone => progesterone 1,0 C00410 Progesterone C01953 Pregnenolone
+steroid delta-isomerase [EC:5.3.3.1] [RN:R02216] K01822 M00107 Steroid hormone biosynthesis, cholesterol => prognenolone => progesterone 1,1 C00410 Progesterone C01953 Pregnenolone
+cytochrome P450, family 21, subfamily A (steroid 21-monooxygenase) [EC:1.14.14.16] [RN:R02213] K00513 M00108 C21-Steroid hormone biosynthesis, progesterone => corticosterone/aldosterone 0,0 C03205 11-Deoxycorticosterone C00410 Progesterone
+cytochrome P450, family 11, subfamily B1 (steroid 11beta-monooxygenase) [EC:1.14.15.4] [RN:R03851] K00497 M00108 C21-Steroid hormone biosynthesis, progesterone => corticosterone/aldosterone 1,0 C02140 Corticosterone C03205 11-Deoxycorticosterone
+cytochrome P450, family 11, subfamily B2 (steroid 11beta-monooxygenase / corticosterone 18-monooxygenase) [EC:1.14.15.4 1.14.15.5] [RN:R03851 R03262 R03263] K07433 M00108 C21-Steroid hormone biosynthesis, progesterone => corticosterone/aldosterone 1,1 C01780 Aldosterone C01124 18-Hydroxycorticosterone
+cytochrome P450, family 11, subfamily B2 (steroid 11beta-monooxygenase / corticosterone 18-monooxygenase) [EC:1.14.15.4 1.14.15.5] [RN:R03851 R03262 R03263] K07433 M00108 C21-Steroid hormone biosynthesis, progesterone => corticosterone/aldosterone 2,0 C01780 Aldosterone C01124 18-Hydroxycorticosterone
+cytochrome P450, family 17, subfamily A (steroid [EC:1.14.14.19] [RN:R02211] K00512 M00109 C21-Steroid hormone biosynthesis, progesterone => cortisol/cortisone 0,0 C01176 17alpha-Hydroxyprogesterone C00410 Progesterone
+cytochrome P450, family 21, subfamily A (steroid 21-monooxygenase) [EC:1.14.14.16] [RN:R03326] K00513 M00109 C21-Steroid hormone biosynthesis, progesterone => cortisol/cortisone 1,0 C05488 11-Deoxycortisol C01176 17alpha-Hydroxyprogesterone
+cytochrome P450, family 11, subfamily B1/B2 (steroid 11beta-monooxygenase) [EC:1.14.15.4] [RN:R02843] K00497 M00109 C21-Steroid hormone biosynthesis, progesterone => cortisol/cortisone 2,0 C00735 Cortisol C05488 11-Deoxycortisol
+cytochrome P450, family 11, subfamily B1/B2 (steroid 11beta-monooxygenase) [EC:1.14.15.4] [RN:R02843] K07433 M00109 C21-Steroid hormone biosynthesis, progesterone => cortisol/cortisone 2,1 C00735 Cortisol C05488 11-Deoxycortisol
+11beta-hydroxysteroid dehydrogenase [EC:1.1.1.146 1.1.1.-] [RN:R02834 R02836] K15680 M00109 C21-Steroid hormone biosynthesis, progesterone => cortisol/cortisone 3,0 C00762 Cortisone C00735 Cortisol
+11beta-hydroxysteroid dehydrogenase [EC:1.1.1.146 1.1.1.-] [RN:R02834 R02836] K00071 M00109 C21-Steroid hormone biosynthesis, progesterone => cortisol/cortisone 3,1 C00762 Cortisone C00735 Cortisol
+steroid 17alpha-monooxygenase / 17alpha-hydroxyprogesterone deacetylase [EC:1.14.14.19 1.14.14.32] [RN:R03783 R08517] K00512 M00110 C19/C18-Steroid hormone biosynthesis, pregnenolone => androstenedione => estrone 0,0 C01227 Dehydroepiandrosterone C05138 17alpha-Hydroxypregnenolone
+3beta-hydroxy-delta5-steroid dehydrogenase [EC:1.1.1.145] [RN:R01837] K00070 M00110 C19/C18-Steroid hormone biosynthesis, pregnenolone => androstenedione => estrone 1,0 C00280 Androstenedione C01227 Dehydroepiandrosterone
+steroid delta-isomerase [EC:5.3.3.1] [RN:R01837] K01822 M00110 C19/C18-Steroid hormone biosynthesis, pregnenolone => androstenedione => estrone 1,1 C00280 Androstenedione C01227 Dehydroepiandrosterone
+cytochrome P450, family 19, subfamily A (aromatase) [EC:1.14.14.14] [RN:R01840 R04759 R02351] K07434 M00110 C19/C18-Steroid hormone biosynthesis, pregnenolone => androstenedione => estrone 2,0 C00468 Estrone C05297 19-Oxoandrost-4-ene-3,17-dione
+homogenitisate phytyltransferase [EC:2.5.1.115 2.5.1.116] [RN:R07500 R10708] K09833 M00112 Tocopherol/tocotorienol biosynthesis 0,0 C20737 6-Geranylgeranyl-2-methylbenzene-1,4-diol C00353 Geranylgeranyl diphosphate
+MPBQ/MSBQ methyltransferase [EC:2.1.1.295] [RN:R07501 R10710] K12502 M00112 Tocopherol/tocotorienol biosynthesis 1,0 C20738 6-Geranylgeranyl-2,3-dimethylbenzene-1,4-diol C20737 6-Geranylgeranyl-2-methylbenzene-1,4-diol
+MPBQ/MSBQ methyltransferase [EC:2.1.1.295] [RN:R07501 R10710] K18534 M00112 Tocopherol/tocotorienol biosynthesis 1,1 C20738 6-Geranylgeranyl-2,3-dimethylbenzene-1,4-diol C20737 6-Geranylgeranyl-2-methylbenzene-1,4-diol
+tocopherol cyclase [EC:5.5.1.24] [RN:R07502 R07503 R10624 R10623] K09834 M00112 Tocopherol/tocotorienol biosynthesis 2,0 C14156 delta-Tocotrienol C20737 6-Geranylgeranyl-2-methylbenzene-1,4-diol
+tocopherol O-methyltransferase [EC:2.1.1.95] [RN:R07236 R07504 R10491 R10492] K05928 M00112 Tocopherol/tocotorienol biosynthesis 3,0 C14154 beta-Tocotrienol C14156 delta-Tocotrienol
+lipoxygenase [EC:1.13.11.12] [RN:R07896] K00454 M00113 Jasmonic acid biosynthesis 0,0 C16336 trans-2-Enoyl-OPC4-CoA C16335 OPC4-CoA
+hydroperoxide dehydratase [EC:4.2.1.92] [RN:R07863] K01723 M00113 Jasmonic acid biosynthesis 1,0 C04672 12,13(S)-EOT C04785 13(S)-HPOT
+allene oxide cyclase [EC:5.3.99.6] [RN:R03402] K10525 M00113 Jasmonic acid biosynthesis 2,0 C01226 12-OPDA C04672 12,13(S)-EOT
+12-oxophytodienoic acid reductase [EC:1.3.1.42] [RN:R03401] K05894 M00113 Jasmonic acid biosynthesis 3,0 C04780 OPC-8:0 C01226 12-OPDA
+OPC-8:0 CoA ligase 1 [EC:6.2.1.-] [RN:R07887] K10526 M00113 Jasmonic acid biosynthesis 4,0 C16327 OPC8-CoA C04780 OPC-8:0
+acyl-CoA oxidase [EC:1.3.3.6] [RN:R07888 R07892 R07896] K00232 M00113 Jasmonic acid biosynthesis 5,0 C16336 trans-2-Enoyl-OPC4-CoA C16335 OPC4-CoA
+enoyl-CoA hydratase/3-hydroxyacyl-CoA dehydrogenase [EC:4.2.1.17 1.1.1.35 1.1.1.211] [RN:R07889 R07890 R07893 R07894 R07897 R07898] K10527 M00113 Jasmonic acid biosynthesis 6,0 C16338 3-Oxo-OPC4-CoA C16336 trans-2-Enoyl-OPC4-CoA
+acetyl-CoA acyltransferase [EC:2.3.1.16] [RN:R07891 R07895 R07899] K00632 M00113 Jasmonic acid biosynthesis 7,0 C16339 (+)-7-Isojasmonic acid CoA C16338 3-Oxo-OPC4-CoA
+acetyl-CoA acyltransferase [EC:2.3.1.16] [RN:R07891 R07895 R07899] K07513 M00113 Jasmonic acid biosynthesis 7,1 C16339 (+)-7-Isojasmonic acid CoA C16338 3-Oxo-OPC4-CoA
+glucose-6-phosphate isomerase [EC:5.3.1.9] [RN:R02740] K01810 M00114 Ascorbate biosynthesis, plants, glucose-6P => ascorbate 0,0,0,0 C05345 beta-D-Fructose 6-phosphate C00668 alpha-D-Glucose 6-phosphate
+glucose-6-phosphate isomerase [EC:5.3.1.9] [RN:R02740] K06859 M00114 Ascorbate biosynthesis, plants, glucose-6P => ascorbate 0,0,0,1 C05345 beta-D-Fructose 6-phosphate C00668 alpha-D-Glucose 6-phosphate
+glucose-6-phosphate isomerase [EC:5.3.1.9] [RN:R02740] K13810 M00114 Ascorbate biosynthesis, plants, glucose-6P => ascorbate 0,0,0,2 C05345 beta-D-Fructose 6-phosphate C00668 alpha-D-Glucose 6-phosphate
+mannose-6-phosphate isomerase [EC:5.3.1.8] [RN:R01819] K01809 M00114 Ascorbate biosynthesis, plants, glucose-6P => ascorbate 0,0,1,0 C00275 D-Mannose 6-phosphate C05345 beta-D-Fructose 6-phosphate
+mannose-6-phosphate isomerase [EC:5.3.1.8] [RN:R01819] K16011 M00114 Ascorbate biosynthesis, plants, glucose-6P => ascorbate 0,0,1,1 C00275 D-Mannose 6-phosphate C05345 beta-D-Fructose 6-phosphate
+glucose-6-phosphate isomerase [EC:5.3.1.9] [RN:R02740] K15916 M00114 Ascorbate biosynthesis, plants, glucose-6P => ascorbate 0,1 C05345 beta-D-Fructose 6-phosphate C00668 alpha-D-Glucose 6-phosphate
+phosphomannomutase [EC:5.4.2.8] [RN:R01818] K16881 M00114 Ascorbate biosynthesis, plants, glucose-6P => ascorbate 1,0 C00636 D-Mannose 1-phosphate C00275 D-Mannose 6-phosphate
+phosphomannomutase [EC:5.4.2.8] [RN:R01818] K17497 M00114 Ascorbate biosynthesis, plants, glucose-6P => ascorbate 1,1,0,0 C00636 D-Mannose 1-phosphate C00275 D-Mannose 6-phosphate
+phosphomannomutase [EC:5.4.2.8] [RN:R01818] K01840 M00114 Ascorbate biosynthesis, plants, glucose-6P => ascorbate 1,1,0,1 C00636 D-Mannose 1-phosphate C00275 D-Mannose 6-phosphate
+phosphomannomutase [EC:5.4.2.8] [RN:R01818] K15778 M00114 Ascorbate biosynthesis, plants, glucose-6P => ascorbate 1,1,0,2 C00636 D-Mannose 1-phosphate C00275 D-Mannose 6-phosphate
+mannose-1-phosphate guanylyltransferase [EC:2.7.7.13] [RN:R00885] K00966 M00114 Ascorbate biosynthesis, plants, glucose-6P => ascorbate 1,1,1,0 C00096 GDP-mannose C00636 D-Mannose 1-phosphate
+mannose-1-phosphate guanylyltransferase [EC:2.7.7.13] [RN:R00885] K00971 M00114 Ascorbate biosynthesis, plants, glucose-6P => ascorbate 1,1,1,1 C00096 GDP-mannose C00636 D-Mannose 1-phosphate
+mannose-6-phosphate isomerase [EC:5.3.1.8] [RN:R01819] K16011 M00114 Ascorbate biosynthesis, plants, glucose-6P => ascorbate 1,1,1,2 C00275 D-Mannose 6-phosphate C05345 beta-D-Fructose 6-phosphate
+GDP-D-mannose 3', 5'-epimerase [EC:5.1.3.18] [RN:R00889] K10046 M00114 Ascorbate biosynthesis, plants, glucose-6P => ascorbate 2,0 C02280 GDP-L-galactose C00096 GDP-mannose
+galactose-1-phosphate guanylyltransferase (GDP) [RN:R07678] K14190 M00114 Ascorbate biosynthesis, plants, glucose-6P => ascorbate 3,0 C15926 L-Galactose 1-phosphate C02280 GDP-L-galactose
+L-galactose 1-phosphate phosphatase [EC:3.1.3.93] [RN:R07674] K10047 M00114 Ascorbate biosynthesis, plants, glucose-6P => ascorbate 4,0 C01825 L-Galactose C15926 L-Galactose 1-phosphate
+L-galactose 1-phosphate phosphatase [EC:3.1.3.93] [RN:R07674] K18649 M00114 Ascorbate biosynthesis, plants, glucose-6P => ascorbate 4,1 C01825 L-Galactose C15926 L-Galactose 1-phosphate
+D-threo-aldose 1-dehydrogenase [EC:1.1.1.122] [RN:R07675] K00064 M00114 Ascorbate biosynthesis, plants, glucose-6P => ascorbate 5,0 C01115 L-Galactono-1,4-lactone C01825 L-Galactose
+L-galactose dehydrogenase [EC:1.1.1.316] [RN:R07675] K17744 M00114 Ascorbate biosynthesis, plants, glucose-6P => ascorbate 5,1 C01115 L-Galactono-1,4-lactone C01825 L-Galactose
+L-galactono-1,4-lactone dehydorogenase [EC:1.3.2.3] [RN:R00640] K00225 M00114 Ascorbate biosynthesis, plants, glucose-6P => ascorbate 6,0 C00072 Ascorbate C01115 L-Galactono-1,4-lactone
+L-aspartate oxidase [EC:1.4.3.16] [RN:R00481] K00278 M00115 NAD biosynthesis, aspartate => NAD 0,0 C05840 Iminoaspartate C00049 L-Aspartate
+quinolinate synthase [RN:R04292] K03517 M00115 NAD biosynthesis, aspartate => NAD 1,0 C03722 Pyridine-2,3-dicarboxylate C05840 Iminoaspartate
+nicotinate-nucleotide pyrophosphorylase (carboxylating) [EC:2.4.2.19] [RN:R03348] K00767 M00115 NAD biosynthesis, aspartate => NAD 2,0 C01185 Nicotinate D-ribonucleotide C03722 Pyridine-2,3-dicarboxylate
+nicotinate-nucleotide adenylyltransferase [EC:2.7.7.18] [RN:R03005] K00969 M00115 NAD biosynthesis, aspartate => NAD 3,0 C00857 Deamino-NAD+ C01185 Nicotinate D-ribonucleotide
+nicotinate-nucleotide adenylyltransferase [EC:2.7.7.18] [RN:R03005] K06210 M00115 NAD biosynthesis, aspartate => NAD 3,1 C00857 Deamino-NAD+ C01185 Nicotinate D-ribonucleotide
+NAD+ synthase [EC:6.3.1.5 6.3.5.1] [RN:R00189 R00257] K01916 M00115 NAD biosynthesis, aspartate => NAD 4,0 C00003 NAD+ C00857 Deamino-NAD+
+NAD+ synthase [EC:6.3.1.5 6.3.5.1] [RN:R00189 R00257] K01950 M00115 NAD biosynthesis, aspartate => NAD 4,1 C00003 NAD+ C00857 Deamino-NAD+
+isochorismate synthase [EC:5.4.4.2] [RN:R01717] K01851 M00116 Menaquinone biosynthesis, chorismate => menaquinol 0,0,0,0 C00885 Isochorismate C00251 Chorismate
+isochorismate synthase [EC:5.4.4.2] [RN:R01717] K02552 M00116 Menaquinone biosynthesis, chorismate => menaquinol 0,0,0,1 C00885 Isochorismate C00251 Chorismate
+isochorismate synthase [EC:5.4.4.2] [RN:R01717] K02361 M00116 Menaquinone biosynthesis, chorismate => menaquinol 0,0,0,2 C00885 Isochorismate C00251 Chorismate
+2-succinyl-6-hydroxy-2,4-cyclohexadiene-1-carboxylate synthase [EC:2.2.1.9] [RN:R08165] K02551 M00116 Menaquinone biosynthesis, chorismate => menaquinol 0,0,1,0 C16519 2-Succinyl-5-enolpyruvyl-6-hydroxy-3-cyclohexene-1-carboxylate C00885 Isochorismate
+2-succinyl-6-hydroxy-2,4-cyclohexadiene-1-carboxylate synthase [EC:4.2.99.20] [RN:R08166] K08680 M00116 Menaquinone biosynthesis, chorismate => menaquinol 0,0,2,0 C05817 (1R,6R)-6-Hydroxy-2-succinylcyclohexa-2,4-diene-1-carboxylate C16519 2-Succinyl-5-enolpyruvyl-6-hydroxy-3-cyclohexene-1-carboxylate
+O-succinylbenzoate-CoA synthase [EC:4.2.1.113] [RN:R04031] K02549 M00116 Menaquinone biosynthesis, chorismate => menaquinol 0,0,3,0 C02730 2-Succinylbenzoate C05817 (1R,6R)-6-Hydroxy-2-succinylcyclohexa-2,4-diene-1-carboxylate
+isochorismate synthase [EC:5.4.4.2] [RN:R01717] K14759 M00116 Menaquinone biosynthesis, chorismate => menaquinol 0,1 C00885 Isochorismate C00251 Chorismate
+O-succinylbenzoic acid--CoA ligase [EC:6.2.1.26] [RN:R04030] K01911 M00116 Menaquinone biosynthesis, chorismate => menaquinol 1,0 C03160 2-Succinylbenzoyl-CoA C02730 2-Succinylbenzoate
+O-succinylbenzoic acid--CoA ligase [EC:6.2.1.26] [RN:R04030] K14760 M00116 Menaquinone biosynthesis, chorismate => menaquinol 1,1 C03160 2-Succinylbenzoyl-CoA C02730 2-Succinylbenzoate
+naphthoate synthase [EC:4.1.3.36] [RN:R07263] K01661 M00116 Menaquinone biosynthesis, chorismate => menaquinol 2,0 C15547 1,4-Dihydroxy-2-naphthoyl-CoA C03160 2-Succinylbenzoyl-CoA
+1,4-dihydroxy-2-naphthoyl-CoA hydrolase [EC:3.1.2.28] [RN:R07262] K12073 M00116 Menaquinone biosynthesis, chorismate => menaquinol 3,0 C03657 1,4-Dihydroxy-2-naphthoate C15547 1,4-Dihydroxy-2-naphthoyl-CoA
+1,4-dihydroxy-2-naphthoyl-CoA hydrolase [EC:3.1.2.28] [RN:R07262] K19222 M00116 Menaquinone biosynthesis, chorismate => menaquinol 3,1 C03657 1,4-Dihydroxy-2-naphthoate C15547 1,4-Dihydroxy-2-naphthoyl-CoA
+1,4-dihydroxy-2-naphthoate polyprenyltransferase [EC:2.5.1.74] [RN:R10757] K02548 M00116 Menaquinone biosynthesis, chorismate => menaquinol 4,0 C19847 Demethylmenaquinol C03657,C05847 1,4-Dihydroxy-2-naphthoate,all-trans-Polyprenyl diphosphate
+demethylmenaquinone methyltransferase [EC:2.1.1.163] [RN:R09736] K03183 M00116 Menaquinone biosynthesis, chorismate => menaquinol 5,0 C05819 Menaquinol C19847 Demethylmenaquinol
+chorismate lyase [EC:4.1.3.40] [RN:R01302] K03181 M00117 Ubiquinone biosynthesis, prokaryotes, chorismate => ubiquinone 0,0 C00156 4-Hydroxybenzoate C00251 Chorismate
+chorismate lyase [EC:4.1.3.40] [RN:R01302] K18240 M00117 Ubiquinone biosynthesis, prokaryotes, chorismate => ubiquinone 0,1 C00156 4-Hydroxybenzoate C00251 Chorismate
+4-hydroxybenzoate polyprenyltransferase [EC:2.5.1.39] [RN:R05000] K03179 M00117 Ubiquinone biosynthesis, prokaryotes, chorismate => ubiquinone 1,0 C05848 4-Hydroxy-3-polyprenylbenzoate C00156 4-Hydroxybenzoate
+4-hydroxy-3-polyprenylbenzoate decarboxylase [EC:4.1.1.98] [RN:R04985] K03182 M00117 Ubiquinone biosynthesis, prokaryotes, chorismate => ubiquinone 2,0 C05807 2-Polyprenylphenol C05848 4-Hydroxy-3-polyprenylbenzoate
+4-hydroxy-3-polyprenylbenzoate decarboxylase [EC:4.1.1.98] [RN:R04985] K03186 M00117 Ubiquinone biosynthesis, prokaryotes, chorismate => ubiquinone 2,0 C05807 2-Polyprenylphenol C05848 4-Hydroxy-3-polyprenylbenzoate
+2-polyprenylphenol 6-hydroxylase [EC:1.14.13.240] [RN:R08768] K18800 M00117 Ubiquinone biosynthesis, prokaryotes, chorismate => ubiquinone 3,0 C17551 2-Polyprenyl-6-hydroxyphenol C05807 2-Polyprenylphenol
+3-demethylubiquinone-9 3-methyltransferase [EC:2.1.1.64] [RN:R08781] K00568 M00117 Ubiquinone biosynthesis, prokaryotes, chorismate => ubiquinone 4,0 C00399 Ubiquinone C17562 2-Polyprenyl-3-methyl-5-hydroxy-6-methoxy-1,4-benzoquinone
+2-octaprenyl-6-methoxyphenol hydroxylase [EC:1.14.13.-] [RN:R08773] K03185 M00117 Ubiquinone biosynthesis, prokaryotes, chorismate => ubiquinone 5,0 C17560 2-Polyprenyl-6-methoxy-1,4-benzoquinone C17552 2-Polyprenyl-6-methoxyphenol
+2-methoxy-6-polyprenyl-1,4-benzoquinol methylase [EC:2.1.1.201] [RN:R08774] K03183 M00117 Ubiquinone biosynthesis, prokaryotes, chorismate => ubiquinone 6,0 C17561 2-Polyprenyl-3-methyl-6-methoxy-1,4-benzoquinone C17560 2-Polyprenyl-6-methoxy-1,4-benzoquinone
+3-demethoxyubiquinol 3-hydroxylase [EC:1.14.99.60] [RN:R08775] K03184 M00117 Ubiquinone biosynthesis, prokaryotes, chorismate => ubiquinone 7,0 C17562 2-Polyprenyl-3-methyl-5-hydroxy-6-methoxy-1,4-benzoquinone C17561 2-Polyprenyl-3-methyl-6-methoxy-1,4-benzoquinone
+3-demethylubiquinone-9 3-methyltransferase [EC:2.1.1.64] [RN:R08781] K00568 M00117 Ubiquinone biosynthesis, prokaryotes, chorismate => ubiquinone 8,0 C00399 Ubiquinone C17562 2-Polyprenyl-3-methyl-5-hydroxy-6-methoxy-1,4-benzoquinone
+glutamate--cysteine ligase [EC:6.3.2.2] [RN:R00894] K11204 M00118 Glutathione biosynthesis, glutamate => glutathione 0,0 C00669 gamma-L-Glutamyl-L-cysteine C00025 L-Glutamate
+glutamate--cysteine ligase [EC:6.3.2.2] [RN:R00894] K11205 M00118 Glutathione biosynthesis, glutamate => glutathione 0,0 C00669 gamma-L-Glutamyl-L-cysteine C00025 L-Glutamate
+glutamate--cysteine ligase [EC:6.3.2.2] [RN:R00894] K01919 M00118 Glutathione biosynthesis, glutamate => glutathione 0,1 C00669 gamma-L-Glutamyl-L-cysteine C00025 L-Glutamate
+glutathione synthase [EC:6.3.2.3] [RN:R00497] K21456 M00118 Glutathione biosynthesis, glutamate => glutathione 1,0 C00051 Glutathione C00669 gamma-L-Glutamyl-L-cysteine
+glutathione synthase [EC:6.3.2.3] [RN:R00497] K01920 M00118 Glutathione biosynthesis, glutamate => glutathione 1,1 C00051 Glutathione C00669 gamma-L-Glutamyl-L-cysteine
+pantoate--beta-alanine ligase [EC:6.3.2.1] [RN:R02473] K01918 M00119 Pantothenate biosynthesis, valine/L-aspartate => pantothenate 0,0 C00864 Pantothenate C00522,C00099 (R)-Pantoate,beta-Alanine
+pantoate--beta-alanine ligase [EC:6.3.2.1] [RN:R02473] K13799 M00119 Pantothenate biosynthesis, valine/L-aspartate => pantothenate 0,1 C00864 Pantothenate C00522,C00099 (R)-Pantoate,beta-Alanine
+pantothenate kinase [EC:2.7.1.33] [RN:R03018] K00867 M00120 Coenzyme A biosynthesis, pantothenate => CoA 0,0 C03492 D-4'-Phosphopantothenate C00864 Pantothenate
+pantothenate kinase [EC:2.7.1.33] [RN:R03018] K03525 M00120 Coenzyme A biosynthesis, pantothenate => CoA 0,1 C03492 D-4'-Phosphopantothenate C00864 Pantothenate
+pantothenate kinase [EC:2.7.1.33] [RN:R03018] K09680 M00120 Coenzyme A biosynthesis, pantothenate => CoA 0,2 C03492 D-4'-Phosphopantothenate C00864 Pantothenate
+pantothenate kinase [EC:2.7.1.33] [RN:R03018] K01947 M00120 Coenzyme A biosynthesis, pantothenate => CoA 0,3 C03492 D-4'-Phosphopantothenate C00864 Pantothenate
+phosphopantothenate---cysteine ligase (ATP) [EC:6.3.2.51] [RN:R04230] K01922 M00120 Coenzyme A biosynthesis, pantothenate => CoA 1,0,0,0 C04352 (R)-4'-Phosphopantothenoyl-L-cysteine C03492 D-4'-Phosphopantothenate
+phosphopantothenate---cysteine ligase (CTP) [EC:6.3.2.5] [RN:R04231] K21977 M00120 Coenzyme A biosynthesis, pantothenate => CoA 1,0,0,1 C04352 (R)-4'-Phosphopantothenoyl-L-cysteine C03492 D-4'-Phosphopantothenate
+phosphopantothenoylcysteine decarboxylase [EC:4.1.1.36] [RN:R03269] K01598 M00120 Coenzyme A biosynthesis, pantothenate => CoA 1,0,1,0 C01134 Pantetheine 4'-phosphate C04352 (R)-4'-Phosphopantothenoyl-L-cysteine
+phosphopantothenate---cysteine ligase (CTP) [EC:6.3.2.5] [RN:R04231] K13038 M00120 Coenzyme A biosynthesis, pantothenate => CoA 1,1 C04352 (R)-4'-Phosphopantothenoyl-L-cysteine C03492 D-4'-Phosphopantothenate
+pantetheine-phosphate adenylyltransferase [EC:2.7.7.3] [RN:R03035] K02318 M00120 Coenzyme A biosynthesis, pantothenate => CoA 2,0 C00882 Dephospho-CoA C01134 Pantetheine 4'-phosphate
+pantetheine-phosphate adenylyltransferase [EC:2.7.7.3] [RN:R03035] K00954 M00120 Coenzyme A biosynthesis, pantothenate => CoA 2,1,0,0 C00882 Dephospho-CoA C01134 Pantetheine 4'-phosphate
+pantetheine-phosphate adenylyltransferase [EC:2.7.7.3] [RN:R03035] K02201 M00120 Coenzyme A biosynthesis, pantothenate => CoA 2,1,0,1 C00882 Dephospho-CoA C01134 Pantetheine 4'-phosphate
+dephospho-CoA kinase [EC:2.7.1.24] [RN:R00130] K00859 M00120 Coenzyme A biosynthesis, pantothenate => CoA 2,1,1,0 C00010 CoA C00882 Dephospho-CoA
+glutamyl-tRNA synthetase [EC:6.1.1.17] [RN:R05578] K01885 M00121 Heme biosynthesis, plants and bacteria, glutamate => heme 0,0 C02987 L-Glutamyl-tRNA(Glu) C00025 L-Glutamate
+glutamyl-tRNA synthetase [EC:6.1.1.17] [RN:R05578] K14163 M00121 Heme biosynthesis, plants and bacteria, glutamate => heme 0,1 C02987 L-Glutamyl-tRNA(Glu) C00025 L-Glutamate
+glutamyl-tRNA reductase [EC:1.2.1.70] [RN:R04109] K02492 M00121 Heme biosynthesis, plants and bacteria, glutamate => heme 1,0 C03741 (S)-4-Amino-5-oxopentanoate C02987 L-Glutamyl-tRNA(Glu)
+glutamate-1-semialdehyde 2,1-aminomutase [EC:5.4.3.8] [RN:R02272] K01845 M00121 Heme biosynthesis, plants and bacteria, glutamate => heme 2,0 C00430 5-Aminolevulinate C03741 (S)-4-Amino-5-oxopentanoate
+porphobilinogen synthase [EC:4.2.1.24] [RN:R00036] K01698 M00121 Heme biosynthesis, plants and bacteria, glutamate => heme 3,0 C00931 Porphobilinogen C00430 5-Aminolevulinate
+hydroxymethylbilane synthase [EC:2.5.1.61] [RN:R00084] K01749 M00121 Heme biosynthesis, plants and bacteria, glutamate => heme 4,0 C01024 Hydroxymethylbilane C00931 Porphobilinogen
+uroporphyrinogen-III synthase [EC:4.2.1.75] [RN:R03165] K01719 M00121 Heme biosynthesis, plants and bacteria, glutamate => heme 5,0 C01051 Uroporphyrinogen III C01024 Hydroxymethylbilane
+uroporphyrinogen-III synthase [EC:4.2.1.75] [RN:R03165] K13542 M00121 Heme biosynthesis, plants and bacteria, glutamate => heme 5,1 C01051 Uroporphyrinogen III C01024 Hydroxymethylbilane
+uroporphyrinogen-III synthase [EC:4.2.1.75] [RN:R03165] K13543 M00121 Heme biosynthesis, plants and bacteria, glutamate => heme 5,2 C01051 Uroporphyrinogen III C01024 Hydroxymethylbilane
+uroporphyrinogen decarboxylase [EC:4.1.1.37] [RN:R03197] K01599 M00121 Heme biosynthesis, plants and bacteria, glutamate => heme 6,0 C03263 Coproporphyrinogen III C01051 Uroporphyrinogen III
+coproporphyrinogen III oxidase [EC:1.3.3.3] [RN:R03220] K00228 M00121 Heme biosynthesis, plants and bacteria, glutamate => heme 7,0 C01079 Protoporphyrinogen IX C03263 Coproporphyrinogen III
+oxygen-independent coproporphyrinogen III oxidase [EC:1.3.98.3] [RN:R06895] K02495 M00121 Heme biosynthesis, plants and bacteria, glutamate => heme 7,1 C01079 Protoporphyrinogen IX C03263 Coproporphyrinogen III
+menaquinone-dependent protoporphyrinogen oxidase [EC:1.3.5.3] [RN:R09489] K00230 M00121 Heme biosynthesis, plants and bacteria, glutamate => heme 8,0 C02191 Protoporphyrin C01079 Protoporphyrinogen IX
+protoporphyrinogen oxidase [EC:1.3.3.4] [RN:R03222] K00231 M00121 Heme biosynthesis, plants and bacteria, glutamate => heme 8,1 C02191 Protoporphyrin C01079 Protoporphyrinogen IX
+ferrochelatase [EC:4.99.1.1] [RN:R00310] K01772 M00121 Heme biosynthesis, plants and bacteria, glutamate => heme 9,0 C00032 Heme C02191 Protoporphyrin
+adenosylcobinamide-GDP ribazoletransferase [EC:2.7.8.26] [RN:R05223] K02233 M00122 Cobalamin biosynthesis, cobinamide => cobalamin 0,0 C00194 Cobamide coenzyme C06510,C05775 Adenosine-GDP-cobinamide,alpha-Ribazole
+8-amino-7-oxononanoate synthase [EC:2.3.1.47] [RN:R10124 R03210] K00652 M00123 Biotin biosynthesis, pimeloyl-ACP/CoA => biotin 0,0 C01092 8-Amino-7-oxononanoate C01063 6-Carboxyhexanoyl-CoA
+adenosylmethionine---8-amino-7-oxononanoate aminotransferase [EC:2.6.1.62] [RN:R03231] K00833 M00123 Biotin biosynthesis, pimeloyl-ACP/CoA => biotin 1,0,0,0 C01037 7,8-Diaminononanoate C01092 8-Amino-7-oxononanoate
+lysine---8-amino-7-oxononanoate aminotransferase [EC:2.6.1.105] [RN:R10699] K19563 M00123 Biotin biosynthesis, pimeloyl-ACP/CoA => biotin 1,0,0,1 C01037 7,8-Diaminononanoate C01092 8-Amino-7-oxononanoate
+dethiobiotin synthetase [EC:6.3.3.3] [RN:R03182] K01935 M00123 Biotin biosynthesis, pimeloyl-ACP/CoA => biotin 1,0,1,0 C01909 Dethiobiotin C01037 7,8-Diaminononanoate
+bifunctional dethiobiotin synthetase / adenosylmethionine---8-amino-7-oxononanoate aminotransferase [EC:6.3.3.3 2.6.1.62] [RN:R03231 R03182] K19562 M00123 Biotin biosynthesis, pimeloyl-ACP/CoA => biotin 1,1 C01909 Dethiobiotin C01037 7,8-Diaminononanoate
+biotin synthetase [EC:2.8.1.6] [RN:R01078] K01012 M00123 Biotin biosynthesis, pimeloyl-ACP/CoA => biotin 2,0 C00120 Biotin C01909 Dethiobiotin
+D-erythrose 4-phosphate dehydrogenase [EC:1.2.1.72] [RN:R01825] K03472 M00124 Pyridoxal biosynthesis, erythrose-4P => pyridoxal-5P 0,0 C03393 4-Phospho-D-erythronate C00279 D-Erythrose 4-phosphate
+erythronate-4-phosphate dehydrogenase [EC:1.1.1.290] [RN:R04210] K03473 M00124 Pyridoxal biosynthesis, erythrose-4P => pyridoxal-5P 1,0 C06054 2-Oxo-3-hydroxy-4-phosphobutanoate C03393 4-Phospho-D-erythronate
+phosphoserine aminotransferase [EC:2.6.1.52] [RN:R05085] K00831 M00124 Pyridoxal biosynthesis, erythrose-4P => pyridoxal-5P 2,0 C06055 O-Phospho-4-hydroxy-L-threonine C06054 2-Oxo-3-hydroxy-4-phosphobutanoate
+4-hydroxythreonine-4-phosphate dehydrogenase [EC:1.1.1.262] [RN:R05681] K00097 M00124 Pyridoxal biosynthesis, erythrose-4P => pyridoxal-5P 3,0 C07335 2-Amino-3-oxo-4-phosphonooxybutyrate C06055 O-Phospho-4-hydroxy-L-threonine
+pyridoxine 5-phosphate synthase [EC:2.6.99.2] [RN:R05838] K03474 M00124 Pyridoxal biosynthesis, erythrose-4P => pyridoxal-5P 4,0 C00627 Pyridoxine phosphate C11638 3-Amino-2-oxopropyl phosphate
+pyridoxamine 5'-phosphate oxidase [EC:1.4.3.5] [RN:R00278] K00275 M00124 Pyridoxal biosynthesis, erythrose-4P => pyridoxal-5P 5,0 C00018 Pyridoxal phosphate C00627 Pyridoxine phosphate
+6,7-dimethyl-8-ribityllumazine synthase [EC:2.5.1.78] [RN:R04457] K00794 M00125 Riboflavin biosynthesis, GTP => riboflavin/FMN/FAD 0,0 C04332 6,7-Dimethyl-8-(1-D-ribityl)lumazine C04732,C15556 5-Amino-6-(1-D-ribitylamino)uracil,3,4-Dihydroxy-2-butanone 4-phosphate
+riboflavin synthase [EC:2.5.1.9] [RN: R00066] K00793 M00125 Riboflavin biosynthesis, GTP => riboflavin/FMN/FAD 1,0 C00255 Riboflavin C04332 6,7-Dimethyl-8-(1-D-ribityl)lumazine
+riboflavin kinase [EC:2.7.1.26] [RN:R00549] K00861 M00125 Riboflavin biosynthesis, GTP => riboflavin/FMN/FAD 2,0,0,0 C00061 FMN C00255 Riboflavin
+riboflavin kinase [EC:2.7.1.26] [RN:R00549] K20884 M00125 Riboflavin biosynthesis, GTP => riboflavin/FMN/FAD 2,0,0,1 C00061 FMN C00255 Riboflavin
+FMN adenylyltransferase [EC:2.7.7.2] [RN:R00161] K00953 M00125 Riboflavin biosynthesis, GTP => riboflavin/FMN/FAD 2,0,1,0 C00016 FAD C00061 FMN
+FMN adenylyltransferase [EC:2.7.7.2] [RN:R00161] K22949 M00125 Riboflavin biosynthesis, GTP => riboflavin/FMN/FAD 2,0,1,1 C00016 FAD C00061 FMN
+riboflavin kinase [EC:2.7.1.26] [RN:R00549] K11753 M00125 Riboflavin biosynthesis, GTP => riboflavin/FMN/FAD 2,1 C00061 FMN C00255 Riboflavin
+GTP cyclohydrolase I [EC:3.5.4.16] [RN:R00428 R05046 R05048 R04639] K01495 M00126 Tetrahydrofolate biosynthesis, GTP => THF 0,0 C04895 7,8-Dihydroneopterin 3'-triphosphate C06148 2,5-Diamino-6-(5'-triphosphoryl-3',4'-trihydroxy-2'-oxopentyl)-amino-4-oxopyrimidine
+GTP cyclohydrolase I [EC:3.5.4.16] [RN:R00428 R05046 R05048 R04639] K09007 M00126 Tetrahydrofolate biosynthesis, GTP => THF 0,1 C04895 7,8-Dihydroneopterin 3'-triphosphate C06148 2,5-Diamino-6-(5'-triphosphoryl-3',4'-trihydroxy-2'-oxopentyl)-amino-4-oxopyrimidine
+GTP cyclohydrolase I [EC:3.5.4.16] [RN:R00428 R05046 R05048 R04639] K22391 M00126 Tetrahydrofolate biosynthesis, GTP => THF 0,2 C04895 7,8-Dihydroneopterin 3'-triphosphate C06148 2,5-Diamino-6-(5'-triphosphoryl-3',4'-trihydroxy-2'-oxopentyl)-amino-4-oxopyrimidine
+alkaline phosphatase [EC:3.1.3.1] [RN:R04620] K01077 M00126 Tetrahydrofolate biosynthesis, GTP => THF 1,0 C04874 7,8-Dihydroneopterin C04895 7,8-Dihydroneopterin 3'-triphosphate
+alkaline phosphatase [EC:3.1.3.1] [RN:R04620] K01113 M00126 Tetrahydrofolate biosynthesis, GTP => THF 1,1 C04874 7,8-Dihydroneopterin C04895 7,8-Dihydroneopterin 3'-triphosphate
+dihydroneopterin triphosphate diphosphatase [EC:3.6.1.67] [RN:R04638] K08310 M00126 Tetrahydrofolate biosynthesis, GTP => THF 1,2 C05925 Dihydroneopterin phosphate C04895 7,8-Dihydroneopterin 3'-triphosphate
+dihydroneopterin triphosphate diphosphatase [EC:3.6.1.67] [RN:R04638] K19965 M00126 Tetrahydrofolate biosynthesis, GTP => THF 1,2 C05925 Dihydroneopterin phosphate C04895 7,8-Dihydroneopterin 3'-triphosphate
+dihydroneopterin aldolase [EC:4.1.2.25] [RN:R03504] K13939 M00126 Tetrahydrofolate biosynthesis, GTP => THF 2,0,0,0 C01300 6-(Hydroxymethyl)-7,8-dihydropterin C04874 7,8-Dihydroneopterin
+dihydroneopterin aldolase [EC:4.1.2.25] [RN:R03504] K13940 M00126 Tetrahydrofolate biosynthesis, GTP => THF 2,0,0,1,0,0 C01300 6-(Hydroxymethyl)-7,8-dihydropterin C04874 7,8-Dihydroneopterin
+dihydroneopterin aldolase [EC:4.1.2.25] [RN:R03504] K01633 M00126 Tetrahydrofolate biosynthesis, GTP => THF 2,0,0,1,0,1 C01300 6-(Hydroxymethyl)-7,8-dihydropterin C04874 7,8-Dihydroneopterin
+2-amino-4-hydroxy-6-hydroxymethyldihydropteridine pyrophosphokinase [EC:2.7.6.3] [RN:R03503] K00950 M00126 Tetrahydrofolate biosynthesis, GTP => THF 2,0,0,1,1,0 C04807 6-Hydroxymethyl-7,8-dihydropterin diphosphate C01300 6-(Hydroxymethyl)-7,8-dihydropterin
+dihydropteroate synthase [EC:2.5.1.15] [RN:R03066 R03067] K00796 M00126 Tetrahydrofolate biosynthesis, GTP => THF 2,0,1,0 C00921 Dihydropteroate C04807 6-Hydroxymethyl-7,8-dihydropterin diphosphate
+dihydroneopterin aldolase [EC:4.1.2.25] [RN:R03504] K01633 M00126 Tetrahydrofolate biosynthesis, GTP => THF 2,1,0,0 C01300 6-(Hydroxymethyl)-7,8-dihydropterin C04874 7,8-Dihydroneopterin
+2-amino-4-hydroxy-6-hydroxymethyldihydropteridine pyrophosphokinase [EC:2.7.6.3] [RN:R03503] K13941 M00126 Tetrahydrofolate biosynthesis, GTP => THF 2,1,1,0 C04807 6-Hydroxymethyl-7,8-dihydropterin diphosphate C01300 6-(Hydroxymethyl)-7,8-dihydropterin
+dihydrofolate synthase [EC:6.3.2.12] [RN:R02237] K11754 M00126 Tetrahydrofolate biosynthesis, GTP => THF 3,0 C00415 Dihydrofolate C00921 Dihydropteroate
+dihydrofolate synthase [EC:6.3.2.12] [RN:R02237] K20457 M00126 Tetrahydrofolate biosynthesis, GTP => THF 3,1 C00415 Dihydrofolate C00921 Dihydropteroate
+dihydrofolate reductase [EC:1.5.1.3] [RN:R00936 R00939] K00287 M00126 Tetrahydrofolate biosynthesis, GTP => THF 4,0 C00101 Tetrahydrofolate C00415 Dihydrofolate
+dihydrofolate reductase [EC:1.5.1.3] [RN:R00936 R00939] K13998 M00126 Tetrahydrofolate biosynthesis, GTP => THF 4,1 C00101 Tetrahydrofolate C00415 Dihydrofolate
+thiamine-phosphate pyrophosphorylase [EC:2.5.1.3] [RN:R03223] K00788 M00127 Thiamine biosynthesis, AIR => thiamine-P/thiamine-2P 0,0 C01081 Thiamin monophosphate C04752,C04327 2-Methyl-4-amino-5-hydroxymethylpyrimidine diphosphate,4-Methyl-5-(2-phosphoethyl)thiazole
+phosphomethylpyrimidine kinase [EC:2.7.4.7] [RN:R04509] K14153 M00127 Thiamine biosynthesis, AIR => thiamine-P/thiamine-2P 0,1 C04752 2-Methyl-4-amino-5-hydroxymethylpyrimidine diphosphate C04556 4-Amino-2-methyl-5-phosphomethylpyrimidine
+hydroxyethylthiazole kinase [EC:2.7.1.50] [RN:R04448] K14154 M00127 Thiamine biosynthesis, AIR => thiamine-P/thiamine-2P 0,2 C04327 4-Methyl-5-(2-phosphoethyl)thiazole C04294 5-(2-Hydroxyethyl)-4-methylthiazole
+thiamine-monophosphate kinase [EC:2.7.4.16] [RN:R00617] K00946 M00127 Thiamine biosynthesis, AIR => thiamine-P/thiamine-2P 1,0 C00068 Thiamin diphosphate C01081 Thiamin monophosphate
+4-hydroxybenzoate polyprenyltransferase [EC:2.5.1.39] [RN:R05000] K06125 M00128 Ubiquinone biosynthesis, eukaryotes, 4-hydroxybenzoate => ubiquinone 0,0 C05848 4-Hydroxy-3-polyprenylbenzoate C00156 4-Hydroxybenzoate
+3-demethylubiquinol 3-O-methyltransferase [EC:2.1.1.64] [RN:R08781] K00591 M00128 Ubiquinone biosynthesis, eukaryotes, 4-hydroxybenzoate => ubiquinone 1,0 C00399 Ubiquinone C17562 2-Polyprenyl-3-methyl-5-hydroxy-6-methoxy-1,4-benzoquinone
+ubiquinone biosynthesis monooxygenase Coq6 [EC:1.14.13.-] [RN:R08773] K06126 M00128 Ubiquinone biosynthesis, eukaryotes, 4-hydroxybenzoate => ubiquinone 2,0 C17560 2-Polyprenyl-6-methoxy-1,4-benzoquinone C17552 2-Polyprenyl-6-methoxyphenol
+2-methoxy-6-polyprenyl-1,4-benzoquinol methylase [EC:2.1.1.201] [RN:R08774] K06127 M00128 Ubiquinone biosynthesis, eukaryotes, 4-hydroxybenzoate => ubiquinone 3,0 C17561 2-Polyprenyl-3-methyl-6-methoxy-1,4-benzoquinone C17560 2-Polyprenyl-6-methoxy-1,4-benzoquinone
+3-demethoxyubiquinol 3-hydroxylase [EC:1.14.99.60] [RN:R08775] K06134 M00128 Ubiquinone biosynthesis, eukaryotes, 4-hydroxybenzoate => ubiquinone 4,0 C17562 2-Polyprenyl-3-methyl-5-hydroxy-6-methoxy-1,4-benzoquinone C17561 2-Polyprenyl-3-methyl-6-methoxy-1,4-benzoquinone
+3-demethylubiquinol 3-O-methyltransferase [EC:2.1.1.64] [RN:R08781] K00591 M00128 Ubiquinone biosynthesis, eukaryotes, 4-hydroxybenzoate => ubiquinone 5,0 C00399 Ubiquinone C17562 2-Polyprenyl-3-methyl-5-hydroxy-6-methoxy-1,4-benzoquinone
+UTP--glucose-1-phosphate uridylyltransferase [EC:2.7.7.9] [RN:R00289] K00963 M00129 Ascorbate biosynthesis, animals, glucose-1P => ascorbate 0,0 C00029 UDP-glucose C00103 D-Glucose 1-phosphate
+UDPglucose 6-dehydrogenase [EC:1.1.1.22] [RN:R00286] K00012 M00129 Ascorbate biosynthesis, animals, glucose-1P => ascorbate 1,0 C00167 UDP-glucuronate C00029 UDP-glucose
+glucuronosyltransferase [EC:2.4.1.17] [RN:R01383] K00699 M00129 Ascorbate biosynthesis, animals, glucose-1P => ascorbate 2,0 C03033 beta-D-Glucuronoside C00167 UDP-glucuronate
+beta-glucuronidase [EC:3.2.1.31] [RN:R01478] K01195 M00129 Ascorbate biosynthesis, animals, glucose-1P => ascorbate 3,0 C00191 D-Glucuronate C03033 beta-D-Glucuronoside
+beta-glucuronidase [EC:3.2.1.31] [RN:R01478] K14756 M00129 Ascorbate biosynthesis, animals, glucose-1P => ascorbate 3,1 C00191 D-Glucuronate C03033 beta-D-Glucuronoside
+alcohol dehydrogenase (NADP+) [EC:1.1.1.2] [RN:R01481] K00002 M00129 Ascorbate biosynthesis, animals, glucose-1P => ascorbate 4,0 C00800 L-Gulonate C00191 D-Glucuronate
+gluconolactonase [EC:3.1.1.17] [RN:R02933] K01053 M00129 Ascorbate biosynthesis, animals, glucose-1P => ascorbate 5,0 C01040 L-Gulono-1,4-lactone C00800 L-Gulonate
+L-gulonolactone oxidase [EC:1.1.3.8] [RN:R03184 R00647] K00103 M00129 Ascorbate biosynthesis, animals, glucose-1P => ascorbate 6,0 C00072 Ascorbate C03289 L-xylo-Hexulonolactone
+phosphatidylinositol 4-kinase [EC:2.7.1.67] [RN:R03361] K00888 M00130 Inositol phosphate metabolism, PI=> PIP2 => Ins(1,4,5)P3 => Ins(1,3,4,5)P4 0,0 C01277 1-Phosphatidyl-1D-myo-inositol 4-phosphate C01194 1-Phosphatidyl-D-myo-inositol
+phosphatidylinositol 4-kinase [EC:2.7.1.67] [RN:R03361] K19801 M00130 Inositol phosphate metabolism, PI=> PIP2 => Ins(1,4,5)P3 => Ins(1,3,4,5)P4 0,1 C01277 1-Phosphatidyl-1D-myo-inositol 4-phosphate C01194 1-Phosphatidyl-D-myo-inositol
+phosphatidylinositol 4-kinase [EC:2.7.1.67] [RN:R03361] K13711 M00130 Inositol phosphate metabolism, PI=> PIP2 => Ins(1,4,5)P3 => Ins(1,3,4,5)P4 0,2 C01277 1-Phosphatidyl-1D-myo-inositol 4-phosphate C01194 1-Phosphatidyl-D-myo-inositol
+1-phosphatidylinositol-4-phosphate 5-kinase [EC:2.7.1.68] [RN:R03469] K00889 M00130 Inositol phosphate metabolism, PI=> PIP2 => Ins(1,4,5)P3 => Ins(1,3,4,5)P4 1,0 C04637 1-Phosphatidyl-D-myo-inositol 4,5-bisphosphate C01277 1-Phosphatidyl-1D-myo-inositol 4-phosphate
+1-phosphatidylinositol-4-phosphate 5-kinase [EC:2.7.1.68] [RN:R03469] K13712 M00130 Inositol phosphate metabolism, PI=> PIP2 => Ins(1,4,5)P3 => Ins(1,3,4,5)P4 1,1 C04637 1-Phosphatidyl-D-myo-inositol 4,5-bisphosphate C01277 1-Phosphatidyl-1D-myo-inositol 4-phosphate
+1-phosphatidylinositol-4,5-bisphosphate phosphodiesterase [EC:3.1.4.11] [RN:R03435] K01116 M00130 Inositol phosphate metabolism, PI=> PIP2 => Ins(1,4,5)P3 => Ins(1,3,4,5)P4 2,0 C01245 D-myo-Inositol 1,4,5-trisphosphate C04637 1-Phosphatidyl-D-myo-inositol 4,5-bisphosphate
+phospholipase C [EC:3.1.4.11] [RN:R03435] K05857 M00130 Inositol phosphate metabolism, PI=> PIP2 => Ins(1,4,5)P3 => Ins(1,3,4,5)P4 2,1 C01245 D-myo-Inositol 1,4,5-trisphosphate C04637 1-Phosphatidyl-D-myo-inositol 4,5-bisphosphate
+phospholipase C [EC:3.1.4.11] [RN:R03435] K05858 M00130 Inositol phosphate metabolism, PI=> PIP2 => Ins(1,4,5)P3 => Ins(1,3,4,5)P4 2,2 C01245 D-myo-Inositol 1,4,5-trisphosphate C04637 1-Phosphatidyl-D-myo-inositol 4,5-bisphosphate
+phospholipase C [EC:3.1.4.11] [RN:R03435] K05859 M00130 Inositol phosphate metabolism, PI=> PIP2 => Ins(1,4,5)P3 => Ins(1,3,4,5)P4 2,3 C01245 D-myo-Inositol 1,4,5-trisphosphate C04637 1-Phosphatidyl-D-myo-inositol 4,5-bisphosphate
+phospholipase C [EC:3.1.4.11] [RN:R03435] K05860 M00130 Inositol phosphate metabolism, PI=> PIP2 => Ins(1,4,5)P3 => Ins(1,3,4,5)P4 2,4 C01245 D-myo-Inositol 1,4,5-trisphosphate C04637 1-Phosphatidyl-D-myo-inositol 4,5-bisphosphate
+phospholipase C [EC:3.1.4.11] [RN:R03435] K05861 M00130 Inositol phosphate metabolism, PI=> PIP2 => Ins(1,4,5)P3 => Ins(1,3,4,5)P4 2,5 C01245 D-myo-Inositol 1,4,5-trisphosphate C04637 1-Phosphatidyl-D-myo-inositol 4,5-bisphosphate
+1D-myo-inositol-triphosphate 3-kinase [EC:2.7.1.127] [RN:R03433] K00911 M00130 Inositol phosphate metabolism, PI=> PIP2 => Ins(1,4,5)P3 => Ins(1,3,4,5)P4 3,0 C01272 1D-myo-Inositol 1,3,4,5-tetrakisphosphate C01245 D-myo-Inositol 1,4,5-trisphosphate
+inositol-1,4,5-trisphosphate 5-phosphatase [EC:3.1.3.56] [RN:R03430] K01106 M00131 Inositol phosphate metabolism, Ins(1,3,4,5)P4 => Ins(1,3,4)P3 => myo-inositol 0,0 C01243 1D-myo-Inositol 1,3,4-trisphosphate C01272 1D-myo-Inositol 1,3,4,5-tetrakisphosphate
+inositol polyphosphate 1-phosphatase [EC:3.1.3.57] [RN:R03427] K01107 M00131 Inositol phosphate metabolism, Ins(1,3,4,5)P4 => Ins(1,3,4)P3 => myo-inositol 1,0 C04063 D-myo-Inositol 3,4-bisphosphate C01243 1D-myo-Inositol 1,3,4-trisphosphate
+inositol polyphosphate 1-phosphatase [EC:3.1.3.57] [RN:R03427] K15422 M00131 Inositol phosphate metabolism, Ins(1,3,4,5)P4 => Ins(1,3,4)P3 => myo-inositol 1,1 C04063 D-myo-Inositol 3,4-bisphosphate C01243 1D-myo-Inositol 1,3,4-trisphosphate
+inositol polyphosphate-4-phosphatase [EC:3.1.3.66] [RN:R04372] K01109 M00131 Inositol phosphate metabolism, Ins(1,3,4,5)P4 => Ins(1,3,4)P3 => myo-inositol 2,0 C04006 1D-myo-Inositol 3-phosphate C04063 D-myo-Inositol 3,4-bisphosphate
+myo-inositol-1(or 4)-monophosphatase [EC:3.1.3.25] [RN:R01187] K01092 M00131 Inositol phosphate metabolism, Ins(1,3,4,5)P4 => Ins(1,3,4)P3 => myo-inositol 3,0 C00137 myo-Inositol C04006 1D-myo-Inositol 3-phosphate
+myo-inositol-1(or 4)-monophosphatase [EC:3.1.3.25] [RN:R01187] K15759 M00131 Inositol phosphate metabolism, Ins(1,3,4,5)P4 => Ins(1,3,4)P3 => myo-inositol 3,1 C00137 myo-Inositol C04006 1D-myo-Inositol 3-phosphate
+myo-inositol-1(or 4)-monophosphatase [EC:3.1.3.25] [RN:R01187] K10047 M00131 Inositol phosphate metabolism, Ins(1,3,4,5)P4 => Ins(1,3,4)P3 => myo-inositol 3,2 C00137 myo-Inositol C04006 1D-myo-Inositol 3-phosphate
+myo-inositol-1(or 4)-monophosphatase [EC:3.1.3.25] [RN:R01187] K18649 M00131 Inositol phosphate metabolism, Ins(1,3,4,5)P4 => Ins(1,3,4)P3 => myo-inositol 3,3 C00137 myo-Inositol C04006 1D-myo-Inositol 3-phosphate
+1D-myo-Inositol-trisphosphate 6-kinase [EC:2.7.1.159] [RN:R03429] K00913 M00132 Inositol phosphate metabolism, Ins(1,3,4)P3 => phytate 0,0 C04477 1D-myo-Inositol 1,3,4,6-tetrakisphosphate C01243 1D-myo-Inositol 1,3,4-trisphosphate
+1D-myo-Inositol-trisphosphate 6-kinase [EC:2.7.1.159] [RN:R03429] K01765 M00132 Inositol phosphate metabolism, Ins(1,3,4)P3 => phytate 0,1 C04477 1D-myo-Inositol 1,3,4,6-tetrakisphosphate C01243 1D-myo-Inositol 1,3,4-trisphosphate
+1D-myo-Inositol-tetrakisphosphate 5-kinase [EC:2.7.1.140] [RN:R03478] K00915 M00132 Inositol phosphate metabolism, Ins(1,3,4)P3 => phytate 1,0 C01284 1D-myo-Inositol 1,3,4,5,6-pentakisphosphate C04477 1D-myo-Inositol 1,3,4,6-tetrakisphosphate
+inositol-pentakisphosphate 2-kinase [EC:2.7.1.158] [RN:R05202] K10572 M00132 Inositol phosphate metabolism, Ins(1,3,4)P3 => phytate 2,0 C01204 myo-Inositol hexakisphosphate C01284 1D-myo-Inositol 1,3,4,5,6-pentakisphosphate
+spermidine synthase [EC:2.5.1.16] [RN:R01920] K00797 M00133 Polyamine biosynthesis, arginine => agmatine => putrescine => spermidine 0,0 C00315 Spermidine C01137,C00134 S-Adenosylmethioninamine,Putrescine
+arginase [EC:3.5.3.1] [RN:R00551] K01476 M00134 Polyamine biosynthesis, arginine => ornithine => putrescine 0,0 C00077 L-Ornithine C00062 L-Arginine
+ornithine decarboxylase [EC:4.1.1.17] [RN:R00670] K01581 M00134 Polyamine biosynthesis, arginine => ornithine => putrescine 1,0 C00134 Putrescine C00077 L-Ornithine
+diamine N-acetyltransferase [EC:2.3.1.57] [RN:R01154] K00657 M00135 GABA biosynthesis, eukaryotes, putrescine => GABA 0,0 C02714 N-Acetylputrescine C00134 Putrescine
+monoamine oxidase [EC:1.4.3.4] [RN:R04025] K00274 M00135 GABA biosynthesis, eukaryotes, putrescine => GABA 1,0 C05936 N4-Acetylaminobutanal C02714 N-Acetylputrescine
+aldehyde dehydrogenase (NAD+) [EC:1.2.1.3] [RN:R05050] K00128 M00135 GABA biosynthesis, eukaryotes, putrescine => GABA 2,0 C02946 4-Acetamidobutanoate C05936 N4-Acetylaminobutanal
+aldehyde dehydrogenase (NAD+) [EC:1.2.1.3] [RN:R05050] K14085 M00135 GABA biosynthesis, eukaryotes, putrescine => GABA 2,1 C02946 4-Acetamidobutanoate C05936 N4-Acetylaminobutanal
+aldehyde dehydrogenase (NAD+) [EC:1.2.1.3] [RN:R05050] K00149 M00135 GABA biosynthesis, eukaryotes, putrescine => GABA 2,2 C02946 4-Acetamidobutanoate C05936 N4-Acetylaminobutanal
+gamma-glutamylputrescine synthase [EC:6.3.1.11] [RN:R07414] K09470 M00136 GABA biosynthesis, prokaryotes, putrescine => GABA 0,0 C15699 gamma-L-Glutamylputrecine C00134 Putrescine
+gamma-glutamylputrescine oxidase [EC:1.4.3.-] [RN:R07415] K09471 M00136 GABA biosynthesis, prokaryotes, putrescine => GABA 1,0 C15700 gamma-Glutamyl-gamma-aminobutyraldehyde C15699 gamma-L-Glutamylputrecine
+4-(gamma-glutamylamino)butanal dehydrogenase [EC:1.2.1.99] [RN:R07417 R07418] K09472 M00136 GABA biosynthesis, prokaryotes, putrescine => GABA 2,0 C15767 gamma-Glutamyl-gamma-aminobutyraye C15700 gamma-Glutamyl-gamma-aminobutyraldehyde
+gamma-glutamyl-gamma-aminobutyrate hydrolase [EC:3.5.1.94] [RN:R07419] K09473 M00136 GABA biosynthesis, prokaryotes, putrescine => GABA 3,0 C00334 4-Aminobutanoate C15767 gamma-Glutamyl-gamma-aminobutyraye
+phenylalanine ammonia-lyase [EC:4.3.1.24] [RN:R00697] K10775 M00137 Flavanone biosynthesis, phenylalanine => naringenin 0,0 C00423 trans-Cinnamate C00079 L-Phenylalanine
+trans-cinnamate 4-monooxygenase [EC:1.14.14.91] [RN:R02253] K00487 M00137 Flavanone biosynthesis, phenylalanine => naringenin 1,0 C00811 4-Coumarate C00423 trans-Cinnamate
+4-coumarate--CoA ligase [EC:6.2.1.12] [RN:R01616] K01904 M00137 Flavanone biosynthesis, phenylalanine => naringenin 2,0 C00223 p-Coumaroyl-CoA C00811 4-Coumarate
+chalcone synthase [EC:2.3.1.74] [RN:R01613] K00660 M00137 Flavanone biosynthesis, phenylalanine => naringenin 3,0 C06561 Naringenin chalcone C00223 p-Coumaroyl-CoA
+chalcone isomerase [EC:5.5.1.6] [RN:R02446] K01859 M00137 Flavanone biosynthesis, phenylalanine => naringenin 4,0 C00509 Naringenin C06561 Naringenin chalcone
+naringenin 3-dioxygenase [EC:1.14.11.9] [RN:R02444] K00475 M00138 Flavonoid biosynthesis, naringenin => pelargonidin 0,0 C00974 Dihydrokaempferol C00509 Naringenin
+dihydroflavonol-4-reductase [EC:1.1.1.219] [RN:R03123] K13082 M00138 Flavonoid biosynthesis, naringenin => pelargonidin 1,0 C03648 cis-3,4-Leucopelargonidin C00974 Dihydrokaempferol
+anthocyanidin synthase [EC:1.14.20.4] [RN:R04276] K05277 M00138 Flavonoid biosynthesis, naringenin => pelargonidin 2,0 C05904 Pelargonidin C03648 cis-3,4-Leucopelargonidin
+glycine hydroxymethyltransferase [EC:2.1.2.1] [RN:R00945] K00600 M00140 C1-unit interconversion, prokaryotes 0,0 C00143 5,10-Methylenetetrahydrofolate C00101 Tetrahydrofolate
+methylenetetrahydrofolate dehydrogenase (NADP+) / methenyltetrahydrofolate cyclohydrolase [EC:1.5.1.5 3.5.4.9] [RN:R01220 R01655] K01491 M00140 C1-unit interconversion, prokaryotes 1,0 C00234 10-Formyltetrahydrofolate C00445 5,10-Methenyltetrahydrofolate
+methylenetetrahydrofolate dehydrogenase (NADP+) [EC:1.5.1.5] [RN:R01220] K00300 M00140 C1-unit interconversion, prokaryotes 1,1,0,0 C00445 5,10-Methenyltetrahydrofolate C00143 5,10-Methylenetetrahydrofolate
+methenyltetrahydrofolate cyclohydrolase [EC:3.5.4.9] [RN:R01655] K01500 M00140 C1-unit interconversion, prokaryotes 1,1,1,0 C00234 10-Formyltetrahydrofolate C00445 5,10-Methenyltetrahydrofolate
+formate--tetrahydrofolate ligase [EC:6.3.4.3] [RN:R00943] K01938 M00140 C1-unit interconversion, prokaryotes 2,0 C00101 Tetrahydrofolate C00234 10-Formyltetrahydrofolate
+glycine hydroxymethyltransferase [EC:2.1.2.1] [RN:R00945] K00600 M00141 C1-unit interconversion, eukaryotes 0,0 C00143 5,10-Methylenetetrahydrofolate C00101 Tetrahydrofolate
+methylenetetrahydrofolate dehydrogenase (NADP+) / methenyltetrahydrofolate cyclohydrolase / formyltetrahydrofolate synthetase [EC:1.5.1.5 3.5.4.9 6.3.4.3] [RN:R01220 R01655 R00943] K00288 M00141 C1-unit interconversion, eukaryotes 1,0 C00101 Tetrahydrofolate C00234 10-Formyltetrahydrofolate
+methylenetetrahydrofolate dehydrogenase(NAD+) / 5,10-methenyltetrahydrofolate cyclohydrolase [EC:1.5.1.15 3.5.4.9] [RN:R01218 R01655] K13403 M00141 C1-unit interconversion, eukaryotes 1,1,0,0 C00234 10-Formyltetrahydrofolate C00445 5,10-Methenyltetrahydrofolate
+C1-tetrahydrofolate synthase [EC:6.3.4.3] [RN:R00943] K13402 M00141 C1-unit interconversion, eukaryotes 1,1,1,0 C00101 Tetrahydrofolate C00234 10-Formyltetrahydrofolate
+ND1; NADH-ubiquinone oxidoreductase chain 1 [EC:7.1.1.2] K03878 M00142 NADH:ubiquinone oxidoreductase, mitochondria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+ND2; NADH-ubiquinone oxidoreductase chain 2 [EC:7.1.1.2] K03879 M00142 NADH:ubiquinone oxidoreductase, mitochondria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+ND3; NADH-ubiquinone oxidoreductase chain 3 [EC:7.1.1.2] K03880 M00142 NADH:ubiquinone oxidoreductase, mitochondria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+ND4; NADH-ubiquinone oxidoreductase chain 4 [EC:7.1.1.2] K03881 M00142 NADH:ubiquinone oxidoreductase, mitochondria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+ND4L; NADH-ubiquinone oxidoreductase chain 4L [EC:7.1.1.2] K03882 M00142 NADH:ubiquinone oxidoreductase, mitochondria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+ND5; NADH-ubiquinone oxidoreductase chain 5 [EC:7.1.1.2] K03883 M00142 NADH:ubiquinone oxidoreductase, mitochondria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+ND6; NADH-ubiquinone oxidoreductase chain 6 [EC:7.1.1.2] K03884 M00142 NADH:ubiquinone oxidoreductase, mitochondria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+NDUFS1; NADH dehydrogenase (ubiquinone) Fe-S protein 1 [EC:7.1.1.2 1.6.99.3] K03934 M00143 NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria 0,0
+NDUFS2; NADH dehydrogenase (ubiquinone) Fe-S protein 2 [EC:7.1.1.2 1.6.99.3] K03935 M00143 NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria 0,0
+NDUFS3; NADH dehydrogenase (ubiquinone) Fe-S protein 3 [EC:7.1.1.2 1.6.99.3] K03936 M00143 NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria 0,0
+NDUFS4; NADH dehydrogenase (ubiquinone) Fe-S protein 4 K03937 M00143 NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria 0,0
+NDUFS5; NADH dehydrogenase (ubiquinone) Fe-S protein 5 K03938 M00143 NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria 0,0
+NDUFS6; NADH dehydrogenase (ubiquinone) Fe-S protein 6 K03939 M00143 NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria 0,0
+NDUFS7; NADH dehydrogenase (ubiquinone) Fe-S protein 7 [EC:7.1.1.2 1.6.99.3] K03940 M00143 NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria 0,0
+NDUFS8; NADH dehydrogenase (ubiquinone) Fe-S protein 8 [EC:7.1.1.2 1.6.99.3] K03941 M00143 NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria 0,0
+NDUFV1; NADH dehydrogenase (ubiquinone) flavoprotein 1 [EC:7.1.1.2 1.6.99.3] K03942 M00143 NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria 0,0
+NDUFV2; NADH dehydrogenase (ubiquinone) flavoprotein 2 [EC:7.1.1.2 1.6.99.3] K03943 M00143 NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria 0,0
+NDUFV3; NADH dehydrogenase (ubiquinone) flavoprotein 3 K03944 M00143 NADH dehydrogenase (ubiquinone) Fe-S protein/flavoprotein complex, mitochondria 0,0
+nuoA; NADH-quinone oxidoreductase subunit A [EC:7.1.1.2] K00330 M00144 NADH:quinone oxidoreductase, prokaryotes 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+nuoB; NADH-quinone oxidoreductase subunit B [EC:7.1.1.2] K00331 M00144 NADH:quinone oxidoreductase, prokaryotes 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+nuoC; NADH-quinone oxidoreductase subunit C [EC:7.1.1.2] K00332 M00144 NADH:quinone oxidoreductase, prokaryotes 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+nuoD; NADH-quinone oxidoreductase subunit D [EC:7.1.1.2] K00333 M00144 NADH:quinone oxidoreductase, prokaryotes 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+nuoB; NADH-quinone oxidoreductase subunit B [EC:7.1.1.2] K00331 M00144 NADH:quinone oxidoreductase, prokaryotes 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+nuoCD; NADH-quinone oxidoreductase subunit C/D [EC:7.1.1.2] K13378 M00144 NADH:quinone oxidoreductase, prokaryotes 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+nuoBCD; NADH-quinone oxidoreductase subunit B/C/D [EC:7.1.1.2] K13380 M00144 NADH:quinone oxidoreductase, prokaryotes 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+nuoE; NADH-quinone oxidoreductase subunit E [EC:7.1.1.2] K00334 M00144 NADH:quinone oxidoreductase, prokaryotes 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+nuoF; NADH-quinone oxidoreductase subunit F [EC:7.1.1.2] K00335 M00144 NADH:quinone oxidoreductase, prokaryotes 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+nuoG; NADH-quinone oxidoreductase subunit G [EC:7.1.1.2] K00336 M00144 NADH:quinone oxidoreductase, prokaryotes 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+nuoH; NADH-quinone oxidoreductase subunit H [EC:7.1.1.2] K00337 M00144 NADH:quinone oxidoreductase, prokaryotes 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+nuoI; NADH-quinone oxidoreductase subunit I [EC:7.1.1.2] K00338 M00144 NADH:quinone oxidoreductase, prokaryotes 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+nuoJ; NADH-quinone oxidoreductase subunit J [EC:7.1.1.2] K00339 M00144 NADH:quinone oxidoreductase, prokaryotes 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+nuoK; NADH-quinone oxidoreductase subunit K [EC:7.1.1.2] K00340 M00144 NADH:quinone oxidoreductase, prokaryotes 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+nuoL; NADH-quinone oxidoreductase subunit L [EC:7.1.1.2] K00341 M00144 NADH:quinone oxidoreductase, prokaryotes 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+nuoM; NADH-quinone oxidoreductase subunit M [EC:7.1.1.2] K00342 M00144 NADH:quinone oxidoreductase, prokaryotes 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+nuoLM; NADH-quinone oxidoreductase subunit L/M [EC:7.1.1.2] K15863 M00144 NADH:quinone oxidoreductase, prokaryotes 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+nuoN; NADH-quinone oxidoreductase subunit N [EC:7.1.1.2] K00343 M00144 NADH:quinone oxidoreductase, prokaryotes 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+ndhC; NAD(P)H-quinone oxidoreductase subunit 3 [EC:7.1.1.2] K05574 M00145 NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+ndhK; NAD(P)H-quinone oxidoreductase subunit K [EC:7.1.1.2] K05582 M00145 NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+ndhJ; NAD(P)H-quinone oxidoreductase subunit J [EC:7.1.1.2] K05581 M00145 NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+ndhH; NAD(P)H-quinone oxidoreductase subunit H [EC:7.1.1.2] K05579 M00145 NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+ndhA; NAD(P)H-quinone oxidoreductase subunit 1 [EC:7.1.1.2] K05572 M00145 NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+ndhI; NAD(P)H-quinone oxidoreductase subunit I [EC:7.1.1.2] K05580 M00145 NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+ndhG; NAD(P)H-quinone oxidoreductase subunit 6 [EC:7.1.1.2] K05578 M00145 NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+ndhE; NAD(P)H-quinone oxidoreductase subunit 4L [EC:7.1.1.2] K05576 M00145 NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+ndhF; NAD(P)H-quinone oxidoreductase subunit 5 [EC:7.1.1.2] K05577 M00145 NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+ndhD; NAD(P)H-quinone oxidoreductase subunit 4 [EC:7.1.1.2] K05575 M00145 NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+ndhB; NAD(P)H-quinone oxidoreductase subunit 2 [EC:7.1.1.2] K05573 M00145 NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+ndhL; NAD(P)H-quinone oxidoreductase subunit L [EC:7.1.1.2] K05583 M00145 NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+ndhM; NAD(P)H-quinone oxidoreductase subunit M [EC:7.1.1.2] K05584 M00145 NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+ndhN; NAD(P)H-quinone oxidoreductase subunit N [EC:7.1.1.2] K05585 M00145 NAD(P)H:quinone oxidoreductase, chloroplasts and cyanobacteria 0,0 C00390,C00003 Ubiquinol,NAD+ C00399,C00004 Ubiquinone,NADH
+NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 1 K03945 M00146 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 2 K03946 M00146 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 3 K03947 M00146 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 4 K03948 M00146 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 5 K03949 M00146 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 6 K03950 M00146 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 7 K03951 M00146 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 8 K03952 M00146 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 9 K03953 M00146 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 10 K03954 M00146 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 alpha/beta subcomplex 1 K03955 M00146 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 0,0
+NADH-ubiquinone oxidoreductase subunit K03956 M00146 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 12 K11352 M00146 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 13 K11353 M00146 NADH dehydrogenase (ubiquinone) 1 alpha subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 beta subcomplex 1 K03957 M00147 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 beta subcomplex 2 K03958 M00147 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 beta subcomplex 3 K03959 M00147 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 beta subcomplex 4 K03960 M00147 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 beta subcomplex 5 K03961 M00147 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 beta subcomplex 6 K03962 M00147 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 beta subcomplex 7 K03963 M00147 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 beta subcomplex 8 K03964 M00147 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 beta subcomplex 9 K03965 M00147 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 beta subcomplex 10 K03966 M00147 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 beta subcomplex 11 K11351 M00147 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 subcomplex unknown 1 K03967 M00147 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 0,0
+NADH dehydrogenase (ubiquinone) 1 subcomplex unknown 2 K03968 M00147 NADH dehydrogenase (ubiquinone) 1 beta subcomplex 0,0
+SDHC; succinate dehydrogenase (ubiquinone) cytochrome b560 subunit K00236 M00148 Succinate dehydrogenase (ubiquinone) 0,0 C00390,C00122 Ubiquinol,Fumarate C00399,C00042 Ubiquinone,Succinate
+SDHD; succinate dehydrogenase (ubiquinone) membrane anchor subunit K00237 M00148 Succinate dehydrogenase (ubiquinone) 0,0 C00390,C00122 Ubiquinol,Fumarate C00399,C00042 Ubiquinone,Succinate
+SDHA; succinate dehydrogenase (ubiquinone) flavoprotein subunit [EC:1.3.5.1] K00234 M00148 Succinate dehydrogenase (ubiquinone) 0,0 C00390,C00122 Ubiquinol,Fumarate C00399,C00042 Ubiquinone,Succinate
+SDHB; succinate dehydrogenase (ubiquinone) iron-sulfur subunit [EC:1.3.5.1] K00235 M00148 Succinate dehydrogenase (ubiquinone) 0,0 C00390,C00122 Ubiquinol,Fumarate C00399,C00042 Ubiquinone,Succinate
+sdhC; succinate dehydrogenase cytochrome b556 subunit K00241 M00149 Succinate dehydrogenase, prokaryotes 0,0 C00122,C15603 Fumarate,Hydroquinone C00042,C15602 Succinate,Quinone
+sdhD; succinate dehydrogenase membrane anchor subunit K00242 M00149 Succinate dehydrogenase, prokaryotes 0,0 C00122,C15603 Fumarate,Hydroquinone C00042,C15602 Succinate,Quinone
+sdhA; succinate dehydrogenase flavoprotein subunit [EC:1.3.5.1] K00239 M00149 Succinate dehydrogenase, prokaryotes 0,0 C00122,C15603 Fumarate,Hydroquinone C00042,C15602 Succinate,Quinone
+sdhB; succinate dehydrogenase iron-sulfur subunit [EC:1.3.5.1] K00240 M00149 Succinate dehydrogenase, prokaryotes 0,0 C00122,C15603 Fumarate,Hydroquinone C00042,C15602 Succinate,Quinone
+frdA; fumarate reductase flavoprotein subunit [EC:1.3.5.4] K00244 M00150 Fumarate reductase, prokaryotes 0,0 C00122,C15603 Fumarate,Hydroquinone C00042,C15602 Succinate,Quinone
+frdB; fumarate reductase iron-sulfur subunit [EC:1.3.5.4] K00245 M00150 Fumarate reductase, prokaryotes 0,0 C00122,C15603 Fumarate,Hydroquinone C00042,C15602 Succinate,Quinone
+frdC; fumarate reductase subunit C K00246 M00150 Fumarate reductase, prokaryotes 0,0 C00122,C15603 Fumarate,Hydroquinone C00042,C15602 Succinate,Quinone
+frdD; fumarate reductase subunit D K00247 M00150 Fumarate reductase, prokaryotes 0,0 C00122,C15603 Fumarate,Hydroquinone C00042,C15602 Succinate,Quinone
+CYTB; ubiquinol-cytochrome c reductase cytochrome b subunit K00412 M00151 Cytochrome bc1 complex respiratory unit 0,0
+CYC1; ubiquinol-cytochrome c reductase cytochrome c1 subunit K00413 M00151 Cytochrome bc1 complex respiratory unit 0,0
+fbcH; ubiquinol-cytochrome c reductase cytochrome b/c1 subunit K00410 M00151 Cytochrome bc1 complex respiratory unit 0,0
+UQCRFS1; ubiquinol-cytochrome c reductase iron-sulfur subunit K00411 M00151 Cytochrome bc1 complex respiratory unit 0,0
+MQCRA; menaquinol-cytochrome c reductase iron-sulfur subunit [EC:1.10.2.-] K03886 M00151 Cytochrome bc1 complex respiratory unit 0,1
+MQCRB; menaquinol-cytochrome c reductase cytochrome b subunit K03887 M00151 Cytochrome bc1 complex respiratory unit 0,1
+MQCRC; menaquinol-cytochrome c reductase cytochrome b/c subunit K03888 M00151 Cytochrome bc1 complex respiratory unit 0,1
+qcrA; ubiquinol-cytochrome c reductase iron-sulfur subunit K03890 M00151 Cytochrome bc1 complex respiratory unit 0,2
+qcrB; ubiquinol-cytochrome c reductase cytochrome b subunit K03891 M00151 Cytochrome bc1 complex respiratory unit 0,2
+qcrC; ubiquinol-cytochrome c reductase cytochrome c subunit K03889 M00151 Cytochrome bc1 complex respiratory unit 0,2
+CYTB; ubiquinol-cytochrome c reductase cytochrome b subunit K00412 M00152 Cytochrome bc1 complex 0,0
+CYC1; ubiquinol-cytochrome c reductase cytochrome c1 subunit K00413 M00152 Cytochrome bc1 complex 0,0
+FBCH; ubiquinol-cytochrome c reductase cytochrome b/c1 subunit K00410 M00152 Cytochrome bc1 complex 0,0
+UQCRFS1; ubiquinol-cytochrome c reductase iron-sulfur subunit K00411 M00152 Cytochrome bc1 complex 0,0
+QCR1; ubiquinol-cytochrome c reductase core subunit 1 K00414 M00152 Cytochrome bc1 complex 0,0
+QCR2; ubiquinol-cytochrome c reductase core subunit 2 K00415 M00152 Cytochrome bc1 complex 0,0
+QCR6; ubiquinol-cytochrome c reductase subunit 6 K00416 M00152 Cytochrome bc1 complex 0,0
+QCR7; ubiquinol-cytochrome c reductase subunit 7 K00417 M00152 Cytochrome bc1 complex 0,0
+QCR8; ubiquinol-cytochrome c reductase subunit 8 K00418 M00152 Cytochrome bc1 complex 0,0
+QCR9; ubiquinol-cytochrome c reductase subunit 9 K00419 M00152 Cytochrome bc1 complex 0,0
+QCR10; ubiquinol-cytochrome c reductase subunit 10 K00420 M00152 Cytochrome bc1 complex 0,0
+cytochrome bd ubiquinol oxidase subunit I [EC:1.10.3.14] K00425 M00153 Cytochrome bd ubiquinol oxidase 0,0
+cytochrome bd ubiquinol oxidase subunit II [EC:1.10.3.14] K00426 M00153 Cytochrome bd ubiquinol oxidase 0,0
+cydX; cytochrome bd-I ubiquinol oxidase subunit X [EC:1.10.3.14] K00424 M00153 Cytochrome bd ubiquinol oxidase 0,0
+appX; cytochrome bd-II ubiquinol oxidase subunit AppX [EC:1.10.3.14] K22501 M00153 Cytochrome bd ubiquinol oxidase 0,0
+COX10; protoheme IX farnesyltransferase [EC:2.5.1.-] K02257 M00154 Cytochrome c oxidase 0,0
+COX3; cytochrome c oxidase subunit 3 K02262 M00154 Cytochrome c oxidase 0,0
+COX1; cytochrome c oxidase subunit 1 [EC:1.9.3.1] K02256 M00154 Cytochrome c oxidase 0,0
+COX2; cytochrome c oxidase subunit 2 K02261 M00154 Cytochrome c oxidase 0,0
+COX4; cytochrome c oxidase subunit 4 K02263 M00154 Cytochrome c oxidase 0,0
+COX5A; cytochrome c oxidase subunit 5a K02264 M00154 Cytochrome c oxidase 0,0
+COX5B; cytochrome c oxidase subunit 5b K02265 M00154 Cytochrome c oxidase 0,0
+COX6A; cytochrome c oxidase subunit 6a K02266 M00154 Cytochrome c oxidase 0,0
+COX6B; cytochrome c oxidase subunit 6b K02267 M00154 Cytochrome c oxidase 0,0
+COX6C; cytochrome c oxidase subunit 6c K02268 M00154 Cytochrome c oxidase 0,0
+COX7; cytochrome c oxidase subunit 7 K02269 M00154 Cytochrome c oxidase 0,0
+COX7A; cytochrome c oxidase subunit 7a K02270 M00154 Cytochrome c oxidase 0,0
+COX7B; cytochrome c oxidase subunit 7b K02271 M00154 Cytochrome c oxidase 0,0
+COX7C; cytochrome c oxidase subunit 7c K02272 M00154 Cytochrome c oxidase 0,0
+COX8; cytochrome c oxidase subunit 8 K02273 M00154 Cytochrome c oxidase 0,0
+COX11; cytochrome c oxidase assembly protein subunit 11 K02258 M00154 Cytochrome c oxidase 0,0
+COX15; cytochrome c oxidase assembly protein subunit 15 K02259 M00154 Cytochrome c oxidase 0,0
+COX17; cytochrome c oxidase assembly protein subunit 17 K02260 M00154 Cytochrome c oxidase 0,0
+coxB; cytochrome c oxidase subunit II [EC:1.9.3.1] K02275 M00155 Cytochrome c oxidase, prokaryotes 0,0
+coxA; cytochrome c oxidase subunit I [EC:1.9.3.1] K02274 M00155 Cytochrome c oxidase, prokaryotes 0,0
+coxC; cytochrome c oxidase subunit III [EC:1.9.3.1] K02276 M00155 Cytochrome c oxidase, prokaryotes 0,0
+coxAC; cytochrome c oxidase subunit I+III [EC:1.9.3.1] K15408 M00155 Cytochrome c oxidase, prokaryotes 0,0
+coxD; cytochrome c oxidase subunit IV [EC:1.9.3.1] K02277 M00155 Cytochrome c oxidase, prokaryotes 0,0
+ccoN; cb-type cytochrome c oxidase subunit I [EC:1.9.3.1] K00404 M00156 Cytochrome c oxidase, cbb3-type 0,0
+ccoO; cb-type cytochrome c oxidase subunit II K00405 M00156 Cytochrome c oxidase, cbb3-type 0,0
+ccoNO; cbb3-type cytochrome c oxidase subunit I/II K15862 M00156 Cytochrome c oxidase, cbb3-type 0,0
+ccoQ; cb-type cytochrome c oxidase subunit IV K00407 M00156 Cytochrome c oxidase, cbb3-type 0,0
+ccoP; cb-type cytochrome c oxidase subunit III K00406 M00156 Cytochrome c oxidase, cbb3-type 0,0
+ATPF1A; F-type H+-transporting ATPase subunit alpha [EC:7.1.2.2] K02111 M00157 F-type ATPase, prokaryotes and chloroplasts 0,0
+ATPF1B; F-type H+-transporting ATPase subunit beta [EC:7.1.2.2] K02112 M00157 F-type ATPase, prokaryotes and chloroplasts 0,0
+ATPF1D; F-type H+-transporting ATPase subunit delta K02113 M00157 F-type ATPase, prokaryotes and chloroplasts 0,0
+ATPF1E; F-type H+-transporting ATPase subunit epsilon K02114 M00157 F-type ATPase, prokaryotes and chloroplasts 0,0
+ATPF1G; F-type H+-transporting ATPase subunit gamma K02115 M00157 F-type ATPase, prokaryotes and chloroplasts 0,0
+ATPF0A; F-type H+-transporting ATPase subunit a K02108 M00157 F-type ATPase, prokaryotes and chloroplasts 0,0
+ATPF0B; F-type H+-transporting ATPase subunit b K02109 M00157 F-type ATPase, prokaryotes and chloroplasts 0,0
+ATPF0C; F-type H+-transporting ATPase subunit c K02110 M00157 F-type ATPase, prokaryotes and chloroplasts 0,0
+ATPeF1A; F-type H+-transporting ATPase subunit alpha K02132 M00158 F-type ATPase, eukaryotes 0,0
+ATPeF1B; F-type H+-transporting ATPase subunit beta [EC:3.6.3.14] K02133 M00158 F-type ATPase, eukaryotes 0,0
+ATPeF1G; F-type H+-transporting ATPase subunit gamma K02136 M00158 F-type ATPase, eukaryotes 0,0
+ATPeF1D; F-type H+-transporting ATPase subunit delta K02134 M00158 F-type ATPase, eukaryotes 0,0
+ATPeF1E; F-type H+-transporting ATPase subunit epsilon K02135 M00158 F-type ATPase, eukaryotes 0,0
+ATPeF0O; F-type H+-transporting ATPase subunit O K02137 M00158 F-type ATPase, eukaryotes 0,0
+ATPeF0A; F-type H+-transporting ATPase subunit a K02126 M00158 F-type ATPase, eukaryotes 0,0
+ATPeF0B; F-type H+-transporting ATPase subunit b K02127 M00158 F-type ATPase, eukaryotes 0,0
+ATPeF0C; F-type H+-transporting ATPase subunit c K02128 M00158 F-type ATPase, eukaryotes 0,0
+ATPeFD; F-type H+-transporting ATPase subunit d K02138 M00158 F-type ATPase, eukaryotes 0,0
+ATPeF0E; F-type H+-transporting ATPase subunit e K02129 M00158 F-type ATPase, eukaryotes 0,0
+TIM11; F-type H+-transporting ATP synthase subunit e K01549 M00158 F-type ATPase, eukaryotes 0,0
+ATPeF0F; F-type H+-transporting ATPase subunit f K02130 M00158 F-type ATPase, eukaryotes 0,0
+ATPeFF; F-type H+-transporting ATPase subunit f K02139 M00158 F-type ATPase, eukaryotes 0,0
+ATPeFG; F-type H+-transporting ATPase subunit g K02140 M00158 F-type ATPase, eukaryotes 0,0
+ATPeFH; F-type H+-transporting ATPase subunit h K02141 M00158 F-type ATPase, eukaryotes 0,0
+ATPeF0F6; F-type H+-transporting ATPase subunit 6 K02131 M00158 F-type ATPase, eukaryotes 0,0
+ATPeFJ; F-type H+-transporting ATPase subunit j K02142 M00158 F-type ATPase, eukaryotes 0,0
+ATPeFK; F-type H+-transporting ATPase subunit k K02143 M00158 F-type ATPase, eukaryotes 0,0
+ATPeF08; F-type H+-transporting ATPase subunit 8 K02125 M00158 F-type ATPase, eukaryotes 0,0
+ATPVA; V/A-type H+-transporting ATPase subunit A [EC:3.6.3.14] K02117 M00159 V/A-type ATPase, prokaryotes 0,0
+ATPVB; V/A-type H+-transporting ATPase subunit B K02118 M00159 V/A-type ATPase, prokaryotes 0,0
+ATPVC; V/A-type H+-transporting ATPase subunit C K02119 M00159 V/A-type ATPase, prokaryotes 0,0
+ATPVD; V/A-type H+-transporting ATPase subunit D K02120 M00159 V/A-type ATPase, prokaryotes 0,0
+ATPVE; V/A-type H+-transporting ATPase subunit E K02121 M00159 V/A-type ATPase, prokaryotes 0,0
+ATPVF; V/A-type H+-transporting ATPase subunit F K02122 M00159 V/A-type ATPase, prokaryotes 0,0
+ATPVG; V/A-type H+-transporting ATPase subunit G/H K02107 M00159 V/A-type ATPase, prokaryotes 0,0
+ATPVI; V/A-type H+-transporting ATPase subunit I K02123 M00159 V/A-type ATPase, prokaryotes 0,0
+ATPVK; V/A-type H+-transporting ATPase subunit K K02124 M00159 V/A-type ATPase, prokaryotes 0,0
+ATPeV1A; V-type H+-transporting ATPase subunit A [EC:3.6.3.14] K02145 M00160 V-type ATPase, eukaryotes 0,0
+ATPeV1B; V-type H+-transporting ATPase subunit B K02147 M00160 V-type ATPase, eukaryotes 0,0
+ATPeV1C; V-type H+-transporting ATPase subunit C K02148 M00160 V-type ATPase, eukaryotes 0,0
+ATPeV1D; V-type H+-transporting ATPase subunit D K02149 M00160 V-type ATPase, eukaryotes 0,0
+ATPeV1E; V-type H+-transporting ATPase subunit E K02150 M00160 V-type ATPase, eukaryotes 0,0
+ATPeV1F; V-type H+-transporting ATPase subunit F K02151 M00160 V-type ATPase, eukaryotes 0,0
+ATPeV1G; V-type H+-transporting ATPase subunit G K02152 M00160 V-type ATPase, eukaryotes 0,0
+ATPeV1H; V-type H+-transporting ATPase subunit H K02144 M00160 V-type ATPase, eukaryotes 0,0
+ATPeV0A; V-type H+-transporting ATPase subunit a K02154 M00160 V-type ATPase, eukaryotes 0,0
+ATPeV0B; V-type H+-transporting ATPase 21kDa proteolipid subunit K03661 M00160 V-type ATPase, eukaryotes 0,0
+ATPeV0C; V-type H+-transporting ATPase 16kDa proteolipid subunit K02155 M00160 V-type ATPase, eukaryotes 0,0
+ATPeV0D; V-type H+-transporting ATPase subunit d K02146 M00160 V-type ATPase, eukaryotes 0,0
+ATPeV0E; V-type H+-transporting ATPase subunit e K02153 M00160 V-type ATPase, eukaryotes 0,0
+ATPeVS1; V-type H+-transporting ATPase S1 subunit K03662 M00160 V-type ATPase, eukaryotes 0,0
+psbA; photosystem II reaction center D1 protein [EC:1.10.3.9] K02703 M00161 Photosystem II 0,0
+psbD; photosystem II reaction center D2 protein [EC:1.10.3.9] K02706 M00161 Photosystem II 0,0
+psbC; photosystem II CP43 chlorophyll apoprotein K02705 M00161 Photosystem II 0,0
+psbB; photosystem II CP47 chlorophyll apoprotein K02704 M00161 Photosystem II 0,0
+psbE; photosystem II cytochrome b559 subunit alpha K02707 M00161 Photosystem II 0,0
+psbF; photosystem II cytochrome b559 subunit beta K02708 M00161 Photosystem II 0,0
+cytochrome b6 K02635 M00162 Cytochrome b6f complex 0,0
+cytochrome b6-f complex subunit 4 K02637 M00162 Cytochrome b6f complex 0,0
+apocytochrome f K02634 M00162 Cytochrome b6f complex 0,0
+cytochrome b6-f complex iron-sulfur subunit K02636 M00162 Cytochrome b6f complex 0,0
+cytochrome b6-f complex subunit 6 K02642 M00162 Cytochrome b6f complex 0,0
+cytochrome b6-f complex subunit 7 K02643 M00162 Cytochrome b6f complex 0,0
+cytochrome b6-f complex subunit 8 K03689 M00162 Cytochrome b6f complex 0,0
+cytochrome b6-f complex subunit 5 K02640 M00162 Cytochrome b6f complex 0,0
+psaA; photosystem I P700 chlorophyll a apoprotein A1 K02689 M00163 Photosystem I 0,0
+psaB; photosystem I P700 chlorophyll a apoprotein A2 K02690 M00163 Photosystem I 0,0
+psaC; photosystem I subunit VII K02691 M00163 Photosystem I 0,0
+psaD; photosystem I subunit II K02692 M00163 Photosystem I 0,0
+psaE; photosystem I subunit IV K02693 M00163 Photosystem I 0,0
+psaF; photosystem I subunit III K02694 M00163 Photosystem I 0,0
+phosphoribulokinase [EC:2.7.1.19] [RN:R01523] K00855 M00165 Reductive pentose phosphate cycle (Calvin cycle) 0,0 C01182 D-Ribulose 1,5-bisphosphate C00199 D-Ribulose 5-phosphate
+ribulose-bisphosphate carboxylase [EC:4.1.1.39] [RN:R00024] K01601 M00165 Reductive pentose phosphate cycle (Calvin cycle) 1,0 C00197 3-Phospho-D-glycerate C01182,C00011 D-Ribulose 1,5-bisphosphate,CO2
+ribulose-bisphosphate carboxylase [EC:4.1.1.39] [RN:R00024] K01602 M00165 Reductive pentose phosphate cycle (Calvin cycle) 1,0 C00197 3-Phospho-D-glycerate C01182,C00011 D-Ribulose 1,5-bisphosphate,CO2
+phosphoglycerate kinase [EC:2.7.2.3] [RN:R01512] K00927 M00165 Reductive pentose phosphate cycle (Calvin cycle) 2,0 C00236 3-Phospho-D-glyceroyl phosphate C00197 3-Phospho-D-glycerate
+glyceraldehyde-3-phosphate dehydrogenase (phosphorylating) [EC:1.2.1.13 1.2.1.59 1.2.1.12] [RN:R01061 R01063] K05298 M00165 Reductive pentose phosphate cycle (Calvin cycle) 3,0 C00118 D-Glyceraldehyde 3-phosphate C00236 3-Phospho-D-glyceroyl phosphate
+glyceraldehyde-3-phosphate dehydrogenase (phosphorylating) [EC:1.2.1.13 1.2.1.59 1.2.1.12] [RN:R01061 R01063] K00150 M00165 Reductive pentose phosphate cycle (Calvin cycle) 3,1 C00118 D-Glyceraldehyde 3-phosphate C00236 3-Phospho-D-glyceroyl phosphate
+glyceraldehyde-3-phosphate dehydrogenase (phosphorylating) [EC:1.2.1.13 1.2.1.59 1.2.1.12] [RN:R01061 R01063] K00134 M00165 Reductive pentose phosphate cycle (Calvin cycle) 3,2 C00118 D-Glyceraldehyde 3-phosphate C00236 3-Phospho-D-glyceroyl phosphate
+fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01068 R01829] K01623 M00165 Reductive pentose phosphate cycle (Calvin cycle) 4,0 C00447 Sedoheptulose 1,7-bisphosphate C00279 D-Erythrose 4-phosphate
+fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01068 R01829] K01624 M00165 Reductive pentose phosphate cycle (Calvin cycle) 4,1 C00447 Sedoheptulose 1,7-bisphosphate C00279 D-Erythrose 4-phosphate
+fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762] K03841 M00165 Reductive pentose phosphate cycle (Calvin cycle) 5,0 C00085 D-Fructose 6-phosphate C00354 D-Fructose 1,6-bisphosphate
+fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762] K02446 M00165 Reductive pentose phosphate cycle (Calvin cycle) 5,1 C00085 D-Fructose 6-phosphate C00354 D-Fructose 1,6-bisphosphate
+fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762] K11532 M00165 Reductive pentose phosphate cycle (Calvin cycle) 5,2 C00085 D-Fructose 6-phosphate C00354 D-Fructose 1,6-bisphosphate
+fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762] K01086 M00165 Reductive pentose phosphate cycle (Calvin cycle) 5,3 C00085 D-Fructose 6-phosphate C00354 D-Fructose 1,6-bisphosphate
+fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762] K04041 M00165 Reductive pentose phosphate cycle (Calvin cycle) 5,4 C00085 D-Fructose 6-phosphate C00354 D-Fructose 1,6-bisphosphate
+transketolase [EC:2.2.1.1] [RN:R01067 R01641] K00615 M00165 Reductive pentose phosphate cycle (Calvin cycle) 6,0 C00117 D-Ribose 5-phosphate C05382 Sedoheptulose 7-phosphate
+fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01068 R01829] K01623 M00165 Reductive pentose phosphate cycle (Calvin cycle) 7,0 C00447 Sedoheptulose 1,7-bisphosphate C00279 D-Erythrose 4-phosphate
+fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01068 R01829] K01624 M00165 Reductive pentose phosphate cycle (Calvin cycle) 7,1 C00447 Sedoheptulose 1,7-bisphosphate C00279 D-Erythrose 4-phosphate
+sedoheptulose-bisphosphatase [EC:3.1.3.37] [RN:R01845] K01100 M00165 Reductive pentose phosphate cycle (Calvin cycle) 8,0 C05382 Sedoheptulose 7-phosphate C00447 Sedoheptulose 1,7-bisphosphate
+fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762] K11532 M00165 Reductive pentose phosphate cycle (Calvin cycle) 8,1 C00085 D-Fructose 6-phosphate C00354 D-Fructose 1,6-bisphosphate
+fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762] K01086 M00165 Reductive pentose phosphate cycle (Calvin cycle) 8,2 C00085 D-Fructose 6-phosphate C00354 D-Fructose 1,6-bisphosphate
+transketolase [EC:2.2.1.1] [RN:R01067 R01641] K00615 M00165 Reductive pentose phosphate cycle (Calvin cycle) 9,0 C00117 D-Ribose 5-phosphate C05382 Sedoheptulose 7-phosphate
+ribose 5-phosphate isomerase [EC:5.3.1.6] [RN:R01056] K01807 M00165 Reductive pentose phosphate cycle (Calvin cycle) 10,0 C00199 D-Ribulose 5-phosphate C00117 D-Ribose 5-phosphate
+ribose 5-phosphate isomerase [EC:5.3.1.6] [RN:R01056] K01808 M00165 Reductive pentose phosphate cycle (Calvin cycle) 10,1 C00199 D-Ribulose 5-phosphate C00117 D-Ribose 5-phosphate
+phosphoribulokinase [EC:2.7.1.19] [RN:R01523] K00855 M00166 Reductive pentose phosphate cycle, ribulose-5P => glyceraldehyde-3P 0,0 C01182 D-Ribulose 1,5-bisphosphate C00199 D-Ribulose 5-phosphate
+ribulose-bisphosphate carboxylase [EC:4.1.1.39] [RN:R00024] K01601 M00166 Reductive pentose phosphate cycle, ribulose-5P => glyceraldehyde-3P 1,0 C00197 3-Phospho-D-glycerate C01182,C00011 D-Ribulose 1,5-bisphosphate,CO2
+ribulose-bisphosphate carboxylase [EC:4.1.1.39] [RN:R00024] K01602 M00166 Reductive pentose phosphate cycle, ribulose-5P => glyceraldehyde-3P 1,0 C00197 3-Phospho-D-glycerate C01182,C00011 D-Ribulose 1,5-bisphosphate,CO2
+phosphoglycerate kinase [EC:2.7.2.3] [RN:R01512] K00927 M00166 Reductive pentose phosphate cycle, ribulose-5P => glyceraldehyde-3P 2,0 C00236 3-Phospho-D-glyceroyl phosphate C00197 3-Phospho-D-glycerate
+glyceraldehyde-3-phosphate dehydrogenase (phosphorylating) [EC:1.2.1.13 1.2.1.59 1.2.1.12] [RN:R01061 R01063] K05298 M00166 Reductive pentose phosphate cycle, ribulose-5P => glyceraldehyde-3P 3,0 C00118 D-Glyceraldehyde 3-phosphate C00236 3-Phospho-D-glyceroyl phosphate
+glyceraldehyde-3-phosphate dehydrogenase (phosphorylating) [EC:1.2.1.13 1.2.1.59 1.2.1.12] [RN:R01061 R01063] K00150 M00166 Reductive pentose phosphate cycle, ribulose-5P => glyceraldehyde-3P 3,1 C00118 D-Glyceraldehyde 3-phosphate C00236 3-Phospho-D-glyceroyl phosphate
+glyceraldehyde-3-phosphate dehydrogenase (phosphorylating) [EC:1.2.1.13 1.2.1.59 1.2.1.12] [RN:R01061 R01063] K00134 M00166 Reductive pentose phosphate cycle, ribulose-5P => glyceraldehyde-3P 3,2 C00118 D-Glyceraldehyde 3-phosphate C00236 3-Phospho-D-glyceroyl phosphate
+fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01068 R01829] K01623 M00167 Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P 0,0 C00447 Sedoheptulose 1,7-bisphosphate C00279 D-Erythrose 4-phosphate
+fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01068 R01829] K01624 M00167 Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P 0,1 C00447 Sedoheptulose 1,7-bisphosphate C00279 D-Erythrose 4-phosphate
+fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762] K03841 M00167 Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P 1,0 C00085 D-Fructose 6-phosphate C00354 D-Fructose 1,6-bisphosphate
+fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762] K02446 M00167 Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P 1,1 C00085 D-Fructose 6-phosphate C00354 D-Fructose 1,6-bisphosphate
+fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762] K11532 M00167 Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P 1,2 C00085 D-Fructose 6-phosphate C00354 D-Fructose 1,6-bisphosphate
+fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762] K01086 M00167 Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P 1,3 C00085 D-Fructose 6-phosphate C00354 D-Fructose 1,6-bisphosphate
+fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762] K04041 M00167 Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P 1,4 C00085 D-Fructose 6-phosphate C00354 D-Fructose 1,6-bisphosphate
+transketolase [EC:2.2.1.1] [RN:R01067 R01641] K00615 M00167 Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P 2,0 C00117 D-Ribose 5-phosphate C05382 Sedoheptulose 7-phosphate
+fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01068 R01829] K01623 M00167 Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P 3,0 C00447 Sedoheptulose 1,7-bisphosphate C00279 D-Erythrose 4-phosphate
+fructose-bisphosphate aldolase [EC:4.1.2.13] [RN:R01068 R01829] K01624 M00167 Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P 3,1 C00447 Sedoheptulose 1,7-bisphosphate C00279 D-Erythrose 4-phosphate
+sedoheptulose-bisphosphatase [EC:3.1.3.37] [RN:R01845] K01100 M00167 Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P 4,0 C05382 Sedoheptulose 7-phosphate C00447 Sedoheptulose 1,7-bisphosphate
+fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762] K11532 M00167 Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P 4,1 C00085 D-Fructose 6-phosphate C00354 D-Fructose 1,6-bisphosphate
+fructose-1,6-bisphosphatase [EC:3.1.3.11] [RN:R00762] K01086 M00167 Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P 4,2 C00085 D-Fructose 6-phosphate C00354 D-Fructose 1,6-bisphosphate
+transketolase [EC:2.2.1.1] [RN:R01067 R01641] K00615 M00167 Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P 5,0 C00117 D-Ribose 5-phosphate C05382 Sedoheptulose 7-phosphate
+ribose 5-phosphate isomerase [EC:5.3.1.6] [RN:R01056] K01807 M00167 Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P 6,0 C00199 D-Ribulose 5-phosphate C00117 D-Ribose 5-phosphate
+ribose 5-phosphate isomerase [EC:5.3.1.6] [RN:R01056] K01808 M00167 Reductive pentose phosphate cycle, glyceraldehyde-3P => ribulose-5P 6,1 C00199 D-Ribulose 5-phosphate C00117 D-Ribose 5-phosphate
+phosphoenolpyruvate carboxylase [EC:4.1.1.31] [RN:R00345] K01595 M00168 CAM (Crassulacean acid metabolism), dark 0,0 C00036 Oxaloacetate C00074,C00011 Phosphoenolpyruvate,CO2
+malate dehydrogenase [EC:1.1.1.37] [RN:R00342] K00025 M00168 CAM (Crassulacean acid metabolism), dark 1,0 C00149 (S)-Malate C00036 Oxaloacetate
+malate dehydrogenase [EC:1.1.1.37] [RN:R00342] K00026 M00168 CAM (Crassulacean acid metabolism), dark 1,1 C00149 (S)-Malate C00036 Oxaloacetate
+malate dehydrogenase [EC:1.1.1.37] [RN:R00342] K00024 M00168 CAM (Crassulacean acid metabolism), dark 1,2 C00149 (S)-Malate C00036 Oxaloacetate
+malate dehydrogenase (oxaloacetate-decarboxylating)(NADP+) [EC:1.1.1.40] [RN:R00216] K00029 M00169 CAM (Crassulacean acid metabolism), light 0,0 C00022,C00011 Pyruvate,CO2 C00149 (S)-Malate
+pyruvate,orthophosphate dikinase [EC:2.7.9.1] [RN:R00206] K01006 M00169 CAM (Crassulacean acid metabolism), light 1,0 C00074 Phosphoenolpyruvate C00022 Pyruvate
+phosphoenolpyruvate carboxylase [EC:4.1.1.31] [RN:R00345] K01595 M00170 C4-dicarboxylic acid cycle, phosphoenolpyruvate carboxykinase type 0,0 C00036 Oxaloacetate C00074 Phosphoenolpyruvate
+aspartate aminotransferase [EC:2.6.1.1] [RN:R00355] K14454 M00170 C4-dicarboxylic acid cycle, phosphoenolpyruvate carboxykinase type 1,0 C00036 Oxaloacetate C00049 L-Aspartate
+aspartate aminotransferase, mitochondrial [EC:2.6.1.1] [RN:R00355] K14455 M00170 C4-dicarboxylic acid cycle, phosphoenolpyruvate carboxykinase type 2,0 C00036 Oxaloacetate C00049 L-Aspartate
+phosphoenolpyruvate carboxykinase (ATP) [EC:4.1.1.49] [RN:R00341] K01610 M00170 C4-dicarboxylic acid cycle, phosphoenolpyruvate carboxykinase type 3,0 C00074,C00011 Phosphoenolpyruvate,CO2 C00036 Oxaloacetate
+phosphoenolpyruvate carboxylase [EC:4.1.1.31] [RN:R00345] K01595 M00171 C4-dicarboxylic acid cycle, NAD - malic enzyme type 0,0 C00036 Oxaloacetate C00074 Phosphoenolpyruvate
+aspartate aminotransferase [EC:2.6.1.1] [RN:R00355] K14454 M00171 C4-dicarboxylic acid cycle, NAD - malic enzyme type 1,0 C00036 Oxaloacetate C00049 L-Aspartate
+aspartate aminotransferase [EC:2.6.1.1] [RN:R00355] K14455 M00171 C4-dicarboxylic acid cycle, NAD - malic enzyme type 2,0 C00036 Oxaloacetate C00049 L-Aspartate
+malate dehydrogenase [EC:1.1.1.37] [RN:R00342] K00025 M00171 C4-dicarboxylic acid cycle, NAD - malic enzyme type 3,0 C00149 (S)-Malate C00036 Oxaloacetate
+malate dehydrogenase [EC:1.1.1.37] [RN:R00342] K00026 M00171 C4-dicarboxylic acid cycle, NAD - malic enzyme type 3,1 C00149 (S)-Malate C00036 Oxaloacetate
+malate dehydrogenase (decarboxylating) [EC:1.1.1.39] [RN:R00214] K00028 M00171 C4-dicarboxylic acid cycle, NAD - malic enzyme type 4,0 C00022,C00011 Pyruvate,CO2 C00149 (S)-Malate
+alanine transaminase [EC:2.6.1.2] [RN:R00258] K00814 M00171 C4-dicarboxylic acid cycle, NAD - malic enzyme type 5,0 C00022 Pyruvate C00041 L-Alanine
+glutamate--glyoxylate aminotransferase [EC:2.6.1.2] [RN:R00258] K14272 M00171 C4-dicarboxylic acid cycle, NAD - malic enzyme type 5,1 C00022 Pyruvate C00041 L-Alanine
+pyruvate,orthophosphate dikinase [EC:2.7.9.1] [RN:R00206] K01006 M00171 C4-dicarboxylic acid cycle, NAD - malic enzyme type 6,0 C00074 Phosphoenolpyruvate C00022 Pyruvate
+phosphoenolpyruvate carboxylase [EC:4.1.1.31] [RN:R00345] K01595 M00172 C4-dicarboxylic acid cycle, NADP - malic enzyme type 0,0 C00036 Oxaloacetate C00074 Phosphoenolpyruvate
+malate dehydrogenase (NADP+) [EC:1.1.1.82] [RN:R00343] K00051 M00172 C4-dicarboxylic acid cycle, NADP - malic enzyme type 1,0 C00149 (S)-Malate C00036 Oxaloacetate
+malate dehydrogenase (oxaloacetate-decarboxylating)(NADP+) [EC:1.1.1.40] [RN:R00216] K00029 M00172 C4-dicarboxylic acid cycle, NADP - malic enzyme type 2,0 C00022,C00011 Pyruvate,CO2 C00149 (S)-Malate
+pyruvate,orthophosphate dikinase [EC:2.7.9.1] [RN:R00206] K01006 M00172 C4-dicarboxylic acid cycle, NADP - malic enzyme type 3,0 C00074 Phosphoenolpyruvate C00022 Pyruvate
+pyruvate:ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] K00169 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 0,0 C00022 Pyruvate C00024 Acetyl-CoA
+pyruvate:ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] K00170 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 0,0 C00022 Pyruvate C00024 Acetyl-CoA
+pyruvate:ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] K00171 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 0,0 C00022 Pyruvate C00024 Acetyl-CoA
+pyruvate:ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] K00172 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 0,0 C00022 Pyruvate C00024 Acetyl-CoA
+pyruvate-ferredoxin/flavodoxin oxidoreductase [EC:1.2.7.1 1.2.7.-] [RN:R01196 R10866] K03737 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 0,1 C00022 Pyruvate C00024 Acetyl-CoA
+pyruvate,water dikinase [EC:2.7.9.2] [RN:R00199] K01007 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 1,0,0,0 C00074 Phosphoenolpyruvate C00022 Pyruvate
+pyruvate,orthophosphate dikinase [EC:2.7.9.1] [RN:R00206] K01006 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 1,0,0,1 C00074 Phosphoenolpyruvate C00022 Pyruvate
+phosphoenolpyruvate carboxylase [EC:4.1.1.31] [RN:R00345] K01595 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 1,0,1,0 C00036 Oxaloacetate C00074 Phosphoenolpyruvate
+pyruvate carboxylase subunit A [EC:6.4.1.1] [RN:R00344] K01959 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 1,1 C00036 Oxaloacetate C00022 Pyruvate
+pyruvate carboxylase subunit A [EC:6.4.1.1] [RN:R00344] K01960 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 1,1 C00036 Oxaloacetate C00022 Pyruvate
+pyruvate carboxylase subunit A [EC:6.4.1.1] [RN:R00344] K01958 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 1,2 C00036 Oxaloacetate C00022 Pyruvate
+malate dehydrogenase [EC:1.1.1.37] [RN:R00342] K00024 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 2,0 C00149 (S)-Malate C00036 Oxaloacetate
+fumarate hydratase [EC:4.2.1.2] [RN:R01082] K01676 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 3,0 C00122 Fumarate C00149 (S)-Malate
+fumarate hydratase [EC:4.2.1.2] [RN:R01082] K01679 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 3,1 C00122 Fumarate C00149 (S)-Malate
+fumarate hydratase [EC:4.2.1.2] [RN:R01082] K01677 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 3,2 C00122 Fumarate C00149 (S)-Malate
+fumarate hydratase [EC:4.2.1.2] [RN:R01082] K01678 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 3,2 C00122 Fumarate C00149 (S)-Malate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K00239 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 4,0 C00042 Succinate C00122 Fumarate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K00240 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 4,0 C00042 Succinate C00122 Fumarate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K00241 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 4,0 C00042 Succinate C00122 Fumarate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K00242 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 4,0 C00042 Succinate C00122 Fumarate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K00244 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 4,1 C00042 Succinate C00122 Fumarate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K00245 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 4,1 C00042 Succinate C00122 Fumarate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K00246 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 4,1 C00042 Succinate C00122 Fumarate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K00247 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 4,1 C00042 Succinate C00122 Fumarate
+NADH-dependent fumarate reductase [EC:1.3.1.6] [RN:R00402] K18556 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 4,2 C00042 Succinate C00122 Fumarate
+NADH-dependent fumarate reductase [EC:1.3.1.6] [RN:R00402] K18557 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 4,2 C00042 Succinate C00122 Fumarate
+NADH-dependent fumarate reductase [EC:1.3.1.6] [RN:R00402] K18558 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 4,2 C00042 Succinate C00122 Fumarate
+NADH-dependent fumarate reductase [EC:1.3.1.6] [RN:R00402] K18559 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 4,2 C00042 Succinate C00122 Fumarate
+NADH-dependent fumarate reductase [EC:1.3.1.6] [RN:R00402] K18560 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 4,2 C00042 Succinate C00122 Fumarate
+succinyl-CoA synthetase [EC:6.2.1.5] [RN:R00405] K01902 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 5,0 C00091 Succinyl-CoA C00042 Succinate
+succinyl-CoA synthetase [EC:6.2.1.5] [RN:R00405] K01903 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 5,0 C00091 Succinyl-CoA C00042 Succinate
+2-oxoglutarate:ferredoxin oxidoreductase [EC:1.2.7.3] [RN:R01197] K00174 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 6,0 C00026 2-Oxoglutarate C00091 Succinyl-CoA
+2-oxoglutarate:ferredoxin oxidoreductase [EC:1.2.7.3] [RN:R01197] K00175 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 6,0 C00026 2-Oxoglutarate C00091 Succinyl-CoA
+2-oxoglutarate:ferredoxin oxidoreductase [EC:1.2.7.3] [RN:R01197] K00177 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 6,0 C00026 2-Oxoglutarate C00091 Succinyl-CoA
+2-oxoglutarate:ferredoxin oxidoreductase [EC:1.2.7.3] [RN:R01197] K00176 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 6,0 C00026 2-Oxoglutarate C00091 Succinyl-CoA
+isocitrate dehydrogenase [EC:1.1.1.42] [RN:R00267] K00031 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 7,0 C00311 Isocitrate C00026 2-Oxoglutarate
+aconitate hydratase [EC:4.2.1.3] [RN:R01900 R01325] K01681 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 8,0 C00158 Citrate C00417 cis-Aconitate
+aconitate hydratase [EC:4.2.1.3] [RN:R01900 R01325] K01682 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 8,1 C00158 Citrate C00417 cis-Aconitate
+ATP-citrate lyase [EC:2.3.3.8] [RN:R00352] K15230 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 9,0 C00024 Acetyl-CoA C00158 Citrate
+ATP-citrate lyase [EC:2.3.3.8] [RN:R00352] K15231 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 9,0 C00024 Acetyl-CoA C00158 Citrate
+citryl-CoA synthetase [EC:6.2.1.18] [RN:R01322] K15232 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 9,1,0,0 C00566 (3S)-Citryl-CoA C00158 Citrate
+citryl-CoA synthetase [EC:6.2.1.18] [RN:R01322] K15233 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 9,1,0,0 C00566 (3S)-Citryl-CoA C00158 Citrate
+citryl-CoA lyase [EC:4.1.3.34] [RN:R00354] K15234 M00173 Reductive citrate cycle (Arnon-Buchanan cycle) 9,1,1,0 C00036,C00024 Oxaloacetate,Acetyl-CoA C00566 (3S)-Citryl-CoA
+methane/ammonia monooxygenase [EC:1.14.18.3] [RN:R09518] K10944 M00174 Methane oxidation, methanotroph, methane => formaldehyde 0,0 C00132 Methanol C01438 Methane
+methane/ammonia monooxygenase [EC:1.14.18.3] [RN:R09518] K10945 M00174 Methane oxidation, methanotroph, methane => formaldehyde 0,0 C00132 Methanol C01438 Methane
+methane/ammonia monooxygenase [EC:1.14.18.3] [RN:R09518] K10946 M00174 Methane oxidation, methanotroph, methane => formaldehyde 0,0 C00132 Methanol C01438 Methane
+methane monooxygenase component A [EC:1.14.13.25] [RN:R01142] K16157 M00174 Methane oxidation, methanotroph, methane => formaldehyde 0,1 C00132 Methanol C01438 Methane
+methane monooxygenase component A [EC:1.14.13.25] [RN:R01142] K16158 M00174 Methane oxidation, methanotroph, methane => formaldehyde 0,1 C00132 Methanol C01438 Methane
+methane monooxygenase component A [EC:1.14.13.25] [RN:R01142] K16159 M00174 Methane oxidation, methanotroph, methane => formaldehyde 0,1 C00132 Methanol C01438 Methane
+methane monooxygenase regulatory protein B [RN:R01142] K16160 M00174 Methane oxidation, methanotroph, methane => formaldehyde 0,1 C00132 Methanol C01438 Methane
+methane monooxygenase component C [EC:1.14.13.25] [RN:R01142] K16161 M00174 Methane oxidation, methanotroph, methane => formaldehyde 0,1 C00132 Methanol C01438 Methane
+methane monooxygenase component D [RN:R01142] K16162 M00174 Methane oxidation, methanotroph, methane => formaldehyde 0,1 C00132 Methanol C01438 Methane
+methanol dehydrogenase [EC:1.1.2.7] [RN:R01146] K14028 M00174 Methane oxidation, methanotroph, methane => formaldehyde 1,0 C00067 Formaldehyde C00132 Methanol
+methanol dehydrogenase [EC:1.1.2.7] [RN:R01146] K14029 M00174 Methane oxidation, methanotroph, methane => formaldehyde 1,0 C00067 Formaldehyde C00132 Methanol
+alcohol oxidase [EC:1.1.3.13] [RN:R00608] K17066 M00174 Methane oxidation, methanotroph, methane => formaldehyde 1,1 C00067 Formaldehyde C00132 Methanol
+nitrogenase iron protein [RN:R05185] K02588 M00175 Nitrogen fixation, nitrogen => ammonia 0,0 C00014 Ammonia C00697 Nitrogen
+nitrogenase molybdenum-iron protein [EC:1.18.6.1] [RN:R05185] K02586 M00175 Nitrogen fixation, nitrogen => ammonia 0,0 C00014 Ammonia C00697 Nitrogen
+nitrogenase molybdenum-iron protein [EC:1.18.6.1] [RN:R05185] K02591 M00175 Nitrogen fixation, nitrogen => ammonia 0,0 C00014 Ammonia C00697 Nitrogen
+nitrogenase delta subunit [EC:1.18.6.1] [RN:R05185] K00531 M00175 Nitrogen fixation, nitrogen => ammonia 0,0 C00014 Ammonia C00697 Nitrogen
+vanadium-dependent nitrogenase [EC:1.18.6.2] [RN:R12084] K22896 M00175 Nitrogen fixation, nitrogen => ammonia 0,1 C00014 Ammonia C00697 Nitrogen
+vanadium-dependent nitrogenase [EC:1.18.6.2] [RN:R12084] K22897 M00175 Nitrogen fixation, nitrogen => ammonia 0,1 C00014 Ammonia C00697 Nitrogen
+vanadium nitrogenase delta subunit [EC:1.18.6.2] [RN:R12084] K22898 M00175 Nitrogen fixation, nitrogen => ammonia 0,1 C00014 Ammonia C00697 Nitrogen
+vanadium nitrogenase iron protein [RN:R12084] K22899 M00175 Nitrogen fixation, nitrogen => ammonia 0,1 C00014 Ammonia C00697 Nitrogen
+sulfate adenylyltransferase [EC:2.7.7.4] [RN:R00529] K13811 M00176 Assimilatory sulfate reduction, sulfate => H2S 0,0 C00224 Adenylyl sulfate C00059 Sulfate
+sulfate adenylyltransferase [EC:2.7.7.4] [RN:R00529] K00958 M00176 Assimilatory sulfate reduction, sulfate => H2S 0,1 C00224 Adenylyl sulfate C00059 Sulfate
+adenylylsulfate kinase [EC:2.7.1.25] [RN:R00509] K00860 M00176 Assimilatory sulfate reduction, sulfate => H2S 0,1 C00053 3'-Phosphoadenylyl sulfate C00224 Adenylyl sulfate
+sulfate adenylyltransferase [EC:2.7.7.4] [RN:R00529] K00955 M00176 Assimilatory sulfate reduction, sulfate => H2S 0,2 C00224 Adenylyl sulfate C00059 Sulfate
+sulfate adenylyltransferase [EC:2.7.7.4] [RN:R00529] K00957 M00176 Assimilatory sulfate reduction, sulfate => H2S 0,2 C00224 Adenylyl sulfate C00059 Sulfate
+sulfate adenylyltransferase [EC:2.7.7.4] [RN:R00529] K00956 M00176 Assimilatory sulfate reduction, sulfate => H2S 0,3 C00224 Adenylyl sulfate C00059 Sulfate
+sulfate adenylyltransferase [EC:2.7.7.4] [RN:R00529] K00957 M00176 Assimilatory sulfate reduction, sulfate => H2S 0,3 C00224 Adenylyl sulfate C00059 Sulfate
+adenylylsulfate kinase [EC:2.7.1.25] [RN:R00509] K00860 M00176 Assimilatory sulfate reduction, sulfate => H2S 0,3 C00053 3'-Phosphoadenylyl sulfate C00224 Adenylyl sulfate
+phosphoadenosine phosphosulfate reductase [EC:1.8.4.8] [RN:R02021] K00390 M00176 Assimilatory sulfate reduction, sulfate => H2S 1,0 C00094 Sulfite C00053 3'-Phosphoadenylyl sulfate
+sulfite reductase (NADPH) [EC:1.8.1.2] [RN:R00858] K00380 M00176 Assimilatory sulfate reduction, sulfate => H2S 2,0 C00283 Hydrogen sulfide C00094 Sulfite
+sulfite reductase (NADPH) [EC:1.8.1.2] [RN:R00858] K00381 M00176 Assimilatory sulfate reduction, sulfate => H2S 2,0 C00283 Hydrogen sulfide C00094 Sulfite
+sulfite reductase (ferredoxin) [EC:1.8.7.1] [RN:R00859] K00392 M00176 Assimilatory sulfate reduction, sulfate => H2S 2,1 C00283 Hydrogen sulfide C00094 Sulfite
+small subunit ribosomal protein S2e K02981 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S3e K02985 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S3Ae K02984 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S4e K02987 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S5e K02989 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S6e K02991 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S7e K02993 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S8e K02995 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S9e K02997 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S10e K02947 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S11e K02949 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S12e K02951 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S13e K02953 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S14e K02955 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S15e K02958 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S15Ae K02957 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S16e K02960 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S17e K02962 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S18e K02964 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S19e K02966 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S20e K02969 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S21e K02971 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S23e K02973 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S24e K02974 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S25e K02975 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S26e K02976 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S27e K02978 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S27Ae K02977 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S28e K02979 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S29e K02980 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S30e K02983 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein SAe K02998 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L3e K02925 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L4e K02930 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L5e K02932 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L6e K02934 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L7e K02937 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L7Ae K02936 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L8e K02938 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L9e K02940 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L10e K02866 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L10Ae K02865 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L11e K02868 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L12e K02870 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L13e K02873 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L13Ae K02872 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L14e K02875 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L15e K02877 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L17e K02880 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L18e K02883 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L18Ae K02882 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L19e K02885 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L21e K02889 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L22e K02891 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L23e K02894 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L23Ae K02893 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L24e K02896 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L26e K02898 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L27e K02901 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L27Ae K02900 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L28e K02903 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L29e K02905 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L30e K02908 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L31e K02910 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L32e K02912 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L34e K02915 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L35e K02918 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L35Ae K02917 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L36e K02920 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L37e K02922 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L37Ae K02921 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L38e K02923 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L39e K02924 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L40e K02927 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L41e K02928 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein L44e K02929 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein LP0 K02941 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein LP1 K02942 M00177 Ribosome, eukaryotes 0,0
+large subunit ribosomal protein LP2 K02943 M00177 Ribosome, eukaryotes 0,0
+small subunit ribosomal protein S10 K02946 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L3 K02906 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L4 K02926 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L23 K02892 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L2 K02886 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S19 K02965 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L22 K02890 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S3 K02982 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L16 K02878 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L29 K02904 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S17 K02961 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L14 K02874 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L24 K02895 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L5 K02931 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S14 K02954 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S8 K02994 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L6 K02933 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L18 K02881 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S5 K02988 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L30 K02907 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L15 K02876 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L36 K02919 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S13 K02952 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S11 K02948 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S4 K02986 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L17 K02879 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L13 K02871 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S9 K02996 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S7 K02992 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S12 K02950 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L7A K07590 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L7/L12 K02935 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L10 K02864 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L1 K02863 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L11 K02867 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S2 K02967 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S15 K02956 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L35 K02916 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L20 K02887 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L34 K02914 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L9 K02939 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S18 K02963 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S6 K02990 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L21 K02888 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L27 K02899 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L28 K02902 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L33 K02913 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L32 K02911 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L31 K02909 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L25 K02897 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S16 K02959 M00178 Ribosome, bacteria 0,0
+large subunit ribosomal protein L19 K02884 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S20 K02968 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S1 K02945 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S21 K02970 M00178 Ribosome, bacteria 0,0
+small subunit ribosomal protein S10 K02946 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L3 K02906 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L4e K02930 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L23 K02892 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L2 K02886 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S19 K02965 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L22 K02890 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S3 K02982 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L29 K02904 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S17 K02961 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L14 K02874 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L24 K02895 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S4e K02987 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L5 K02931 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S14 K02954 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S8 K02994 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L6 K02933 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L32e K02912 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L19e K02885 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L18 K02881 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S5 K02988 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L30 K02907 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L15 K02876 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S13 K02952 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S11 K02948 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S4 K02986 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L18e K02883 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L13 K02871 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S9 K02996 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S7 K02992 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S12 K02950 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L7Ae K02936 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S28e K02979 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L24e K02896 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L12 K02869 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L10 K02864 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L1 K02863 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L11 K02867 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S2 K02967 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S15 K02956 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S27e K02978 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L44e K02929 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L15e K02877 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S3Ae K02984 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S6e K02991 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S24e K02974 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S27Ae K02977 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S17e K02962 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L31e K02910 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L39e K02924 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L10e K02866 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L21e K02889 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L37e K02922 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L37Ae K02921 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S8e K02995 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S19e K02966 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L40e K02927 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein LX K02944 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S26e K02976 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S25e K02975 M00179 Ribosome, archaea 0,0
+small subunit ribosomal protein S30e K02983 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L13e K02873 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L35Ae K02917 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L41e K02928 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L34e K02915 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L14e K02875 M00179 Ribosome, archaea 0,0
+large subunit ribosomal protein L30e K02908 M00179 Ribosome, archaea 0,0
+RPB1; DNA-directed RNA polymerase II subunit RPB1 [EC:2.7.7.6] K03006 M00180 RNA polymerase II, eukaryotes 0,0
+RPB2; DNA-directed RNA polymerase II subunit RPB2 [EC:2.7.7.6] K03010 M00180 RNA polymerase II, eukaryotes 0,0
+RPB3; DNA-directed RNA polymerase II subunit RPB3 K03011 M00180 RNA polymerase II, eukaryotes 0,0
+RPB11; DNA-directed RNA polymerase II subunit RPB11 K03008 M00180 RNA polymerase II, eukaryotes 0,0
+RPB4; DNA-directed RNA polymerase II subunit RPB4 K03012 M00180 RNA polymerase II, eukaryotes 0,0
+RPB7; DNA-directed RNA polymerase II subunit RPB7 K03015 M00180 RNA polymerase II, eukaryotes 0,0
+RPB9; DNA-directed RNA polymerase II subunit RPB9 K03017 M00180 RNA polymerase II, eukaryotes 0,0
+RPB5; DNA-directed RNA polymerases I, II, and III subunit RPABC1 K03013 M00180 RNA polymerase II, eukaryotes 0,0
+RPB6; DNA-directed RNA polymerases I, II, and III subunit RPABC2 K03014 M00180 RNA polymerase II, eukaryotes 0,0
+RPB8; DNA-directed RNA polymerases I, II, and III subunit RPABC3 K03016 M00180 RNA polymerase II, eukaryotes 0,0
+RPB12; DNA-directed RNA polymerases I, II, and III subunit RPABC4 K03009 M00180 RNA polymerase II, eukaryotes 0,0
+RPB10; DNA-directed RNA polymerases I, II, and III subunit RPABC5 K03007 M00180 RNA polymerase II, eukaryotes 0,0
+RPC1; DNA-directed RNA polymerase III subunit RPC1 [EC:2.7.7.6] K03018 M00181 RNA polymerase III, eukaryotes 0,0
+RPC2; DNA-directed RNA polymerase III subunit RPC2 [EC:2.7.7.6] K03021 M00181 RNA polymerase III, eukaryotes 0,0
+RPC40; DNA-directed RNA polymerases I and III subunit RPAC1 K03027 M00181 RNA polymerase III, eukaryotes 0,0
+RPC19; DNA-directed RNA polymerases I and III subunit RPAC2 K03020 M00181 RNA polymerase III, eukaryotes 0,0
+RPC82; DNA-directed RNA polymerase III subunit RPC3 K03023 M00181 RNA polymerase III, eukaryotes 0,0
+RPC53; DNA-directed RNA polymerase III subunit RPC4 K03026 M00181 RNA polymerase III, eukaryotes 0,0
+RPC37; DNA-directed RNA polymerase III subunit RPC5 K14721 M00181 RNA polymerase III, eukaryotes 0,0
+RPC34; DNA-directed RNA polymerase III subunit RPC6 K03025 M00181 RNA polymerase III, eukaryotes 0,0
+RPC31; DNA-directed RNA polymerase III subunit RPC7 K03024 M00181 RNA polymerase III, eukaryotes 0,0
+RPC25; DNA-directed RNA polymerase III subunit RPC8 K03022 M00181 RNA polymerase III, eukaryotes 0,0
+RPC11; DNA-directed RNA polymerase III subunit RPC10 K03019 M00181 RNA polymerase III, eukaryotes 0,0
+RPB5; DNA-directed RNA polymerases I, II, and III subunit RPABC1 K03013 M00181 RNA polymerase III, eukaryotes 0,0
+RPB6; DNA-directed RNA polymerases I, II, and III subunit RPABC2 K03014 M00181 RNA polymerase III, eukaryotes 0,0
+RPB8; DNA-directed RNA polymerases I, II, and III subunit RPABC3 K03016 M00181 RNA polymerase III, eukaryotes 0,0
+RPB12; DNA-directed RNA polymerases I, II, and III subunit RPABC4 K03009 M00181 RNA polymerase III, eukaryotes 0,0
+RPB10; DNA-directed RNA polymerases I, II, and III subunit RPABC5 K03007 M00181 RNA polymerase III, eukaryotes 0,0
+RPA1; DNA-directed RNA polymerase I subunit RPA1 [EC:2.7.7.6] K02999 M00182 RNA polymerase I, eukaryotes 0,0
+RPA2; DNA-directed RNA polymerase I subunit RPA2 [EC:2.7.7.6] K03002 M00182 RNA polymerase I, eukaryotes 0,0
+RPC40; DNA-directed RNA polymerases I and III subunit RPAC1 K03027 M00182 RNA polymerase I, eukaryotes 0,0
+RPC19; DNA-directed RNA polymerases I and III subunit RPAC2 K03020 M00182 RNA polymerase I, eukaryotes 0,0
+RPA12; DNA-directed RNA polymerase I subunit RPA12 K03000 M00182 RNA polymerase I, eukaryotes 0,0
+RPA14; DNA-directed RNA polymerase I subunit RPA14 K03001 M00182 RNA polymerase I, eukaryotes 0,0
+RPA34; DNA-directed RNA polymerase I subunit RPA34 K03003 M00182 RNA polymerase I, eukaryotes 0,0
+RPA43; DNA-directed RNA polymerase I subunit RPA43 K03004 M00182 RNA polymerase I, eukaryotes 0,0
+RPA49; DNA-directed RNA polymerase I subunit RPA49 K03005 M00182 RNA polymerase I, eukaryotes 0,0
+RPB5; DNA-directed RNA polymerases I, II, and III subunit RPABC1 K03013 M00182 RNA polymerase I, eukaryotes 0,0
+RPB6; DNA-directed RNA polymerases I, II, and III subunit RPABC2 K03014 M00182 RNA polymerase I, eukaryotes 0,0
+RPB8; DNA-directed RNA polymerases I, II, and III subunit RPABC3 K03016 M00182 RNA polymerase I, eukaryotes 0,0
+RPB12; DNA-directed RNA polymerases I, II, and III subunit RPABC4 K03009 M00182 RNA polymerase I, eukaryotes 0,0
+RPB10; DNA-directed RNA polymerases I, II, and III subunit RPABC5 K03007 M00182 RNA polymerase I, eukaryotes 0,0
+rpoA; DNA-directed RNA polymerase subunit alpha [EC:2.7.7.6] K03040 M00183 RNA polymerase, bacteria 0,0
+rpoB; DNA-directed RNA polymerase subunit beta [EC:2.7.7.6] K03043 M00183 RNA polymerase, bacteria 0,0
+rpoC; DNA-directed RNA polymerase subunit beta' [EC:2.7.7.6] K03046 M00183 RNA polymerase, bacteria 0,0
+rpoBC; DNA-directed RNA polymerase subunit beta-beta' [EC:2.7.7.6] K13797 M00183 RNA polymerase, bacteria 0,0
+rpoZ; DNA-directed RNA polymerase subunit omega [EC:2.7.7.6] K03060 M00183 RNA polymerase, bacteria 0,0
+rpoE; DNA-directed RNA polymerase subunit delta K03048 M00183 RNA polymerase, bacteria 0,0
+"rpoA2; DNA-directed RNA polymerase subunit A"" [EC:2.7.7.6]" K03042 M00184 RNA polymerase, archaea 0,0
+rpoA1; DNA-directed RNA polymerase subunit A' [EC:2.7.7.6] K03041 M00184 RNA polymerase, archaea 0,0
+rpoB1; DNA-directed RNA polymerase subunit B' [EC:2.7.7.6] K03044 M00184 RNA polymerase, archaea 0,0
+"rpoB2; DNA-directed RNA polymerase subunit B"" [EC:2.7.7.6]" K03045 M00184 RNA polymerase, archaea 0,0
+rpoB; DNA-directed RNA polymerase subunit B [EC:2.7.7.6] K13798 M00184 RNA polymerase, archaea 0,0
+rpoH; DNA-directed RNA polymerase subunit H [EC:2.7.7.6] K03053 M00184 RNA polymerase, archaea 0,0
+rpoK; DNA-directed RNA polymerase subunit K [EC:2.7.7.6] K03055 M00184 RNA polymerase, archaea 0,0
+rpoN; DNA-directed RNA polymerase subunit N [EC:2.7.7.6] K03058 M00184 RNA polymerase, archaea 0,0
+rpoD; DNA-directed RNA polymerase subunit D [EC:2.7.7.6] K03047 M00184 RNA polymerase, archaea 0,0
+rpoE1; DNA-directed RNA polymerase subunit E' [EC:2.7.7.6] K03049 M00184 RNA polymerase, archaea 0,0
+"rpoE2; DNA-directed RNA polymerase subunit E"" [EC:2.7.7.6]" K03050 M00184 RNA polymerase, archaea 0,0
+rpoL; DNA-directed RNA polymerase subunit L [EC:2.7.7.6] K03056 M00184 RNA polymerase, archaea 0,0
+rpoP; DNA-directed RNA polymerase subunit P [EC:2.7.7.6] K03059 M00184 RNA polymerase, archaea 0,0
+rpoF; DNA-directed RNA polymerase subunit F [EC:2.7.7.6] K03051 M00184 RNA polymerase, archaea 0,0
+rpoG; DNA-directed RNA polymerase subunit G [EC:2.7.7.6] K03052 M00184 RNA polymerase, archaea 0,0
+rpoI; DNA-directed RNA polymerase subunit I [EC:2.7.7.6] K03054 M00184 RNA polymerase, archaea 0,0
+dnaE; DNA polymerase III subunit alpha [EC:2.7.7.7] K02337 M00260 DNA polymerase III complex, bacteria 0,0
+polC; DNA polymerase III subunit alpha, Gram-positive type [EC:2.7.7.7] K03763 M00260 DNA polymerase III complex, bacteria 0,0
+dnaQ; DNA polymerase III subunit epsilon [EC:2.7.7.7] K02342 M00260 DNA polymerase III complex, bacteria 0,0
+rnhA-dnaQ; ribonuclease HI / DNA polymerase III subunit epsilon [EC:3.1.26.4 2.7.7.7] K14159 M00260 DNA polymerase III complex, bacteria 0,0
+holE; DNA polymerase III subunit theta [EC:2.7.7.7] K02345 M00260 DNA polymerase III complex, bacteria 0,0
+dnaN; DNA polymerase III subunit beta [EC:2.7.7.7] K02338 M00260 DNA polymerase III complex, bacteria 0,0
+holA; DNA polymerase III subunit delta [EC:2.7.7.7] K02340 M00260 DNA polymerase III complex, bacteria 0,0
+holB; DNA polymerase III subunit delta' [EC:2.7.7.7] K02341 M00260 DNA polymerase III complex, bacteria 0,0
+dnaX; DNA polymerase III subunit gamma/tau [EC:2.7.7.7] K02343 M00260 DNA polymerase III complex, bacteria 0,0
+holC; DNA polymerase III subunit chi [EC:2.7.7.7] K02339 M00260 DNA polymerase III complex, bacteria 0,0
+holD; DNA polymerase III subunit psi [EC:2.7.7.7] K02344 M00260 DNA polymerase III complex, bacteria 0,0
+POLA1; DNA polymerase alpha, subunit A [EC:2.7.7.7] K02320 M00261 DNA polymerase alpha / primase complex 0,0
+POLA2; DNA polymerase alpha, subunit B [EC:2.7.7.7] K02321 M00261 DNA polymerase alpha / primase complex 0,0
+PRI2; DNA primase large subunit [EC:2.7.7.-] K02685 M00261 DNA polymerase alpha / primase complex 0,0
+PRI1; DNA primase small subunit [EC:2.7.7.-] K02684 M00261 DNA polymerase alpha / primase complex 0,0
+POLD1; DNA polymerase delta, subunit A [EC:2.7.7.7] K02327 M00262 DNA polymerase delta complex 0,0
+POLD2; DNA polymerase delta, subunit B [EC:2.7.7.7] K02328 M00262 DNA polymerase delta complex 0,0
+POLD3; DNA polymerase delta, subunit C [EC:2.7.7.7] K03504 M00262 DNA polymerase delta complex 0,0
+POLD4; DNA polymerase delta, subunit D [EC:2.7.7.7] K03505 M00262 DNA polymerase delta complex 0,0
+POLE1; DNA polymerase epsilon, subunit A [EC:2.7.7.7] K02324 M00263 DNA polymerase epsilon complex 0,0
+POLE2; DNA Polymerase epsilon, subunit B [EC:2.7.7.7] K02325 M00263 DNA polymerase epsilon complex 0,0
+POLE3; DNA Polymerase epsilon, subunit C [EC:2.7.7.7] K02326 M00263 DNA polymerase epsilon complex 0,0
+POLE4; DNA polymerase epsilon, subunit D [EC:2.7.7.7] K03506 M00263 DNA polymerase epsilon complex 0,0
+DPB1; DNA polymerase II large subunit [EC:2.7.7.7] K02322 M00264 DNA polymerase II complex, archaea 0,0
+DPB2; DNA polymerase II small subunit [EC:2.7.7.7] K02323 M00264 DNA polymerase II complex, archaea 0,0
+POLZ1, rev3; DNA polymerase zeta subunit K02350 M00293 DNA polymerase zeta complex 0,0
+POLZ2, rev7; DNA polymerase zeta subunit K03508 M00293 DNA polymerase zeta complex 0,0
+MAD2L2; mitotic spindle assembly checkpoint protein MAD2B K13728 M00293 DNA polymerase zeta complex 0,0
+POLG1; DNA polymerase gamma subunit [EC:2.7.7.7] [COG:COG0749] [GO:0003895] K02332 M00294 DNA polymerase gamma complex 0,0
+POLG2; DNA polymerase gamma2 subunit [EC:2.7.7.7] [GO:0003895] K02333 M00294 DNA polymerase gamma complex 0,0
+pyruvate dehydrogenase complex [EC:1.2.4.1 2.3.1.12 1.8.1.4] [RN:R00209] K00163 M00307 Pyruvate oxidation, pyruvate => acetyl-CoA 0,0 C00024 Acetyl-CoA C00022 Pyruvate
+pyruvate dehydrogenase complex [EC:1.2.4.1 2.3.1.12 1.8.1.4] [RN:R00209] K00161 M00307 Pyruvate oxidation, pyruvate => acetyl-CoA 0,0 C00024 Acetyl-CoA C00022 Pyruvate
+pyruvate dehydrogenase complex [EC:1.2.4.1 2.3.1.12 1.8.1.4] [RN:R00209] K00162 M00307 Pyruvate oxidation, pyruvate => acetyl-CoA 0,0 C00024 Acetyl-CoA C00022 Pyruvate
+pyruvate dehydrogenase complex [EC:1.2.4.1 2.3.1.12 1.8.1.4] [RN:R00209] K00627 M00307 Pyruvate oxidation, pyruvate => acetyl-CoA 0,0 C00024 Acetyl-CoA C00022 Pyruvate
+pyruvate dehydrogenase complex [EC:1.2.4.1 2.3.1.12 1.8.1.4] [RN:R00209] K00382 M00307 Pyruvate oxidation, pyruvate => acetyl-CoA 0,0 C00024 Acetyl-CoA C00022 Pyruvate
+pyruvate dehydrogenase complex [EC:1.2.4.1 2.3.1.12 1.8.1.4] [RN:R00209] K13997 M00307 Pyruvate oxidation, pyruvate => acetyl-CoA 0,0 C00024 Acetyl-CoA C00022 Pyruvate
+pyruvate:ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] K00169 M00307 Pyruvate oxidation, pyruvate => acetyl-CoA 0,1 C00024 Acetyl-CoA C00022 Pyruvate
+pyruvate:ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] K00170 M00307 Pyruvate oxidation, pyruvate => acetyl-CoA 0,1 C00024 Acetyl-CoA C00022 Pyruvate
+pyruvate:ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] K00171 M00307 Pyruvate oxidation, pyruvate => acetyl-CoA 0,1 C00024 Acetyl-CoA C00022 Pyruvate
+pyruvate:ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] K00172 M00307 Pyruvate oxidation, pyruvate => acetyl-CoA 0,1 C00024 Acetyl-CoA C00022 Pyruvate
+pyruvate:ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] K03737 M00307 Pyruvate oxidation, pyruvate => acetyl-CoA 0,2 C00024 Acetyl-CoA C00022 Pyruvate
+gluconate dehydratase [EC:4.2.1.140] [RN:R01538] K05308 M00308 Semi-phosphorylative Entner-Doudoroff pathway, gluconate => glycerate-3P 0,0 C00204 2-Dehydro-3-deoxy-D-gluconate C00257 D-Gluconic acid
+2-dehydro-3-deoxygluconokinase [EC:2.7.1.45] [RN:R01541] K00874 M00308 Semi-phosphorylative Entner-Doudoroff pathway, gluconate => glycerate-3P 1,0 C04442 2-Dehydro-3-deoxy-6-phospho-D-gluconate C00204 2-Dehydro-3-deoxy-D-gluconate
+2-dehydro-3-deoxyphosphogluconate aldolase [EC:4.1.2.14] [RN:R05605] K01625 M00308 Semi-phosphorylative Entner-Doudoroff pathway, gluconate => glycerate-3P 2,0 C00118,C00022 D-Glyceraldehyde 3-phosphate,Pyruvate C04442 2-Dehydro-3-deoxy-6-phospho-D-gluconate
+glyceraldehyde 3-phosphate dehydrogenase [EC:1.2.1.12] [RN:R01061] K00134 M00308 Semi-phosphorylative Entner-Doudoroff pathway, gluconate => glycerate-3P 3,0,0,0 C00236 3-Phospho-D-glyceroyl phosphate C00118 D-Glyceraldehyde 3-phosphate
+phosphoglycerate kinase [EC:2.7.2.3] [RN:R01512] K00927 M00308 Semi-phosphorylative Entner-Doudoroff pathway, gluconate => glycerate-3P 3,0,1,0 C00197 3-Phospho-D-glycerate C00236 3-Phospho-D-glyceroyl phosphate
+glyceraldehyde-3-phosphate dehydrogenase (NADP+) [EC:1.2.1.9] [RN:R01058] K00131 M00308 Semi-phosphorylative Entner-Doudoroff pathway, gluconate => glycerate-3P 3,1 C00197 3-Phospho-D-glycerate C00118 D-Glyceraldehyde 3-phosphate
+glyceraldehyde-3-phosphate dehydrogenase [NAD(P)+] [EC:1.2.1.90] [RN:R01058 R10860] K18978 M00308 Semi-phosphorylative Entner-Doudoroff pathway, gluconate => glycerate-3P 3,2 C00197 3-Phospho-D-glycerate C00118 D-Glyceraldehyde 3-phosphate
+gluconate/galactonate dehydratase [EC:4.2.1.140] [RN:R01538 R03033] K05308 M00309 Non-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate 0,0 C01216 2-Dehydro-3-deoxy-D-galactonate C00880 D-Galactonate
+2-dehydro-3-deoxy-phosphogluconate/2-dehydro-3-deoxy-6-phosphogalactonate aldolase [EC:4.1.2.55] [RN:R08570 R10616] K11395 M00309 Non-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate 1,0 C00577,C00022 D-Glyceraldehyde,Pyruvate C01216 2-Dehydro-3-deoxy-D-galactonate
+2-dehydro-3-deoxy-D-gluconate aldolase [EC:4.1.2.51] [RN:R08570 R10616] K18127 M00309 Non-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate 1,1 C00577,C00022 D-Glyceraldehyde,Pyruvate C01216 2-Dehydro-3-deoxy-D-galactonate
+glyceraldehyde dehydrogenase large subunit [EC:1.2.99.8] [RN:R10324] K18020 M00309 Non-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate 2,0 C00258 D-Glycerate C00577 D-Glyceraldehyde
+glyceraldehyde dehydrogenase large subunit [EC:1.2.99.8] [RN:R10324] K18021 M00309 Non-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate 2,0 C00258 D-Glycerate C00577 D-Glyceraldehyde
+glyceraldehyde dehydrogenase large subunit [EC:1.2.99.8] [RN:R10324] K18022 M00309 Non-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate 2,0 C00258 D-Glycerate C00577 D-Glyceraldehyde
+glyceraldehyde dehydrogenase [EC:1.2.1.89] [RN:R10615] K18128 M00309 Non-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate 2,1 C00258 D-Glycerate C00577 D-Glyceraldehyde
+aldehyde:ferredoxin oxidoreductase [EC:1.2.7.5] [RN:R08571] K03738 M00309 Non-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate 2,2 C00258 D-Glycerate C00577 D-Glyceraldehyde
+cystathionine beta-synthase [EC:4.2.1.22] [RN:R01290] K01697 M00338 Cysteine biosynthesis, homocysteine + serine => cysteine 0,0 C02291 L-Cystathionine C00065,C00155 L-Serine,L-Homocysteine
+cystathionine beta-synthase [EC:4.2.1.22] [RN:R01290] K10150 M00338 Cysteine biosynthesis, homocysteine + serine => cysteine 0,1 C02291 L-Cystathionine C00065,C00155 L-Serine,L-Homocysteine
+cystathionine gamma-lyase [EC:4.4.1.1] [RN:R01001] K01758 M00338 Cysteine biosynthesis, homocysteine + serine => cysteine 1,0 C00097 L-Cysteine C02291 L-Cystathionine
+dihydroxyacetone synthase [EC:2.2.1.3] [RN:R01440] K17100 M00344 Formaldehyde assimilation, xylulose monophosphate pathway 0,0 C00184 Glycerone C00067 Formaldehyde
+dihydroxyacetone kinase [EC:2.7.1.29] [RN:R01011] K00863 M00344 Formaldehyde assimilation, xylulose monophosphate pathway 1,0 C00111 Glycerone phosphate C00184 Glycerone
+fructose-bisphosphate aldolase, class II [EC:4.1.2.13] [RN:R01068] K01624 M00344 Formaldehyde assimilation, xylulose monophosphate pathway 2,0 C00354 D-Fructose 1,6-bisphosphate C00111 Glycerone phosphate
+fructose-1,6-bisphosphatase I [EC:3.1.3.11] [RN:R00762] K03841 M00344 Formaldehyde assimilation, xylulose monophosphate pathway 3,0 C00085 D-Fructose 6-phosphate C00354 D-Fructose 1,6-bisphosphate
+3-hexulose-6-phosphate synthase [EC:4.1.2.43] [RN:R05338] K08093 M00345 Formaldehyde assimilation, ribulose monophosphate pathway 0,0,0,0 C06019 D-arabino-Hex-3-ulose 6-phosphate C00199,C00067 D-Ribulose 5-phosphate,Formaldehyde
+3-hexulose-6-phosphate synthase [EC:4.1.2.43] [RN:R05338] K13812 M00345 Formaldehyde assimilation, ribulose monophosphate pathway 0,0,0,1 C06019 D-arabino-Hex-3-ulose 6-phosphate C00199,C00067 D-Ribulose 5-phosphate,Formaldehyde
+6-phospho-3-hexuloisomerase [EC:5.3.1.27] [RN:R05339 R09780] K08094 M00345 Formaldehyde assimilation, ribulose monophosphate pathway 0,0,1,0 C05345 beta-D-Fructose 6-phosphate C06019 D-arabino-Hex-3-ulose 6-phosphate
+3-hexulose-6-phosphate synthase [EC:4.1.2.43] [RN:R05338] K13831 M00345 Formaldehyde assimilation, ribulose monophosphate pathway 0,1 C06019 D-arabino-Hex-3-ulose 6-phosphate C00199,C00067 D-Ribulose 5-phosphate,Formaldehyde
+6-phosphofructokinase [EC:2.7.1.11] [RN:R00756 R04779] K00850 M00345 Formaldehyde assimilation, ribulose monophosphate pathway 1,0 C05378 beta-D-Fructose 1,6-bisphosphate C05345 beta-D-Fructose 6-phosphate
+6-phosphofructokinase [EC:2.7.1.11] [RN:R00756 R04779] K16370 M00345 Formaldehyde assimilation, ribulose monophosphate pathway 1,1 C05378 beta-D-Fructose 1,6-bisphosphate C05345 beta-D-Fructose 6-phosphate
+fructose-bisphosphate aldolase, class II [EC:4.1.2.13] [RN:R01068 R01070] K01624 M00345 Formaldehyde assimilation, ribulose monophosphate pathway 2,0 C00118 D-Glyceraldehyde 3-phosphate C05378 beta-D-Fructose 1,6-bisphosphate
+glycine hydroxymethyltransferase [EC:2.1.2.1] [RN:R00945] K00600 M00346 Formaldehyde assimilation, serine pathway 0,0 C00065 L-Serine C00037 Glycine
+serine--glyoxylate transaminase [EC:2.6.1.45] [RN:R00588] K00830 M00346 Formaldehyde assimilation, serine pathway 1,0 C00037 Glycine C00048 Glyoxylate
+glycerate dehydrogenase [EC:1.1.1.29] [RN:R01388] K00018 M00346 Formaldehyde assimilation, serine pathway 2,0 C00258 D-Glycerate C00168 Hydroxypyruvate
+glycerate 2-kinase [EC:2.7.1.165] [RN:R08572] K11529 M00346 Formaldehyde assimilation, serine pathway 3,0 C00631 2-Phospho-D-glycerate C00258 D-Glycerate
+enolase [EC:4.2.1.11] [RN:R00658] K01689 M00346 Formaldehyde assimilation, serine pathway 4,0 C00074 Phosphoenolpyruvate C00631 2-Phospho-D-glycerate
+phosphoenolpyruvate carboxylase [EC:4.1.1.31] [RN:R00345] K01595 M00346 Formaldehyde assimilation, serine pathway 5,0 C00036 Oxaloacetate C00074 Phosphoenolpyruvate
+malate dehydrogenase [EC:1.1.1.37] [RN:R00342] K00024 M00346 Formaldehyde assimilation, serine pathway 6,0 C00149 (S)-Malate C00036 Oxaloacetate
+malate-CoA ligase [EC:6.2.1.9] [RN:R01256] K08692 M00346 Formaldehyde assimilation, serine pathway 7,0 C04348 (3S)-3-Carboxy-3-hydroxypropanoyl-CoA C00149 (S)-Malate
+malate-CoA ligase [EC:6.2.1.9] [RN:R01256] K14067 M00346 Formaldehyde assimilation, serine pathway 7,0 C04348 (3S)-3-Carboxy-3-hydroxypropanoyl-CoA C00149 (S)-Malate
+malyl-CoA lyase [EC:4.1.3.24] [RN:R00473] K08691 M00346 Formaldehyde assimilation, serine pathway 8,0 C00048 Glyoxylate C04348 (3S)-3-Carboxy-3-hydroxypropanoyl-CoA
+[methyl-Co(III) methanol-specific corrinoid protein]:coenzyme M methyltransferase [EC:2.1.1.246] [RN:R09098] K14080 M00356 Methanogenesis, methanol => methane 0,0 C03920 2-(Methylthio)ethanesulfonate C00132 Methanol
+methanol---5-hydroxybenzimidazolylcobamide Co-methyltransferase [EC:2.1.1.90] [RN:R09098] K04480 M00356 Methanogenesis, methanol => methane 0,0 C03920 2-(Methylthio)ethanesulfonate C00132 Methanol
+methanol corrinoid protein [RN:R09098] K14081 M00356 Methanogenesis, methanol => methane 0,0 C03920 2-(Methylthio)ethanesulfonate C00132 Methanol
+methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] K00399 M00356 Methanogenesis, methanol => methane 1,0 C01438,C04832 Methane,Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide C03920,C04628 2-(Methylthio)ethanesulfonate,Coenzyme B
+methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] K00401 M00356 Methanogenesis, methanol => methane 1,0 C01438,C04832 Methane,Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide C03920,C04628 2-(Methylthio)ethanesulfonate,Coenzyme B
+methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] K00402 M00356 Methanogenesis, methanol => methane 1,0 C01438,C04832 Methane,Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide C03920,C04628 2-(Methylthio)ethanesulfonate,Coenzyme B
+heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] K22480 M00356 Methanogenesis, methanol => methane 2,0 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] K22481 M00356 Methanogenesis, methanol => methane 2,0 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] K22482 M00356 Methanogenesis, methanol => methane 2,0 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03388 M00356 Methanogenesis, methanol => methane 2,1 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03389 M00356 Methanogenesis, methanol => methane 2,1 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03390 M00356 Methanogenesis, methanol => methane 2,1 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase [EC:1.8.98.1] [RN:R04540] K08264 M00356 Methanogenesis, methanol => methane 2,2 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase [EC:1.8.98.1] [RN:R04540] K08265 M00356 Methanogenesis, methanol => methane 2,2 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03388 M00356 Methanogenesis, methanol => methane 2,3 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03389 M00356 Methanogenesis, methanol => methane 2,3 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03390 M00356 Methanogenesis, methanol => methane 2,3 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+F420-non-reducing hydrogenase iron-sulfur subunit [EC:1.8.98.5 1.8.98.6] [RN:R11943 R11944] K14127 M00356 Methanogenesis, methanol => methane 2,3 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+F420-non-reducing hydrogenase [EC:1.8.98.5] [RN:R11943] K14126 M00356 Methanogenesis, methanol => methane 2,3 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+F420-non-reducing hydrogenase [EC:1.8.98.5] [RN:R11943] K14128 M00356 Methanogenesis, methanol => methane 2,3 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+formate dehydrogenase (coenzyme F420) [EC:1.8.98.6] [RN:R11944] K22516 M00356 Methanogenesis, methanol => methane 2,3 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+formate dehydrogenase (coenzyme F420) [EC:1.8.98.6] [RN:R11944] K00125 M00356 Methanogenesis, methanol => methane 2,3 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+acetate kinase [EC:2.7.2.1] [RN:R00315] K00925 M00357 Methanogenesis, acetate => methane 0,0,0,0 C00227 Acetyl phosphate C00033 Acetate
+phosphate acetyltransferase [EC:2.3.1.8] [RN:R00230] K00625 M00357 Methanogenesis, acetate => methane 0,0,1,0 C00024 Acetyl-CoA C00227 Acetyl phosphate
+phosphate acetyltransferase [EC:2.3.1.8] [RN:R00230] K13788 M00357 Methanogenesis, acetate => methane 0,0,1,1 C00024 Acetyl-CoA C00227 Acetyl phosphate
+acetyl-CoA synthetase [EC:6.2.1.1] [RN:R00235] K01895 M00357 Methanogenesis, acetate => methane 0,1 C00024 Acetyl-CoA C00033 Acetate
+acetyl-CoA decarbonylase/synthase complex [EC:2.3.1.-] [RN:R09096] K00193 M00357 Methanogenesis, acetate => methane 1,0 C04488 5-Methyl-5,6,7,8-tetrahydromethanopterin C00024 Acetyl-CoA
+acetyl-CoA decarbonylase/synthase complex [EC:2.3.1.-] [RN:R09096] K00197 M00357 Methanogenesis, acetate => methane 1,0 C04488 5-Methyl-5,6,7,8-tetrahydromethanopterin C00024 Acetyl-CoA
+acetyl-CoA decarbonylase/synthase complex [EC:2.3.1.-] [RN:R09096] K00194 M00357 Methanogenesis, acetate => methane 1,0 C04488 5-Methyl-5,6,7,8-tetrahydromethanopterin C00024 Acetyl-CoA
+tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] K00577 M00357 Methanogenesis, acetate => methane 2,0 C03920 2-(Methylthio)ethanesulfonate C04488,C03576 5-Methyl-5,6,7,8-tetrahydromethanopterin,Coenzyme M
+tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] K00578 M00357 Methanogenesis, acetate => methane 2,0 C03920 2-(Methylthio)ethanesulfonate C04488,C03576 5-Methyl-5,6,7,8-tetrahydromethanopterin,Coenzyme M
+tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] K00579 M00357 Methanogenesis, acetate => methane 2,0 C03920 2-(Methylthio)ethanesulfonate C04488,C03576 5-Methyl-5,6,7,8-tetrahydromethanopterin,Coenzyme M
+tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] K00580 M00357 Methanogenesis, acetate => methane 2,0 C03920 2-(Methylthio)ethanesulfonate C04488,C03576 5-Methyl-5,6,7,8-tetrahydromethanopterin,Coenzyme M
+tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] K00581 M00357 Methanogenesis, acetate => methane 2,0 C03920 2-(Methylthio)ethanesulfonate C04488,C03576 5-Methyl-5,6,7,8-tetrahydromethanopterin,Coenzyme M
+tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] K00582 M00357 Methanogenesis, acetate => methane 2,0 C03920 2-(Methylthio)ethanesulfonate C04488,C03576 5-Methyl-5,6,7,8-tetrahydromethanopterin,Coenzyme M
+tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] K00583 M00357 Methanogenesis, acetate => methane 2,0 C03920 2-(Methylthio)ethanesulfonate C04488,C03576 5-Methyl-5,6,7,8-tetrahydromethanopterin,Coenzyme M
+tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] K00584 M00357 Methanogenesis, acetate => methane 2,0 C03920 2-(Methylthio)ethanesulfonate C04488,C03576 5-Methyl-5,6,7,8-tetrahydromethanopterin,Coenzyme M
+methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] K00399 M00357 Methanogenesis, acetate => methane 3,0 C01438,C04832 Methane,Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide C03920,C04628 2-(Methylthio)ethanesulfonate,Coenzyme B
+methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] K00401 M00357 Methanogenesis, acetate => methane 3,0 C01438,C04832 Methane,Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide C03920,C04628 2-(Methylthio)ethanesulfonate,Coenzyme B
+methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] K00402 M00357 Methanogenesis, acetate => methane 3,0 C01438,C04832 Methane,Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide C03920,C04628 2-(Methylthio)ethanesulfonate,Coenzyme B
+heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] K22480 M00357 Methanogenesis, acetate => methane 4,0 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] K22481 M00357 Methanogenesis, acetate => methane 4,0 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] K22482 M00357 Methanogenesis, acetate => methane 4,0 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03388 M00357 Methanogenesis, acetate => methane 4,1 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03389 M00357 Methanogenesis, acetate => methane 4,1 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03390 M00357 Methanogenesis, acetate => methane 4,1 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase [EC:1.8.98.1] [RN:R04540] K08264 M00357 Methanogenesis, acetate => methane 4,2 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase [EC:1.8.98.1] [RN:R04540] K08265 M00357 Methanogenesis, acetate => methane 4,2 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03388 M00357 Methanogenesis, acetate => methane 4,3 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03389 M00357 Methanogenesis, acetate => methane 4,3 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03390 M00357 Methanogenesis, acetate => methane 4,3 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+F420-non-reducing hydrogenase iron-sulfur subunit [EC:1.8.98.5 1.8.98.6] [RN:R11943 R11944] K14127 M00357 Methanogenesis, acetate => methane 4,3 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+F420-non-reducing hydrogenase [EC:1.8.98.5] [RN:R11943] K14126 M00357 Methanogenesis, acetate => methane 4,3 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+F420-non-reducing hydrogenase [EC:1.8.98.5] [RN:R11943] K14128 M00357 Methanogenesis, acetate => methane 4,3 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+formate dehydrogenase (coenzyme F420) [EC:1.8.98.6] [RN:R11944] K22516 M00357 Methanogenesis, acetate => methane 4,3 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+formate dehydrogenase (coenzyme F420) [EC:1.8.98.6] [RN:R11944] K00125 M00357 Methanogenesis, acetate => methane 4,3 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+phosphosulfolactate synthase [EC:4.4.1.19] [RN:R07476] K08097 M00358 Coenzyme M biosynthesis 0,0 C11536 (2R)-O-Phospho-3-sulfolactate C00074 Phosphoenolpyruvate
+2-phosphosulfolactate phosphatase [EC:3.1.3.71] [RN:R05789] K05979 M00358 Coenzyme M biosynthesis 1,0 C11537 (2R)-3-Sulfolactate C11536 (2R)-O-Phospho-3-sulfolactate
+L-2-hydroxycarboxylate dehydrogenase (NAD+) [EC:1.1.1.337] [RN:R07136] K05884 M00358 Coenzyme M biosynthesis 2,0 C05528 3-Sulfopyruvate C11537 (2R)-3-Sulfolactate
+sulfopyruvate decarboxylase [EC:4.1.1.79] [RN:R05774] K13039 M00358 Coenzyme M biosynthesis 3,0 C00593 Sulfoacetaldehyde C05528 3-Sulfopyruvate
+sulfopyruvate decarboxylase [EC:4.1.1.79] [RN:R05774] K06034 M00358 Coenzyme M biosynthesis 3,0 C00593 Sulfoacetaldehyde C05528 3-Sulfopyruvate
+stxA; shiga toxin subunit A K11006 M00363 EHEC pathogenicity signature, Shiga toxin 0,0
+stxB; shiga toxin subunit B K11007 M00363 EHEC pathogenicity signature, Shiga toxin 1,0
+IPP <-> DMPP [EC:5.3.3.2] [RN:R01123] K01823 M00364 C10-C20 isoprenoid biosynthesis, bacteria 0,0 C00235 Dimethylallyl diphosphate (DMPP) C00129 Isopentenyl diphosphate (IPP)
+DMPP -> GPP -> FPP [EC:2.5.1.1 2.5.1.10] [RN:R01658 R02003] K00795 M00364 C10-C20 isoprenoid biosynthesis, bacteria 1,0 C00448 trans,trans-Farnesyl diphosphate (FPP) C00341,C00129 Geranyl diphosphate (GPP),Isopentenyl diphosphate (IPP)
+DMPP -> GPP -> FPP -> GGPP [EC:2.5.1.1 2.5.1.10 2.5.1.29] [RN:R01658 R02003 R02061] K13789 M00364 C10-C20 isoprenoid biosynthesis, bacteria 1,1 C00353 Geranylgeranyl diphosphate (GGPP) C00448,C00129 trans,trans-Farnesyl diphosphate (FPP),Isopentenyl diphosphate (IPP)
+DMPP -> GPP -> FPP -> GGPP [EC:2.5.1.1 2.5.1.10 2.5.1.29] [RN:R01658 R02003 R02061] K13787 M00364 C10-C20 isoprenoid biosynthesis, bacteria 1,2 C00353 Geranylgeranyl diphosphate (GGPP) C00448,C00129 trans,trans-Farnesyl diphosphate (FPP),Isopentenyl diphosphate (IPP)
+IPP <-> DMPP [EC:5.3.3.2] [RN:R01123] K01823 M00365 C10-C20 isoprenoid biosynthesis, archaea 0,0 C00235 Dimethylallyl diphosphate (DMPP) C00129 Isopentenyl diphosphate (IPP)
+DMPP -> GPP -> FPP -> GGPP [EC:2.5.1.1 2.5.1.10 2.5.1.29] [RN:R01658 R02003 R02061] K13787 M00365 C10-C20 isoprenoid biosynthesis, archaea 1,0 C00353 Geranylgeranyl diphosphate (GGPP) C00448,C00129 trans,trans-Farnesyl diphosphate (FPP),Isopentenyl diphosphate (IPP)
+IPP <-> DMPP [EC:5.3.3.2] [RN:R01123] K01823 M00366 C10-C20 isoprenoid biosynthesis, plants 0,0 C00235 Dimethylallyl diphosphate (DMPP) C00129 Isopentenyl diphosphate (IPP)
+DMPP -> GPP [EC:2.5.1.1] [RN:R01658] K14066 M00366 C10-C20 isoprenoid biosynthesis, plants 1,0 C00341 Geranyl diphosphate (GPP) C00235,C00129 Dimethylallyl diphosphate (DMPP),Isopentenyl diphosphate (IPP)
+DMPP -> GPP -> FPP [EC:2.5.1.1 2.5.1.10] [RN:R01658 R02003] K00787 M00366 C10-C20 isoprenoid biosynthesis, plants 2,0 C00448 trans,trans-Farnesyl diphosphate (FPP) C00341,C00129 Geranyl diphosphate (GPP),Isopentenyl diphosphate (IPP)
+DMPP -> GPP -> FPP -> GGPP [EC:2.5.1.1 2.5.1.10 2.5.1.29] [RN:R01658 R02003 R02061] K13789 M00366 C10-C20 isoprenoid biosynthesis, plants 3,0 C00353 Geranylgeranyl diphosphate (GGPP) C00448,C00129 trans,trans-Farnesyl diphosphate (FPP),Isopentenyl diphosphate (IPP)
+IPP <-> DMPP [EC:5.3.3.2] [RN:R01123] K01823 M00367 C10-C20 isoprenoid biosynthesis, non-plant eukaryotes 0,0 C00235 Dimethylallyl diphosphate (DMPP) C00129 Isopentenyl diphosphate (IPP)
+DMPP -> GPP -> FPP [EC:2.5.1.1 2.5.1.10] [RN:R01658 R02003] K00787 M00367 C10-C20 isoprenoid biosynthesis, non-plant eukaryotes 1,0 C00448 trans,trans-Farnesyl diphosphate (FPP) C00341,C00129 Geranyl diphosphate (GPP),Isopentenyl diphosphate (IPP)
+DMPP -> GPP -> FPP -> GGPP [EC:2.5.1.1 2.5.1.10 2.5.1.29] [RN:R01658 R02003 R02061] K00804 M00367 C10-C20 isoprenoid biosynthesis, non-plant eukaryotes 2,0 C00353 Geranylgeranyl diphosphate (GGPP) C00448,C00129 trans,trans-Farnesyl diphosphate (FPP),Isopentenyl diphosphate (IPP)
+S-adenosylmethionine synthetase [EC:2.5.1.6] [RN:R00177] K00789 M00368 Ethylene biosynthesis, methionine => ethylene 0,0 C00019 S-Adenosyl-L-methionine C00073 L-Methionine
+1-aminocyclopropane-1-carboxylate synthase [EC:4.4.1.14] [RN:R00179] K01762 M00368 Ethylene biosynthesis, methionine => ethylene 1,0 C01234 1-Aminocyclopropane-1-carboxylate C00019 S-Adenosyl-L-methionine
+1-aminocyclopropane-1-carboxylate synthase [EC:4.4.1.14] [RN:R00179] K20772 M00368 Ethylene biosynthesis, methionine => ethylene 1,1 C01234 1-Aminocyclopropane-1-carboxylate C00019 S-Adenosyl-L-methionine
+aminocyclopropanecarboxylate oxidase [EC:1.14.17.4] [RN:R07214] K05933 M00368 Ethylene biosynthesis, methionine => ethylene 2,0 C06547 Ethylene C01234 1-Aminocyclopropane-1-carboxylate
+tyrosine N-monooxygenase [EC:1.14.14.36] [RN:R00730 R04460 R07190] K13027 M00369 Cyanogenic glycoside biosynthesis, tyrosine => dhurrin 0,0 C04350 (E)-4-Hydroxyphenylacetaldehyde oxime C15503 N,N-Dihydroxy-L-tyrosine
+4-hydroxyphenylacetaldehyde oxime monooxygenase [EC:1.14.14.37] [RN:R05728] K13029 M00369 Cyanogenic glycoside biosynthesis, tyrosine => dhurrin 1,0 C03742 (S)-4-Hydroxymandelonitrile C04350 (E)-4-Hydroxyphenylacetaldehyde oxime
+cyanohydrin beta-glucosyltransferase [EC:2.4.1.85] [RN:R04296] K13030 M00369 Cyanogenic glycoside biosynthesis, tyrosine => dhurrin 2,0 C05143 Dhurrin C03742 (S)-4-Hydroxymandelonitrile
+tryptophan N-monooxygenase [EC:1.14.14.156] [RN:R08160] K11812 M00370 Glucosinolate biosynthesis, tryptophan => glucobrassicin 0,0 C02937 Indole-3-acetaldehyde oxime C00078 L-Tryptophan
+tryptophan N-monooxygenase [EC:1.14.14.156] [RN:R08160] K11813 M00370 Glucosinolate biosynthesis, tryptophan => glucobrassicin 0,1 C02937 Indole-3-acetaldehyde oxime C00078 L-Tryptophan
+aromatic aldoxime N-monooxygenase [EC:1.14.14.45] [RN:R08168] K11818 M00370 Glucosinolate biosynthesis, tryptophan => glucobrassicin 1,0 C16518 S-(Indolylmethylthiohydroximoyl)-L-cysteine C02937 Indole-3-acetaldehyde oxime
+S-alkyl-thiohydroximate lyase SUR1 [EC:4.4.1.-] [RN:R08170] K11819 M00370 Glucosinolate biosynthesis, tryptophan => glucobrassicin 2,0 C16516 Indolylmethylthiohydroximate C16518 S-(Indolylmethylthiohydroximoyl)-L-cysteine
+N-hydroxythioamide S-beta-glucosyltransferase [EC:2.4.1.195] [RN:R08164] K11820 M00370 Glucosinolate biosynthesis, tryptophan => glucobrassicin 3,0 C16517 Indolylmethyl-desulfoglucosinolate C16516 Indolylmethylthiohydroximate
+aromatic desulfoglucosinolate sulfotransferase [EC:2.8.2.24] [RN:R08167] K11821 M00370 Glucosinolate biosynthesis, tryptophan => glucobrassicin 4,0 C05837 Glucobrassicin C16517 Indolylmethyl-desulfoglucosinolate
+steroid 22-alpha-hydroxylase [EC:1.14.13.-] [RN:R07445] K09587 M00371 Castasterone biosynthesis, campesterol => castasterone 0,0 C15795 22alpha-Hydroxy-campesterol C01789 Campesterol
+steroid 22-alpha-hydroxylase [EC:1.14.13.-] [RN:R07445] K12639 M00371 Castasterone biosynthesis, campesterol => castasterone 0,1 C15795 22alpha-Hydroxy-campesterol C01789 Campesterol
+cytochrome P450, family 90, subfamily A, polypeptide 1 [EC:1.14.-.-] [RN:R07446] K09588 M00371 Castasterone biosynthesis, campesterol => castasterone 1,0 C15796 22alpha-Hydroxy-campest-4-en-3-one C15795 22alpha-Hydroxy-campesterol
+probable steroid reductase DET2 [EC:1.3.1.22] [RN:R07447] K09591 M00371 Castasterone biosynthesis, campesterol => castasterone 2,0 C15797 22alpha-Hydroxy-5alpha-campestan-3-one C15796 22alpha-Hydroxy-campest-4-en-3-one
+3-epi-6-deoxocathasterone 23-monooxygenase [EC:1.14.14.147] [RN:R07791] K12637 M00371 Castasterone biosynthesis, campesterol => castasterone 3,0 C15800 3-Dehydro-6-deoxoteasterone C15797 22alpha-Hydroxy-5alpha-campestan-3-one
+3-epi-6-deoxocathasterone 23-monooxygenase [EC:1.14.14.147] [RN:R07791] K12638 M00371 Castasterone biosynthesis, campesterol => castasterone 3,1 C15800 3-Dehydro-6-deoxoteasterone C15797 22alpha-Hydroxy-5alpha-campestan-3-one
+6-deoxotyphasterol 2alpha-hydroxylase [RN:R07474] K20623 M00371 Castasterone biosynthesis, campesterol => castasterone 4,0 C15802 6-Deoxocastasterone C15801 6-Deoxotyphasterol
+cytochrome P450, family 85, subfamily A, polypeptide 1 / 2 [EC:1.14.-.-] [RN:R07450 R07451] K09590 M00371 Castasterone biosynthesis, campesterol => castasterone 5,0 C15794 Castasterone C15803 6alpha-Hydroxy-castasterone
+cytochrome P450, family 85, subfamily A, polypeptide 1 / 2 [EC:1.14.-.-] [RN:R07450 R07451] K12640 M00371 Castasterone biosynthesis, campesterol => castasterone 5,1 C15794 Castasterone C15803 6alpha-Hydroxy-castasterone
+beta-carotene hydroxylase [EC:1.14.15.24 1.14.-.-] [RN:R07558 R07559] K15746 M00372 Abscisic acid biosynthesis, beta-carotene => abscisic acid 0,0 C06098 Zeaxanthin C08591 beta-Cryptoxanthin
+beta-carotene hydroxylase [EC:1.14.15.24 1.14.-.-] [RN:R07558 R07559] K15747 M00372 Abscisic acid biosynthesis, beta-carotene => abscisic acid 0,1 C06098 Zeaxanthin C08591 beta-Cryptoxanthin
+zeaxanthin epoxidase [EC:1.14.13.90] [RN:R06946 R06947] K09838 M00372 Abscisic acid biosynthesis, beta-carotene => abscisic acid 1,0 C08614 Violaxanthin C08579 Antheraxanthin
+NSY; neoxanthin synthase [EC:5.3.99.9] [RN:R06948] K14594 M00372 Abscisic acid biosynthesis, beta-carotene => abscisic acid 2,0 C08606 Neoxanthin C08614 Violaxanthin
+9-cis-epoxycarotenoid dioxygenase [EC:1.13.11.51] [RN:R06953 R06952] K09840 M00372 Abscisic acid biosynthesis, beta-carotene => abscisic acid 3,0 C13453 Xanthoxin C13431 9'-cis-Neoxanthin
+xanthoxin dehydrogenase [EC:1.1.1.288] [RN:R06954] K09841 M00372 Abscisic acid biosynthesis, beta-carotene => abscisic acid 4,0 C13455 Abscisic aldehyde C13453 Xanthoxin
+abscisic-aldehyde oxidase [EC:1.2.3.14] [RN:R06957] K09842 M00372 Abscisic acid biosynthesis, beta-carotene => abscisic acid 5,0 C06082 Abscisate C13455 Abscisic aldehyde
+propionyl-CoA carboxylase [EC:6.4.1.3] [RN:R01859] K01965 M00373 Ethylmalonyl pathway 0,0 C00683 (S)-Methylmalonyl-CoA C00100 Propanoyl-CoA
+propionyl-CoA carboxylase [EC:6.4.1.3] [RN:R01859] K01966 M00373 Ethylmalonyl pathway 0,0 C00683 (S)-Methylmalonyl-CoA C00100 Propanoyl-CoA
+methylmalonyl-CoA/ethylmalonyl-CoA epimerase [EC:5.1.99.1] [RN:R02765 R09979] K05606 M00373 Ethylmalonyl pathway 1,0 C20238 (2R)-Ethylmalonyl-CoA C18026 (2S)-Ethylmalonyl-CoA
+methylmalonyl-CoA mutase [EC:5.4.99.2] [RN:R00833] K01847 M00373 Ethylmalonyl pathway 2,0 C00091 Succinyl-CoA C01213 (R)-Methylmalonyl-CoA
+pyruvate ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] K00169 M00374 Dicarboxylate-hydroxybutyrate cycle 0,0 C00022 Pyruvate C00024 Acetyl-CoA
+pyruvate ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] K00170 M00374 Dicarboxylate-hydroxybutyrate cycle 0,0 C00022 Pyruvate C00024 Acetyl-CoA
+pyruvate ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] K00171 M00374 Dicarboxylate-hydroxybutyrate cycle 0,0 C00022 Pyruvate C00024 Acetyl-CoA
+pyruvate ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] K00172 M00374 Dicarboxylate-hydroxybutyrate cycle 0,0 C00022 Pyruvate C00024 Acetyl-CoA
+pyruvate, water dikinase [EC:2.7.9.2] [RN:R00199] K01007 M00374 Dicarboxylate-hydroxybutyrate cycle 1,0 C00074 Phosphoenolpyruvate C00022 Pyruvate
+phosphoenolpyruvate carboxylase [EC:4.1.1.31] [RN:R00345] K01595 M00374 Dicarboxylate-hydroxybutyrate cycle 2,0 C00036 Oxaloacetate C00074 Phosphoenolpyruvate
+malate dehydrogenase [EC:1.1.1.37] [RN:R00342] K00024 M00374 Dicarboxylate-hydroxybutyrate cycle 3,0 C00149 (S)-Malate C00036 Oxaloacetate
+fumarate hydratase [EC:4.2.1.2] [RN:R01082] K01676 M00374 Dicarboxylate-hydroxybutyrate cycle 4,0 C00122 Fumarate C00149 (S)-Malate
+fumarate hydratase [EC:4.2.1.2] [RN:R01082] K01677 M00374 Dicarboxylate-hydroxybutyrate cycle 4,1 C00122 Fumarate C00149 (S)-Malate
+fumarate hydratase [EC:4.2.1.2] [RN:R01082] K01678 M00374 Dicarboxylate-hydroxybutyrate cycle 4,1 C00122 Fumarate C00149 (S)-Malate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K00239 M00374 Dicarboxylate-hydroxybutyrate cycle 5,0 C00042 Succinate C00122 Fumarate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K00240 M00374 Dicarboxylate-hydroxybutyrate cycle 5,0 C00042 Succinate C00122 Fumarate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K00241 M00374 Dicarboxylate-hydroxybutyrate cycle 5,0 C00042 Succinate C00122 Fumarate
+succinate dehydrogenase / fumarate reductase [EC:1.3.5.1 1.3.5.4] [RN:R02164] K18860 M00374 Dicarboxylate-hydroxybutyrate cycle 5,0 C00042 Succinate C00122 Fumarate
+succinyl-CoA synthetase [EC:6.2.1.5] [RN:R00405] K01902 M00374 Dicarboxylate-hydroxybutyrate cycle 6,0 C00091 Succinyl-CoA C00042 Succinate
+succinyl-CoA synthetase [EC:6.2.1.5] [RN:R00405] K01903 M00374 Dicarboxylate-hydroxybutyrate cycle 6,0 C00091 Succinyl-CoA C00042 Succinate
+succinyl-CoA reductase [EC:1.2.1.76] [RN:R09280] K15038 M00374 Dicarboxylate-hydroxybutyrate cycle 7,0 C00232 Succinate semialdehyde C00091 Succinyl-CoA
+succinyl-CoA reductase [EC:1.2.1.76] [RN:R09280] K15017 M00374 Dicarboxylate-hydroxybutyrate cycle 7,1 C00232 Succinate semialdehyde C00091 Succinyl-CoA
+succinate semialdehyde reductase (NADPH) [EC:1.1.1.-] [RN:R09281] K14465 M00374 Dicarboxylate-hydroxybutyrate cycle 8,0 C00989 4-Hydroxybutanoic acid C00232 Succinate semialdehyde
+4-hydroxybutyrate---CoA ligase (AMP-forming) [EC:6.2.1.40] [RN:R09279] K14467 M00374 Dicarboxylate-hydroxybutyrate cycle 9,0 C11062 4-Hydroxybutyryl-CoA C00989 4-Hydroxybutanoic acid
+4-hydroxybutyrate---CoA ligase (AMP-forming) [EC:6.2.1.40] [RN:R09279] K18861 M00374 Dicarboxylate-hydroxybutyrate cycle 9,1 C11062 4-Hydroxybutyryl-CoA C00989 4-Hydroxybutanoic acid
+4-hydroxybutyryl-CoA dehydratase [EC:4.2.1.120] [RN:R10782] K14534 M00374 Dicarboxylate-hydroxybutyrate cycle 10,0 C00877 Crotonoyl-CoA C11062 4-Hydroxybutyryl-CoA
+3-hydroxybutyryl-CoA dehydratase / 3-hydroxyacyl-CoA dehydrogenase [EC:4.2.1.17 1.1.1.35] [RN:R03026 R01975] K15016 M00374 Dicarboxylate-hydroxybutyrate cycle 11,0 C00332 Acetoacetyl-CoA C01144 (S)-3-Hydroxybutanoyl-CoA
+acetyl-CoA C-acetyltransferase [EC:2.3.1.9] [RN:R00238] K00626 M00374 Dicarboxylate-hydroxybutyrate cycle 12,0 C00024 Acetyl-CoA C00332 Acetoacetyl-CoA
+acetyl-CoA/propionyl-CoA carboxylase [EC:6.4.1.2 6.4.1.3] [RN:R00742 R01859] K01964 M00375 Hydroxypropionate-hydroxybutylate cycle 0,0 C00683 (S)-Methylmalonyl-CoA C00100 Propanoyl-CoA
+biotin carboxyl carrier protein [RN:R00742 R01859] K15037 M00375 Hydroxypropionate-hydroxybutylate cycle 0,0 C00683 (S)-Methylmalonyl-CoA C00100 Propanoyl-CoA
+acetyl-CoA/propionyl-CoA carboxylase [EC:6.4.1.2 6.4.1.3] [RN:R00742 R01859] K15036 M00375 Hydroxypropionate-hydroxybutylate cycle 0,0 C00683 (S)-Methylmalonyl-CoA C00100 Propanoyl-CoA
+malonyl-CoA reductase (NADPH) [EC:1.2.1.75] [RN:R00740] K15017 M00375 Hydroxypropionate-hydroxybutylate cycle 1,0 C00222 3-Oxopropanoate C00083 Malonyl-CoA
+3-hydroxypropionate dehydrogenase (NADP+) [EC:1.1.1.298] [RN:R09289] K15039 M00375 Hydroxypropionate-hydroxybutylate cycle 2,0 C01013 3-Hydroxypropanoate C00222 3-Oxopropanoate
+3-hydroxypropionyl-coenzyme A synthetase [EC:6.2.1.36] [RN:R09286] K15018 M00375 Hydroxypropionate-hydroxybutylate cycle 3,0 C05668 3-Hydroxypropionyl-CoA C01013 3-Hydroxypropanoate
+3-hydroxypropionyl-coenzyme A dehydratase [EC:4.2.1.116] [RN:R03045] K15019 M00375 Hydroxypropionate-hydroxybutylate cycle 4,0 C00894 Propenoyl-CoA C05668 3-Hydroxypropionyl-CoA
+acryloyl-coenzyme A reductase [EC:1.3.1.84] [RN:R00919] K15020 M00375 Hydroxypropionate-hydroxybutylate cycle 5,0 C00100 Propanoyl-CoA C00894 Propenoyl-CoA
+methylmalonyl-CoA epimerase [EC:5.1.99.1] [RN:R02765] K05606 M00375 Hydroxypropionate-hydroxybutylate cycle 6,0 C01213 (R)-Methylmalonyl-CoA C00683 (S)-Methylmalonyl-CoA
+methylmalonyl-CoA mutase [EC:5.4.99.2] [RN:R00833] K01848 M00375 Hydroxypropionate-hydroxybutylate cycle 7,0 C00091 Succinyl-CoA C01213 (R)-Methylmalonyl-CoA
+methylmalonyl-CoA mutase [EC:5.4.99.2] [RN:R00833] K01849 M00375 Hydroxypropionate-hydroxybutylate cycle 7,0 C00091 Succinyl-CoA C01213 (R)-Methylmalonyl-CoA
+succinyl-coA reductase [EC:1.2.1.76] [RN:R09280] K15038 M00375 Hydroxypropionate-hydroxybutylate cycle 8,0 C00232 Succinate semialdehyde C00091 Succinyl-CoA
+malonyl-CoA reductase (NADPH) [EC:1.2.1.75] [RN:R00740] K15017 M00375 Hydroxypropionate-hydroxybutylate cycle 8,1 C00222 3-Oxopropanoate C00083 Malonyl-CoA
+succinate semialdehyde reductase [EC:1.1.1.-] [RN:R09281] K14465 M00375 Hydroxypropionate-hydroxybutylate cycle 9,0 C00989 4-Hydroxybutanoic acid C00232 Succinate semialdehyde
+4-hydroxybutyrate---CoA ligase (AMP-forming) [EC:6.2.1.40] [RN:R09279] K14466 M00375 Hydroxypropionate-hydroxybutylate cycle 10,0 C11062 4-Hydroxybutyryl-CoA C00989 4-Hydroxybutanoic acid
+4-hydroxybutyrate---CoA ligase (AMP-forming) [EC:6.2.1.40] [RN:R09279] K18861 M00375 Hydroxypropionate-hydroxybutylate cycle 10,1 C11062 4-Hydroxybutyryl-CoA C00989 4-Hydroxybutanoic acid
+4-hydroxybutyryl-CoA dehydratase / vinylacetyl-CoA-Delta-isomerase [EC:4.2.1.120 5.3.3.3] [RN:R10782] K14534 M00375 Hydroxypropionate-hydroxybutylate cycle 11,0 C00877 Crotonoyl-CoA C11062 4-Hydroxybutyryl-CoA
+3-hydroxybutyryl-CoA dehydratase / 3-hydroxyacyl-CoA dehydrogenase [EC:4.2.1.17 1.1.1.35] [RN:R03026 R01975] K15016 M00375 Hydroxypropionate-hydroxybutylate cycle 12,0 C00332 Acetoacetyl-CoA C01144 (S)-3-Hydroxybutanoyl-CoA
+acetyl-CoA C-acetyltransferase [EC:2.3.1.9] [RN:R00238] K00626 M00375 Hydroxypropionate-hydroxybutylate cycle 13,0 C00024 Acetyl-CoA C00332 Acetoacetyl-CoA
+malyl-CoA/(S)-citramalyl-CoA lyase [EC:4.1.3.24 4.1.3.25] [RN:R00473 R00934 R00237] K08691 M00376 3-Hydroxypropionate bi-cycle 0,0 C00024,C00022 Acetyl-CoA,Pyruvate C01011 (3S)-Citramalyl-CoA
+2-methylfumaryl-CoA hydratase [EC:4.2.1.148] [RN:R05076] K14449 M00376 3-Hydroxypropionate bi-cycle 1,0 C06028 Mesaconyl-CoA C06027 L-erythro-3-Methylmalyl-CoA
+2-methylfumaryl-CoA isomerase [EC:5.4.1.3] [RN:R09283] K14470 M00376 3-Hydroxypropionate bi-cycle 2,0 C18323 Mesaconyl-C4-CoA C06028 Mesaconyl-CoA
+3-methylfumaryl-CoA hydratase [EC:4.2.1.153] [RN:R09282] K09709 M00376 3-Hydroxypropionate bi-cycle 3,0 C01011 (3S)-Citramalyl-CoA C18323 Mesaconyl-C4-CoA
+carbon-monoxide dehydrogenase [EC:1.2.7.4] [RN:R07157] K00198 M00377 Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) 0,0 C00237 CO C00011 CO2
+formate dehydrogenase [EC:1.17.1.10] [RN:R00134] K05299 M00377 Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) 1,0 C00058 Formate C00011 CO2
+formate dehydrogenase [EC:1.17.1.10] [RN:R00134] K15022 M00377 Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) 1,0 C00058 Formate C00011 CO2
+formate--tetrahydrofolate ligase [EC:6.3.4.3] [RN:R00943] K01938 M00377 Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) 2,0 C00234 10-Formyltetrahydrofolate C00058,C00101 Formate,Tetrahydrofolate
+methylenetetrahydrofolate dehydrogenase (NADP+) / methenyltetrahydrofolate cyclohydrolase [EC:1.5.1.5 3.5.4.9] [RN:R01655 R01220] K01491 M00377 Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) 3,0 C00143 5,10-Methylenetetrahydrofolate C00445 5,10-Methenyltetrahydrofolate
+methylenetetrahydrofolate reductase (NADPH) [EC:1.5.1.20] [RN:R07168] K00297 M00377 Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) 4,0 C00440 5-Methyltetrahydrofolate C00143 5,10-Methylenetetrahydrofolate
+5-methyltetrahydrofolate corrinoid/iron sulfur protein methyltransferase [EC:2.1.1.258] [RN:R02289] K15023 M00377 Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) 5,0 C00101,C00024 Tetrahydrofolate,Acetyl-CoA C00237,C00440 CO,5-Methyltetrahydrofolate
+acetyl-CoA synthase [EC:2.3.1.169] [RN:R08433] K14138 M00377 Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) 6,0 C00101,C00024 Tetrahydrofolate,Acetyl-CoA C00237,C00440 CO,5-Methyltetrahydrofolate
+acetyl-CoA decarbonylase/synthase complex [EC:2.3.1.-] [RN:R10243] K00197 M00377 Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) 6,0 C00101,C00024 Tetrahydrofolate,Acetyl-CoA C00237,C00440 CO,5-Methyltetrahydrofolate
+acetyl-CoA decarbonylase/synthase complex [EC:2.3.1.-] [RN:R10243] K00194 M00377 Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) 6,0 C00101,C00024 Tetrahydrofolate,Acetyl-CoA C00237,C00440 CO,5-Methyltetrahydrofolate
+LPPG:FO 2-phospho-L-lactate transferase [EC:2.7.8.28] [RN:R09398] K11212 M00378 F420 biosynthesis 0,0 C19153 Coenzyme F420-0 C19155,C19154 (2S)-Lactyl-2-diphospho-5'-guanosine,7,8-Didemethyl-8-hydroxy-5-deazariboflavin
+coenzyme F420-0:L-glutamate ligase / coenzyme F420-1:gamma-L-glutamate ligase [EC:6.3.2.31 6.3.2.34] [RN:R09399 R09400] K12234 M00378 F420 biosynthesis 1,0 C00876 Coenzyme F420 C19152 Coenzyme F420-1
+elongation of very long chain fatty acids protein [EC:2.3.1.199] K10247 M00415 Fatty acid elongation in endoplasmic reticulum 0,0
+elongation of very long chain fatty acids protein [EC:2.3.1.199] K10205 M00415 Fatty acid elongation in endoplasmic reticulum 0,1
+elongation of very long chain fatty acids protein [EC:2.3.1.199] K10248 M00415 Fatty acid elongation in endoplasmic reticulum 0,2
+elongation of very long chain fatty acids protein [EC:2.3.1.199] K10249 M00415 Fatty acid elongation in endoplasmic reticulum 0,3
+elongation of very long chain fatty acids protein [EC:2.3.1.199] K10244 M00415 Fatty acid elongation in endoplasmic reticulum 0,4
+elongation of very long chain fatty acids protein [EC:2.3.1.199] K10203 M00415 Fatty acid elongation in endoplasmic reticulum 0,5
+elongation of very long chain fatty acids protein [EC:2.3.1.199] K10250 M00415 Fatty acid elongation in endoplasmic reticulum 0,6
+elongation of very long chain fatty acids protein [EC:2.3.1.199] K15397 M00415 Fatty acid elongation in endoplasmic reticulum 0,7
+elongation of very long chain fatty acids protein [EC:2.3.1.199] K10245 M00415 Fatty acid elongation in endoplasmic reticulum 0,8
+elongation of very long chain fatty acids protein [EC:2.3.1.199] K10246 M00415 Fatty acid elongation in endoplasmic reticulum 0,9
+beta-keto reductase [EC:1.1.1.330] K10251 M00415 Fatty acid elongation in endoplasmic reticulum 1,0
+3-hydroxy acyl-CoA dehydratase [EC:4.2.1.134] K10703 M00415 Fatty acid elongation in endoplasmic reticulum 2,0
+enoyl reductase [EC:1.3.1.93] K10258 M00415 Fatty acid elongation in endoplasmic reticulum 3,0
+qoxB; cytochrome aa3-600 menaquinol oxidase subunit I [EC:1.10.3.12] K02827 M00416 Cytochrome aa3-600 menaquinol oxidase 0,0 C00828,C00001 Menaquinone,H2O C05819,C00007 Menaquinol,Oxygen
+qoxA; cytochrome aa3-600 menaquinol oxidase subunit II [EC:1.10.3.12] K02826 M00416 Cytochrome aa3-600 menaquinol oxidase 0,0 C00828,C00001 Menaquinone,H2O C05819,C00007 Menaquinol,Oxygen
+qoxC; cytochrome aa3-600 menaquinol oxidase subunit III [EC:1.10.3.12] K02828 M00416 Cytochrome aa3-600 menaquinol oxidase 0,0 C00828,C00001 Menaquinone,H2O C05819,C00007 Menaquinol,Oxygen
+qoxD; cytochrome aa3-600 menaquinol oxidase subunit IV [EC:1.10.3.12] K02829 M00416 Cytochrome aa3-600 menaquinol oxidase 0,0 C00828,C00001 Menaquinone,H2O C05819,C00007 Menaquinol,Oxygen
+cyoA; cytochrome o ubiquinol oxidase subunit II [EC:1.10.3.10] K02297 M00417 Cytochrome o ubiquinol oxidase 0,0
+cyoB; cytochrome o ubiquinol oxidase subunit I [EC:1.10.3.10] K02298 M00417 Cytochrome o ubiquinol oxidase 0,0
+cyoC; cytochrome o ubiquinol oxidase subunit III K02299 M00417 Cytochrome o ubiquinol oxidase 0,0
+cyoD; cytochrome o ubiquinol oxidase operon protein cyoD K02300 M00417 Cytochrome o ubiquinol oxidase 0,0
+benzylsuccinate synthase [EC:4.1.99.11] [RN:R05598] K07540 M00418 Toluene degradation, anaerobic, toluene => benzoyl-CoA 0,0 C09816 Benzylsuccinate C01455 Toluene
+benzylsuccinate CoA-transferase subunit [EC:2.8.3.15] [RN:R05588] K07543 M00418 Toluene degradation, anaerobic, toluene => benzoyl-CoA 1,0 C09817 Benzylsuccinyl-CoA C09816 Benzylsuccinate
+benzylsuccinate CoA-transferase subunit [EC:2.8.3.15] [RN:R05588] K07544 M00418 Toluene degradation, anaerobic, toluene => benzoyl-CoA 1,0 C09817 Benzylsuccinyl-CoA C09816 Benzylsuccinate
+bbsG; (R)-benzylsuccinyl-CoA dehydro genase [EC:1.3.8.3] [RN:R05584] K07545 M00418 Toluene degradation, anaerobic, toluene => benzoyl-CoA 2,0 C09818 E-Phenylitaconyl-CoA C09817 Benzylsuccinyl-CoA
+bbsH; E-phenylitaconyl-CoA hydratase [EC:4.2.1.-] [RN:R05599] K07546 M00418 Toluene degradation, anaerobic, toluene => benzoyl-CoA 3,0 C09819 (Hydroxymethylphenyl)succinyl-CoA C09818 E-Phenylitaconyl-CoA
+2-[hydroxy(phenyl)methyl]-succinyl-CoA dehydrogenase [EC:1.1.1.35] [RN:R05575] K07547 M00418 Toluene degradation, anaerobic, toluene => benzoyl-CoA 4,0 C09820 Benzoylsuccinyl-CoA C09819 (Hydroxymethylphenyl)succinyl-CoA
+2-[hydroxy(phenyl)methyl]-succinyl-CoA dehydrogenase [EC:1.1.1.35] [RN:R05575] K07548 M00418 Toluene degradation, anaerobic, toluene => benzoyl-CoA 4,0 C09820 Benzoylsuccinyl-CoA C09819 (Hydroxymethylphenyl)succinyl-CoA
+benzoylsuccinyl-CoA thiolase [EC:2.3.1.-] [RN:R05587] K07549 M00418 Toluene degradation, anaerobic, toluene => benzoyl-CoA 5,0 C00512 S-Benzoate coenzyme A C09820 Benzoylsuccinyl-CoA
+benzoylsuccinyl-CoA thiolase [EC:2.3.1.-] [RN:R05587] K07550 M00418 Toluene degradation, anaerobic, toluene => benzoyl-CoA 5,0 C00512 S-Benzoate coenzyme A C09820 Benzoylsuccinyl-CoA
+cymAa; p-cymene methyl-monooxygenase [EC:1.14.15.25] [RN:R05266] K10616 M00419 Cymene degradation, p-cymene => p-cumate 0,0 C06576 p-Cumic alcohol C06575 p-Cymene
+cymAb; p-cymene methyl-monooxygenase electron transfer component [EC:1.18.1.3] K18293 M00419 Cymene degradation, p-cymene => p-cumate 0,0 C06576 p-Cumic alcohol C06575 p-Cymene
+cymB; p-cumic alcohol dehydrogenase [RN:R05232] K10617 M00419 Cymene degradation, p-cymene => p-cumate 1,0 C06577 4-Isopropylbenzaldehyde C06576 p-Cumic alcohol
+cymC; p-cumic aldehyde dehydrogenase [RN:R05235] K10618 M00419 Cymene degradation, p-cymene => p-cumate 2,0 C06578 p-Cumate C06577 4-Isopropylbenzaldehyde
+cdhA; anaerobic carbon-monoxide dehydrogenase, CODH/ACS complex subunit alpha [EC:1.2.7.4] [RN:R07157] K00192 M00422 Acetyl-CoA pathway, CO2 => acetyl-CoA 0,0 C00237 CO C00011 CO2
+cdhB; anaerobic carbon-monoxide dehydrogenase, CODH/ACS complex subunit epsilon [RN:R07157] K00195 M00422 Acetyl-CoA pathway, CO2 => acetyl-CoA 0,0 C00237 CO C00011 CO2
+cdhC; acetyl-CoA decarbonylase/synthase, CODH/ACS complex subunit beta [EC:2.3.1.169] [RN:R09096 R10219] K00193 M00422 Acetyl-CoA pathway, CO2 => acetyl-CoA 1,0 C00024 Acetyl-CoA C00237 CO
+cdhE; acetyl-CoA decarbonylase/synthase, CODH/ACS complex subunit gamma [EC:2.1.1.245] [RN:R09096 R10219] K00197 M00422 Acetyl-CoA pathway, CO2 => acetyl-CoA 1,0 C00024 Acetyl-CoA C00237 CO
+cdhD; acetyl-CoA decarbonylase/synthase, CODH/ACS complex subunit delta [EC:2.1.1.245] [RN:R09096 R10219] K00194 M00422 Acetyl-CoA pathway, CO2 => acetyl-CoA 1,0 C00024 Acetyl-CoA C00237 CO
+2-isopropylmalate synthase [EC:2.3.3.13] [RN:R01213] K01649 M00432 Leucine biosynthesis, 2-oxoisovalerate => 2-oxoisocaproate 0,0 C02504 alpha-Isopropylmalate C00141,C00024 3-Methyl-2-oxobutanoic acid,Acetyl-CoA
+3-isopropylmalate dehydratase [EC:4.2.1.33] [RN:R03968 R04001] K01702 M00432 Leucine biosynthesis, 2-oxoisovalerate => 2-oxoisocaproate 1,0 C04411 (2R,3S)-3-Isopropylmalate C02504 alpha-Isopropylmalate
+3-isopropylmalate dehydratase [EC:4.2.1.33] [RN:R03968 R04001] K01703 M00432 Leucine biosynthesis, 2-oxoisovalerate => 2-oxoisocaproate 1,1 C04411 (2R,3S)-3-Isopropylmalate C02504 alpha-Isopropylmalate
+3-isopropylmalate dehydratase [EC:4.2.1.33] [RN:R03968 R04001] K01704 M00432 Leucine biosynthesis, 2-oxoisovalerate => 2-oxoisocaproate 1,1 C04411 (2R,3S)-3-Isopropylmalate C02504 alpha-Isopropylmalate
+3-isopropylmalate dehydrogenase [EC:1.1.1.85] [RN:R04426] K00052 M00432 Leucine biosynthesis, 2-oxoisovalerate => 2-oxoisocaproate 2,0 C00233 4-Methyl-2-oxopentanoate C04411 (2R,3S)-3-Isopropylmalate
+homocitrate synthase [EC:2.3.3.14] [RN:R00271] K01655 M00433 Lysine biosynthesis, 2-oxoglutarate => 2-oxoadipate 0,0 C01251 (R)-2-Hydroxybutane-1,2,4-tricarboxylate C00026,C00024 2-Oxoglutarate,Acetyl-CoA
+homoaconitase [EC:4.2.1.- 4.2.1.36 4.2.1.114] [RN:R03444 R04371 R09720] K17450 M00433 Lysine biosynthesis, 2-oxoglutarate => 2-oxoadipate 1,0,0,0 C05662 Homoisocitrate C01251 (R)-2-Hydroxybutane-1,2,4-tricarboxylate
+homoaconitase [EC:4.2.1.- 4.2.1.36 4.2.1.114] [RN:R03444 R04371 R09720] K01705 M00433 Lysine biosynthesis, 2-oxoglutarate => 2-oxoadipate 1,0,1,0 C05662 Homoisocitrate C01251 (R)-2-Hydroxybutane-1,2,4-tricarboxylate
+homoaconitase [EC:4.2.1.- 4.2.1.36 4.2.1.114] [RN:R03444 R04371 R09720] K16792 M00433 Lysine biosynthesis, 2-oxoglutarate => 2-oxoadipate 1,1 C05662 Homoisocitrate C01251 (R)-2-Hydroxybutane-1,2,4-tricarboxylate
+homoaconitase [EC:4.2.1.- 4.2.1.36 4.2.1.114] [RN:R03444 R04371 R09720] K16793 M00433 Lysine biosynthesis, 2-oxoglutarate => 2-oxoadipate 1,1 C05662 Homoisocitrate C01251 (R)-2-Hydroxybutane-1,2,4-tricarboxylate
+homoisocitrate dehydrogenase [EC:1.1.1.87] [RN:R01934] K05824 M00433 Lysine biosynthesis, 2-oxoglutarate => 2-oxoadipate 2,0 C00322 2-Oxoadipate C05662 Homoisocitrate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K00928 M00525 Lysine biosynthesis, acetyl-DAP pathway, aspartate => lysine 0,0 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate-semialdehyde dehydrogenase [EC:1.2.1.11] [RN:R02291] K00133 M00525 Lysine biosynthesis, acetyl-DAP pathway, aspartate => lysine 1,0 C00441 L-Aspartate 4-semialdehyde C03082 4-Phospho-L-aspartate
+4-hydroxy-tetrahydrodipicolinate synthase [EC:4.3.3.7] [RN:R10147] K01714 M00525 Lysine biosynthesis, acetyl-DAP pathway, aspartate => lysine 2,0 C20258 (2S,4S)-4-Hydroxy-2,3,4,5-tetrahydrodipicolinate C00441 L-Aspartate 4-semialdehyde
+4-hydroxy-tetrahydrodipicolinate reductase [EC:1.17.1.8] [RN:R04198 R04199] K00215 M00525 Lysine biosynthesis, acetyl-DAP pathway, aspartate => lysine 3,0 C03972 2,3,4,5-Tetrahydrodipicolinate C20258 (2S,4S)-4-Hydroxy-2,3,4,5-tetrahydrodipicolinate
+tetrahydrodipicolinate N-acetyltransferase [EC:2.3.1.89] [RN:R04364] K05822 M00525 Lysine biosynthesis, acetyl-DAP pathway, aspartate => lysine 4,0 C05539 N-Acetyl-L-2-amino-6-oxopimelate C03972 2,3,4,5-Tetrahydrodipicolinate
+aminotransferase [EC:2.6.1.-] [RN:R04467] K00841 M00525 Lysine biosynthesis, acetyl-DAP pathway, aspartate => lysine 5,0 C04390 N6-Acetyl-LL-2,6-diaminoheptanedioate C05539 N-Acetyl-L-2-amino-6-oxopimelate
+N-acetyldiaminopimelate deacetylase [EC:3.5.1.47] [RN:R02733] K05823 M00525 Lysine biosynthesis, acetyl-DAP pathway, aspartate => lysine 6,0 C00666 LL-2,6-Diaminoheptanedioate C04390 N6-Acetyl-LL-2,6-diaminoheptanedioate
+diaminopimelate epimerase [EC:5.1.1.7] [RN:R02735] K01778 M00525 Lysine biosynthesis, acetyl-DAP pathway, aspartate => lysine 7,0 C00680 meso-2,6-Diaminoheptanedioate C00666 LL-2,6-Diaminoheptanedioate
+diaminopimelate decarboxylase [EC:4.1.1.20] [RN:R00451] K01586 M00525 Lysine biosynthesis, acetyl-DAP pathway, aspartate => lysine 8,0 C00047 L-Lysine C00680 meso-2,6-Diaminoheptanedioate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K00928 M00526 Lysine biosynthesis, DAP dehydrogenase pathway, aspartate => lysine 0,0 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12524 M00526 Lysine biosynthesis, DAP dehydrogenase pathway, aspartate => lysine 0,1 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12525 M00526 Lysine biosynthesis, DAP dehydrogenase pathway, aspartate => lysine 0,2 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12526 M00526 Lysine biosynthesis, DAP dehydrogenase pathway, aspartate => lysine 0,3 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate-semialdehyde dehydrogenase [EC:1.2.1.11] [RN:R02291] K00133 M00526 Lysine biosynthesis, DAP dehydrogenase pathway, aspartate => lysine 1,0 C00441 L-Aspartate 4-semialdehyde C03082 4-Phospho-L-aspartate
+4-hydroxy-tetrahydrodipicolinate synthase [EC:4.3.3.7] [RN:R10147] K01714 M00526 Lysine biosynthesis, DAP dehydrogenase pathway, aspartate => lysine 2,0 C20258 (2S,4S)-4-Hydroxy-2,3,4,5-tetrahydrodipicolinate C00441 L-Aspartate 4-semialdehyde
+4-hydroxy-tetrahydrodipicolinate reductase [EC:1.17.1.8] [RN:R04198 R04199] K00215 M00526 Lysine biosynthesis, DAP dehydrogenase pathway, aspartate => lysine 3,0 C03972 2,3,4,5-Tetrahydrodipicolinate C20258 (2S,4S)-4-Hydroxy-2,3,4,5-tetrahydrodipicolinate
+diaminopimelate dehydrogenase [EC:1.4.1.16] [RN:R02755] K03340 M00526 Lysine biosynthesis, DAP dehydrogenase pathway, aspartate => lysine 4,0 C00680 meso-2,6-Diaminoheptanedioate C03871 L-2-Amino-6-oxoheptanedioate
+diaminopimelate decarboxylase [EC:4.1.1.20] [RN:R00451] K01586 M00526 Lysine biosynthesis, DAP dehydrogenase pathway, aspartate => lysine 5,0 C00047 L-Lysine C00680 meso-2,6-Diaminoheptanedioate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12526 M00526 Lysine biosynthesis, DAP dehydrogenase pathway, aspartate => lysine 5,1 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K00928 M00527 Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine 0,0 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12524 M00527 Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine 0,1 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12525 M00527 Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine 0,2 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12526 M00527 Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine 0,3 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+aspartate-semialdehyde dehydrogenase [EC:1.2.1.11] [RN:R02291] K00133 M00527 Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine 1,0 C00441 L-Aspartate 4-semialdehyde C03082 4-Phospho-L-aspartate
+4-hydroxy-tetrahydrodipicolinate synthase [EC:4.3.3.7] [RN:R10147] K01714 M00527 Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine 2,0 C20258 (2S,4S)-4-Hydroxy-2,3,4,5-tetrahydrodipicolinate C00441 L-Aspartate 4-semialdehyde
+4-hydroxy-tetrahydrodipicolinate reductase [EC:1.17.1.8] [RN:R04198 R04199] K00215 M00527 Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine 3,0 C03972 2,3,4,5-Tetrahydrodipicolinate C20258 (2S,4S)-4-Hydroxy-2,3,4,5-tetrahydrodipicolinate
+LL-diaminopimelate aminotransferase [EC:2.6.1.83] [RN:R07613] K10206 M00527 Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine 4,0 C00666 LL-2,6-Diaminoheptanedioate C03972 2,3,4,5-Tetrahydrodipicolinate
+diaminopimelate epimerase [EC:5.1.1.7] [RN:R02735] K01778 M00527 Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine 5,0 C00680 meso-2,6-Diaminoheptanedioate C00666 LL-2,6-Diaminoheptanedioate
+diaminopimelate decarboxylase [EC:4.1.1.20] [RN:R00451] K01586 M00527 Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine 6,0 C00047 L-Lysine C00680 meso-2,6-Diaminoheptanedioate
+aspartate kinase [EC:2.7.2.4] [RN:R00480] K12526 M00527 Lysine biosynthesis, DAP aminotransferase pathway, aspartate => lysine 6,1 C03082 4-Phospho-L-aspartate C00049 L-Aspartate
+ammonia monooxygenase [EC:1.14.99.39] [RN:R00148] K10944 M00528 Nitrification, ammonia => nitrite 0,0 C00192 Hydroxylamine C00014 Ammonia
+ammonia monooxygenase [EC:1.14.99.39] [RN:R00148] K10945 M00528 Nitrification, ammonia => nitrite 0,0 C00192 Hydroxylamine C00014 Ammonia
+ammonia monooxygenase [EC:1.14.99.39] [RN:R00148] K10946 M00528 Nitrification, ammonia => nitrite 0,0 C00192 Hydroxylamine C00014 Ammonia
+hydroxylamine oxidase [EC:1.7.2.6] [RN:R10164] K10535 M00528 Nitrification, ammonia => nitrite 1,0 C00088 Nitrite C00192 Hydroxylamine
+nitrate reductase 1 [EC:1.7.99.-] [RN:R00798] K00370 M00529 Denitrification, nitrate => nitrogen 0,0 C00088 Nitrite C00244 Nitrate
+nitrate reductase 1 [EC:1.7.99.-] [RN:R00798] K00371 M00529 Denitrification, nitrate => nitrogen 0,0 C00088 Nitrite C00244 Nitrate
+nitrate reductase 1 [EC:1.7.99.-] [RN:R00798] K00374 M00529 Denitrification, nitrate => nitrogen 0,0 C00088 Nitrite C00244 Nitrate
+periplasmic nitrate reductase NapA [EC:1.7.99.-] [RN:R00798] K02567 M00529 Denitrification, nitrate => nitrogen 0,1 C00088 Nitrite C00244 Nitrate
+cytochrome c-type protein NapB [RN:R00798] K02568 M00529 Denitrification, nitrate => nitrogen 0,1 C00088 Nitrite C00244 Nitrate
+nitrite reductase (NO-forming) [EC:1.7.2.1] [RN:R00783 R00785] K00368 M00529 Denitrification, nitrate => nitrogen 1,0 C00533 Nitric oxide C00088 Nitrite
+nitrite reductase (NO-forming) [EC:1.7.2.1] [RN:R00783 R00785] K15864 M00529 Denitrification, nitrate => nitrogen 1,1 C00533 Nitric oxide C00088 Nitrite
+nitric oxide reductase [EC:1.7.2.5] [RN:R00294] K04561 M00529 Denitrification, nitrate => nitrogen 2,0 C00887 Nitrous oxide C00533 Nitric oxide
+nitric oxide reductase [EC:1.7.2.5] [RN:R00294] K02305 M00529 Denitrification, nitrate => nitrogen 2,0 C00887 Nitrous oxide C00533 Nitric oxide
+fungal nitric oxide reductase [EC:1.7.1.14] [RN:R02492 R09446 R09808 R09809] K15877 M00529 Denitrification, nitrate => nitrogen 2,1 C00887 Nitrous oxide C00533 Nitric oxide
+nitrous-oxide reductase [EC:1.7.2.4] [RN:R02804] K00376 M00529 Denitrification, nitrate => nitrogen 3,0 C00697 Nitrogen C00887 Nitrous oxide
+respiratory nitrate reductase 1 [EC:1.7.99.-] [RN:R00798] K00370 M00530 Dissimilatory nitrate reduction, nitrate => ammonia 0,0 C00088 Nitrite C00244 Nitrate
+respiratory nitrate reductase 1 [EC:1.7.99.-] [RN:R00798] K00371 M00530 Dissimilatory nitrate reduction, nitrate => ammonia 0,0 C00088 Nitrite C00244 Nitrate
+respiratory nitrate reductase 1 [EC:1.7.99.-] [RN:R00798] K00374 M00530 Dissimilatory nitrate reduction, nitrate => ammonia 0,0 C00088 Nitrite C00244 Nitrate
+dissimilatory nitrate reductase [EC:1.7.99.-] [RN:R00798] K02567 M00530 Dissimilatory nitrate reduction, nitrate => ammonia 0,1 C00088 Nitrite C00244 Nitrate
+dissimilatory nitrate reductase [EC:1.7.99.-] [RN:R00798] K02568 M00530 Dissimilatory nitrate reduction, nitrate => ammonia 0,1 C00088 Nitrite C00244 Nitrate
+respiratory nitrite reductase [EC:1.7.1.15] [RN:R00787] K00362 M00530 Dissimilatory nitrate reduction, nitrate => ammonia 1,0 C00014 NH3 C00088 Nitrite
+respiratory nitrite reductase [EC:1.7.1.15] [RN:R00787] K00363 M00530 Dissimilatory nitrate reduction, nitrate => ammonia 1,0 C00014 NH3 C00088 Nitrite
+respiratory nitrite reductase [EC:1.7.2.2] [RN:R05712] K03385 M00530 Dissimilatory nitrate reduction, nitrate => ammonia 1,1 C00014 NH3 C00088 Nitrite
+respiratory nitrite reductase [EC:1.7.2.2] [RN:R05712] K15876 M00530 Dissimilatory nitrate reduction, nitrate => ammonia 1,1 C00014 NH3 C00088 Nitrite
+assimilatory nitrate reductase [EC:1.7.7.2] [RN:R00791] K00367 M00531 Assimilatory nitrate reduction, nitrate => ammonia 0,0 C00088 Nitrite C00244 Nitrate
+nitrate reductase (NAD(P)H) [EC:1.7.1.1 1.7.1.2 1.7.1.3] [RN:R00794 R00796] K10534 M00531 Assimilatory nitrate reduction, nitrate => ammonia 0,1 C00088 Nitrite C00244 Nitrate
+assimilatory nitrate reductase [EC:1.7.99.-] [RN:R00798] K00372 M00531 Assimilatory nitrate reduction, nitrate => ammonia 0,2 C00088 Nitrite C00244 Nitrate
+assimilatory nitrate reductase [EC:1.7.99.-] [RN:R00798] K00360 M00531 Assimilatory nitrate reduction, nitrate => ammonia 0,2 C00088 Nitrite C00244 Nitrate
+assimilatory nitrite reductase [EC:1.7.7.1] [RN:R00790] K00366 M00531 Assimilatory nitrate reduction, nitrate => ammonia 1,0 C00014 NH3 C00088 Nitrite
+assimilatory nitrite reductase [EC:1.7.1.4] [RN:R00787 R00789] K17877 M00531 Assimilatory nitrate reduction, nitrate => ammonia 1,1
+glycine cleavage system [RN:R01221] K00281 M00532 Photorespiration 0,0 C00014 NH3 C00037 Glycine
+glycine cleavage system [RN:R01221] K00605 M00532 Photorespiration 0,0 C00014 NH3 C00037 Glycine
+glycine cleavage system [RN:R01221] K00382 M00532 Photorespiration 0,0 C00014 NH3 C00037 Glycine
+glycine cleavage system [RN:R01221] K02437 M00532 Photorespiration 0,0 C00014 NH3 C00037 Glycine
+3,4-dihydroxyphenylacetate 2,3-dioxygenase [EC:1.13.11.15] [RN:R03303] K00455 M00533 Homoprotocatechuate degradation, homoprotocatechuate => 2-oxohept-3-enedioate 0,0 C04642 2-Hydroxy-5-carboxymethylmuconate semialdehyde C01161 3,4-Dihydroxyphenylacetate
+5-carboxymethyl-2-hydroxymuconic-semialdehyde dehydrogenase [EC:1.2.1.60] [RN:R04418] K00151 M00533 Homoprotocatechuate degradation, homoprotocatechuate => 2-oxohept-3-enedioate 1,0 C04186 5-Carboxymethyl-2-hydroxymuconate C04642 2-Hydroxy-5-carboxymethylmuconate semialdehyde
+2-hydroxy-4-carboxymuconate semialdehyde hemiacetal dehydrogenase [EC:1.1.1.312] [RN:R04418] K10219 M00533 Homoprotocatechuate degradation, homoprotocatechuate => 2-oxohept-3-enedioate 1,1 C04186 5-Carboxymethyl-2-hydroxymuconate C04642 2-Hydroxy-5-carboxymethylmuconate semialdehyde
+5-carboxymethyl-2-hydroxymuconate isomerase [EC:5.3.3.10][RN:R04379] K01826 M00533 Homoprotocatechuate degradation, homoprotocatechuate => 2-oxohept-3-enedioate 2,0 C04052 5-Carboxy-2-oxohept-3-enedioate C04186 5-Carboxymethyl-2-hydroxymuconate
+5-oxopent-3-ene-1,2,5-tricarboxylate decarboxylase / 2-hydroxyhepta-2,4-diene-1,7-dioate isomerase [EC:4.1.1.68 5.3.3.-] [RN:R04380 R04134] K05921 M00533 Homoprotocatechuate degradation, homoprotocatechuate => 2-oxohept-3-enedioate 3,0 C03063 2-Oxohept-3-enedioate C05600 2-Hydroxyhepta-2,4-dienedioate
+nahA; naphthalene 1,2-dioxygenase [EC:1.14.12.12] [RN:R02968] K14579 M00534 Naphthalene degradation, naphthalene => salicylate 0,0 C04314 cis-1,2-Dihydronaphthalene-1,2-diol C00829 Naphthalene
+nahA; naphthalene 1,2-dioxygenase [EC:1.14.12.12] [RN:R02968] K14580 M00534 Naphthalene degradation, naphthalene => salicylate 0,0 C04314 cis-1,2-Dihydronaphthalene-1,2-diol C00829 Naphthalene
+nahA; naphthalene 1,2-dioxygenase [EC:1.14.12.12] [RN:R02968] K14578 M00534 Naphthalene degradation, naphthalene => salicylate 0,0 C04314 cis-1,2-Dihydronaphthalene-1,2-diol C00829 Naphthalene
+nahA; naphthalene 1,2-dioxygenase [EC:1.14.12.12] [RN:R02968] K14581 M00534 Naphthalene degradation, naphthalene => salicylate 0,0 C04314 cis-1,2-Dihydronaphthalene-1,2-diol C00829 Naphthalene
+nahB; cis-1,2-dihydro-1,2-dihydroxynaphthalene/dibenzothiophene dihydrodiol dehydrogenase [EC:1.3.1.29] [RN:R04115] K14582 M00534 Naphthalene degradation, naphthalene => salicylate 1,0 C03012 Naphthalene-1,2-diol C04314 cis-1,2-Dihydronaphthalene-1,2-diol
+1,2-dihydroxynaphthalene dioxygenase [EC:1.13.11.56] [RN:R04117] K14583 M00534 Naphthalene degradation, naphthalene => salicylate 2,0 C06204 2-Hydroxychromene-2-carboxylate C03012 Naphthalene-1,2-diol
+2-hydroxychromene-2-carboxylate isomerase [EC:5.99.1.4] [RN:R05137] K14584 M00534 Naphthalene degradation, naphthalene => salicylate 3,0 C06203 trans-O-Hydroxybenzylidenepyruvate C06204 2-Hydroxychromene-2-carboxylate
+trans-o-hydroxybenzylidenepyruvate hydratase-aldolase [EC:4.1.2.45] [RN:R05136] K14585 M00534 Naphthalene degradation, naphthalene => salicylate 4,0 C06202 Salicylaldehyde C06203 trans-O-Hydroxybenzylidenepyruvate
+salicylaldehyde dehydrogenase [EC:1.2.1.65] [RN:R02941] K00152 M00534 Naphthalene degradation, naphthalene => salicylate 5,0 C00805 Salicylate C06202 Salicylaldehyde
+cimA; D-citramalate synthase [EC:2.3.1.182] [RN:R07399] K09011 M00535 Isoleucine biosynthesis, pyruvate => 2-oxobutanoate 0,0 C02612 (R)-2-Methylmalate C00022 Pyruvate
+leuCD; 3-isopropylmalate/(R)-2-methylmalate dehydratase [EC:4.2.1.33 4.2.1.35] [RN:R03896 R03898] K01703 M00535 Isoleucine biosynthesis, pyruvate => 2-oxobutanoate 1,0 C06032 D-erythro-3-Methylmalate C02226 2-Methylmaleate
+leuCD; 3-isopropylmalate/(R)-2-methylmalate dehydratase [EC:4.2.1.33 4.2.1.35] [RN:R03896 R03898] K01704 M00535 Isoleucine biosynthesis, pyruvate => 2-oxobutanoate 1,0 C06032 D-erythro-3-Methylmalate C02226 2-Methylmaleate
+leuB; 3-isopropylmalate dehydrogenase [EC:1.1.1.85] [RN:R00994] K00052 M00535 Isoleucine biosynthesis, pyruvate => 2-oxobutanoate 2,0 C00109 2-Oxobutanoate C06032 D-erythro-3-Methylmalate
+xylM; xylene monooxygenase [EC:1.14.13.-] [RN:R05288 R05442 R05443] K15757 M00537 Xylene degradation, xylene => methylbenzoate 0,0 C07216 3-Methylbenzyl alcohol C07208 m-Xylene
+xylene monooxygenase electron transfer component [EC:1.18.1.3] K15758 M00537 Xylene degradation, xylene => methylbenzoate 0,0 C07216 3-Methylbenzyl alcohol C07208 m-Xylene
+E1.1.1.90; aryl-alcohol dehydrogenase [EC:1.1.1.90] [RN:R05282 R05348 R05347] K00055 M00537 Xylene degradation, xylene => methylbenzoate 1,0 C07209 3-Methylbenzaldehyde C07216 3-Methylbenzyl alcohol
+xylC; benzaldehyde dehydrogenase (NAD) [EC:1.2.1.28] [RN:R05289 R05663 R05664] K00141 M00537 Xylene degradation, xylene => methylbenzoate 2,0 C07211 m-Methylbenzoate C07209 3-Methylbenzaldehyde
+toluene monooxygenase system [EC:1.14.13.-] [RN:R02550] K15760 M00538 Toluene degradation, toluene => benzoate 0,0 C00556 Benzyl alcohol C01455 Toluene
+toluene monooxygenase system [EC:1.14.13.-] [RN:R02550] K15761 M00538 Toluene degradation, toluene => benzoate 0,0 C00556 Benzyl alcohol C01455 Toluene
+toluene monooxygenase system [EC:1.14.13.-] [RN:R02550] K15762 M00538 Toluene degradation, toluene => benzoate 0,0 C00556 Benzyl alcohol C01455 Toluene
+toluene monooxygenase system [EC:1.14.13.-] [RN:R02550] K15763 M00538 Toluene degradation, toluene => benzoate 0,0 C00556 Benzyl alcohol C01455 Toluene
+toluene monooxygenase system [EC:1.14.13.-] [RN:R02550] K15764 M00538 Toluene degradation, toluene => benzoate 0,0 C00556 Benzyl alcohol C01455 Toluene
+toluene monooxygenase system [EC:1.14.13.-] [RN:R02550] K15765 M00538 Toluene degradation, toluene => benzoate 0,0 C00556 Benzyl alcohol C01455 Toluene
+xylB; aryl-alcohol dehydrogenase [EC:1.1.1.90] [RN:R01763] K00055 M00538 Toluene degradation, toluene => benzoate 1,0 C00261 Benzaldehyde C00556 Benzyl alcohol
+xylC; benzaldehyde dehydrogenase (NAD) [EC:1.2.1.28] [RN:R01419] K00141 M00538 Toluene degradation, toluene => benzoate 2,0 C00180 Benzoate C00261 Benzaldehyde
+cmtA; p-cumate 2,3-dioxygenase [EC:1.14.12.25] [RN:R05247] K10619 M00539 Cumate degradation, p-cumate => 2-oxopent-4-enoate + 2-methylpropanoate 0,0 C06579 cis-2,3-Dihydroxy-2,3-dihydro-p-cumate C06578 p-Cumate
+cmtA; p-cumate 2,3-dioxygenase [EC:1.14.12.25] [RN:R05247] K16303 M00539 Cumate degradation, p-cumate => 2-oxopent-4-enoate + 2-methylpropanoate 0,0 C06579 cis-2,3-Dihydroxy-2,3-dihydro-p-cumate C06578 p-Cumate
+cmtA; p-cumate 2,3-dioxygenase [EC:1.14.12.25] [RN:R05247] K16304 M00539 Cumate degradation, p-cumate => 2-oxopent-4-enoate + 2-methylpropanoate 0,0 C06579 cis-2,3-Dihydroxy-2,3-dihydro-p-cumate C06578 p-Cumate
+cmtA; p-cumate 2,3-dioxygenase [EC:1.14.12.25] [RN:R05247] K18227 M00539 Cumate degradation, p-cumate => 2-oxopent-4-enoate + 2-methylpropanoate 0,0 C06579 cis-2,3-Dihydroxy-2,3-dihydro-p-cumate C06578 p-Cumate
+cmtB; 2,3-dihydroxy-2,3-dihydro-p-cumate dehydrogenase [EC:1.3.1.58] [RN:R05240] K10620 M00539 Cumate degradation, p-cumate => 2-oxopent-4-enoate + 2-methylpropanoate 1,0 C06580 2,3-Dihydroxy-p-cumate C06579 cis-2,3-Dihydroxy-2,3-dihydro-p-cumate
+cmtC; 2,3-dihydroxy-p-cumate-3,4-dioxygenase [EC:1.13.11.-] [RN:R05248] K10621 M00539 Cumate degradation, p-cumate => 2-oxopent-4-enoate + 2-methylpropanoate 2,0 C06581 2-Hydroxy-3-carboxy-6-oxo-7-methylocta-2,4-dienoate C06580 2,3-Dihydroxy-p-cumate
+cmtD; HCOMODA decarboxylase [EC:4.1.1.-] [RN:R05377] K10622 M00539 Cumate degradation, p-cumate => 2-oxopent-4-enoate + 2-methylpropanoate 3,0 C06582 2-Hydroxy-6-oxo-7-methylocta-2,4-dienoate C06581 2-Hydroxy-3-carboxy-6-oxo-7-methylocta-2,4-dienoate
+cmtE; HOMODA hydrolase [EC:3.7.1.-] [RN: R05364] K10623 M00539 Cumate degradation, p-cumate => 2-oxopent-4-enoate + 2-methylpropanoate 4,0 C00596,C02632 2-Hydroxy-2,4-pentadienoate,2-Methylpropanoate C06582 2-Hydroxy-6-oxo-7-methylocta-2,4-dienoate
+aliA; cyclohexanecarboxylate-CoA ligase [EC:6.2.1.-] [RN:R05620] K04116 M00540 Benzoate degradation, cyclohexanecarboxylic acid =>pimeloyl-CoA 0,0 C09823 Cyclohexane-1-carboxyl-CoA C09822 Cyclohexane-1-carboxylate
+aliB; cyclohexanecarboxyl-CoA dehydrogenase [EC:1.3.99.-] [RN:R05619] K04117 M00540 Benzoate degradation, cyclohexanecarboxylic acid =>pimeloyl-CoA 1,0 C09811 Cyclohex-1-ene-1-carboxyl-CoA C09823 Cyclohexane-1-carboxyl-CoA
+badK; cyclohex-1-ene-1-carboxyl-CoA hydratase [EC:4.2.1.-] [RN:R05600] K07534 M00540 Benzoate degradation, cyclohexanecarboxylic acid =>pimeloyl-CoA 2,0 C09812 2-Hydroxycyclohexane-1-carboxyl-CoA C09811 Cyclohex-1-ene-1-carboxyl-CoA
+badH; 2-hydroxycyclohexanecarboxyl-CoA dehydrogenase [EC:1.1.1.-] [RN:R05582] K07535 M00540 Benzoate degradation, cyclohexanecarboxylic acid =>pimeloyl-CoA 3,0 C09813 2-Ketocyclohexane-1-carboxyl-CoA C09812 2-Hydroxycyclohexane-1-carboxyl-CoA
+badI; 2-ketocyclohexanecarboxyl-CoA hydrolase [EC:3.1.2.-] [RN:R05592] K07536 M00540 Benzoate degradation, cyclohexanecarboxylic acid =>pimeloyl-CoA 4,0 C01063 6-Carboxyhexanoyl-CoA C09813 2-Ketocyclohexane-1-carboxyl-CoA
+benzoyl-CoA reductase [EC:1.3.7.8] [RN:R02451] K04112 M00541 Benzoyl-CoA degradation, benzoyl-CoA => 3-hydroxypimeloyl-CoA 0,0 C06322 S-1,5-Cyclohexadiene-1-carboxylate coenzymeA C00512 S-Benzoate coenzyme A
+benzoyl-CoA reductase [EC:1.3.7.8] [RN:R02451] K04113 M00541 Benzoyl-CoA degradation, benzoyl-CoA => 3-hydroxypimeloyl-CoA 0,0 C06322 S-1,5-Cyclohexadiene-1-carboxylate coenzymeA C00512 S-Benzoate coenzyme A
+benzoyl-CoA reductase [EC:1.3.7.8] [RN:R02451] K04114 M00541 Benzoyl-CoA degradation, benzoyl-CoA => 3-hydroxypimeloyl-CoA 0,0 C06322 S-1,5-Cyclohexadiene-1-carboxylate coenzymeA C00512 S-Benzoate coenzyme A
+benzoyl-CoA reductase [EC:1.3.7.8] [RN:R02451] K04115 M00541 Benzoyl-CoA degradation, benzoyl-CoA => 3-hydroxypimeloyl-CoA 0,0 C06322 S-1,5-Cyclohexadiene-1-carboxylate coenzymeA C00512 S-Benzoate coenzyme A
+benzoyl-CoA reductase [EC:1.3.-.-] [RN:R10961] K19515 M00541 Benzoyl-CoA degradation, benzoyl-CoA => 3-hydroxypimeloyl-CoA 0,1 C06322 S-1,5-Cyclohexadiene-1-carboxylate coenzymeA C00512 S-Benzoate coenzyme A
+benzoyl-CoA reductase [EC:1.3.-.-] [RN:R10961] K19516 M00541 Benzoyl-CoA degradation, benzoyl-CoA => 3-hydroxypimeloyl-CoA 0,1 C06322 S-1,5-Cyclohexadiene-1-carboxylate coenzymeA C00512 S-Benzoate coenzyme A
+cyclohexa-1,5-dienecarbonyl-CoA hydratase [EC:4.2.1.100] [RN:R05597] K07537 M00541 Benzoyl-CoA degradation, benzoyl-CoA => 3-hydroxypimeloyl-CoA 1,0 C06749 6-Hydroxycyclohex-1-enecarbonyl-CoA C06322 S-1,5-Cyclohexadiene-1-carboxylate coenzymeA
+6-hydroxycyclohex-1-ene-1-carboxyl-CoA dehydrogenase [EC:1.1.1.368] [RN:R05581] K07538 M00541 Benzoyl-CoA degradation, benzoyl-CoA => 3-hydroxypimeloyl-CoA 2,0 C09821 6-Ketoxycyclohex-1-ene-1-carboxyl-CoA C06749 6-Hydroxycyclohex-1-enecarbonyl-CoA
+6-oxo-cyclohex-1-ene-carbonyl-CoA hydrolase [EC:3.7.1.21] [RN:R05594] K07539 M00541 Benzoyl-CoA degradation, benzoyl-CoA => 3-hydroxypimeloyl-CoA 3,0 C06714 3-Hydroxypimeloyl-CoA C09821 6-Ketoxycyclohex-1-ene-1-carboxyl-CoA
+yscF; type III secretion protein SctF K03221 M00542 EHEC/EPEC pathogenicity signature, T3SS and effectors 0,0
+yscC; type III secretion protein SctC K03219 M00542 EHEC/EPEC pathogenicity signature, T3SS and effectors 0,0
+yscJ; type III secretion protein SctJ K03222 M00542 EHEC/EPEC pathogenicity signature, T3SS and effectors 0,0
+yscR; type III secretion protein SctR K03226 M00542 EHEC/EPEC pathogenicity signature, T3SS and effectors 0,0
+yscS; type III secretion protein SctS K03227 M00542 EHEC/EPEC pathogenicity signature, T3SS and effectors 0,0
+yscT; type III secretion protein SctT K03228 M00542 EHEC/EPEC pathogenicity signature, T3SS and effectors 0,0
+yscU; type III secretion protein SctU K03229 M00542 EHEC/EPEC pathogenicity signature, T3SS and effectors 0,0
+yscV; type III secretion protein SctV K03230 M00542 EHEC/EPEC pathogenicity signature, T3SS and effectors 0,0
+yscN; ATP synthase in type III secretion protein SctN [EC:3.6.3.14] K03224 M00542 EHEC/EPEC pathogenicity signature, T3SS and effectors 0,0
+yscQ; type III secretion protein SctQ K03225 M00542 EHEC/EPEC pathogenicity signature, T3SS and effectors 0,0
+tir; translocated intimin receptor K12784 M00542 EHEC/EPEC pathogenicity signature, T3SS and effectors 1,0
+map; LEE-encoded effector Map K12787 M00542 EHEC/EPEC pathogenicity signature, T3SS and effectors 2,0
+espG; LEE-encoded effector EspG K12785 M00542 EHEC/EPEC pathogenicity signature, T3SS and effectors 3,0
+espF; LEE-encoded effector EspF K12786 M00542 EHEC/EPEC pathogenicity signature, T3SS and effectors 4,0
+espH; LEE-encoded effector EspH K12788 M00542 EHEC/EPEC pathogenicity signature, T3SS and effectors 5,0
+nleA; non-LEE-encoded effector NleA K16041 M00542 EHEC/EPEC pathogenicity signature, T3SS and effectors 6,0
+nleH; non-LEE-encoded effector NleH K16042 M00542 EHEC/EPEC pathogenicity signature, T3SS and effectors 7,0
+biphenyl 2,3-dioxygenase [EC:1.14.12.18] [RN:R05263 R05264 R05261 R05262] K08689 M00543 Biphenyl degradation, biphenyl => 2-oxopent-4-enoate + benzoate 0,0 C06585 cis-2,3-Dihydro-2,3-dihydroxy-4'-chlorobiphenyl C06584 4-Chlorobiphenyl
+biphenyl 2,3-dioxygenase [EC:1.14.12.18] [RN:R05263 R05264 R05261 R05262] K15750 M00543 Biphenyl degradation, biphenyl => 2-oxopent-4-enoate + benzoate 0,0 C06585 cis-2,3-Dihydro-2,3-dihydroxy-4'-chlorobiphenyl C06584 4-Chlorobiphenyl
+biphenyl 2,3-dioxygenase [EC:1.14.12.18] [RN:R05263 R05264 R05261 R05262] K18087 M00543 Biphenyl degradation, biphenyl => 2-oxopent-4-enoate + benzoate 0,0 C06585 cis-2,3-Dihydro-2,3-dihydroxy-4'-chlorobiphenyl C06584 4-Chlorobiphenyl
+biphenyl 2,3-dioxygenase [EC:1.14.12.18] [RN:R05263 R05264 R05261 R05262] K18088 M00543 Biphenyl degradation, biphenyl => 2-oxopent-4-enoate + benzoate 0,0 C06585 cis-2,3-Dihydro-2,3-dihydroxy-4'-chlorobiphenyl C06584 4-Chlorobiphenyl
+cis-2,3-dihydrobiphenyl-2,3-diol dehydrogenase [EC:1.3.1.56] [RN:R05239 R05241] K08690 M00543 Biphenyl degradation, biphenyl => 2-oxopent-4-enoate + benzoate 1,0 C06586 2,3-Dihydroxy-4'-chlorobiphenyl C06585 cis-2,3-Dihydro-2,3-dihydroxy-4'-chlorobiphenyl
+biphenyl-2,3-diol 1,2-dioxygenase [EC:1.13.11.39] [RN:R03462 R05245] K00462 M00543 Biphenyl degradation, biphenyl => 2-oxopent-4-enoate + benzoate 2,0 C06587 2-Hydroxy-6-oxo-6-(4'-chlorophenyl)-hexa-2,4-dienoate C06586 2,3-Dihydroxy-4'-chlorobiphenyl
+2,6-dioxo-6-phenylhexa-3-enoate hydrolase [EC:3.7.1.8] [RN:R02606 R05359] K10222 M00543 Biphenyl degradation, biphenyl => 2-oxopent-4-enoate + benzoate 3,0 C00596,C02370 2-Hydroxy-2,4-pentadienoate,4-Chlorobenzoate C06587 2-Hydroxy-6-oxo-6-(4'-chlorophenyl)-hexa-2,4-dienoate
+carbazole 1,9a-dioxygenase [EC:1.14.12.22] [RN:R05414 R09512] K15751 M00544 Carbazole degradation, carbazole => 2-oxopent-4-enoate + anthranilate 0,0 C08061 2'-Aminobiphenyl-2,3-diol C08060 Carbazole
+carbazole 1,9a-dioxygenase [EC:1.14.12.22] [RN:R05414 R09512] K15752 M00544 Carbazole degradation, carbazole => 2-oxopent-4-enoate + anthranilate 0,0 C08061 2'-Aminobiphenyl-2,3-diol C08060 Carbazole
+carbazole 1,9a-dioxygenase [EC:1.14.12.22] [RN:R05414 R09512] K15753 M00544 Carbazole degradation, carbazole => 2-oxopent-4-enoate + anthranilate 0,0 C08061 2'-Aminobiphenyl-2,3-diol C08060 Carbazole
+2'-aminobiphenyl-2,3-diol 1,2-dioxygenase [EC:1.13.11.-] [RN:R05415] K15754 M00544 Carbazole degradation, carbazole => 2-oxopent-4-enoate + anthranilate 1,0 C08062 2-Hydroxy-6-oxo-(2'-aminophenyl)-hexa-2,4-dienoate C08061 2'-Aminobiphenyl-2,3-diol
+2'-aminobiphenyl-2,3-diol 1,2-dioxygenase [EC:1.13.11.-] [RN:R05415] K15755 M00544 Carbazole degradation, carbazole => 2-oxopent-4-enoate + anthranilate 1,0 C08062 2-Hydroxy-6-oxo-(2'-aminophenyl)-hexa-2,4-dienoate C08061 2'-Aminobiphenyl-2,3-diol
+2-hydroxy-6-oxo-6-(2'-aminophenyl)hexa-2, 4-dienoate hydrolase [EC:3.7.1.13] [RN:R05365] K15756 M00544 Carbazole degradation, carbazole => 2-oxopent-4-enoate + anthranilate 2,0 C00596,C00108 2-Hydroxy-2,4-pentadienoate,Anthranilate C08062 2-Hydroxy-6-oxo-(2'-aminophenyl)-hexa-2,4-dienoate
+3-phenylpropionate/cinnamic acid dioxygenase [EC:1.14.12.19] [RN:R06783] K05708 M00545 Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA 0,0,0,0 C12622 cis-3-(3-Carboxyethenyl)-3,5-cyclohexadiene-1,2-diol C00423 trans-Cinnamate
+3-phenylpropionate/cinnamic acid dioxygenase [EC:1.14.12.19] [RN:R06783] K05709 M00545 Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA 0,0,0,0 C12622 cis-3-(3-Carboxyethenyl)-3,5-cyclohexadiene-1,2-diol C00423 trans-Cinnamate
+3-phenylpropionate/cinnamic acid dioxygenase [EC:1.14.12.19] [RN:R06783] K05710 M00545 Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA 0,0,0,0 C12622 cis-3-(3-Carboxyethenyl)-3,5-cyclohexadiene-1,2-diol C00423 trans-Cinnamate
+3-phenylpropionate/cinnamic acid dioxygenase [EC:1.14.12.19] [RN:R06783] K00529 M00545 Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA 0,0,0,0 C12622 cis-3-(3-Carboxyethenyl)-3,5-cyclohexadiene-1,2-diol C00423 trans-Cinnamate
+2,3-dihydroxy-2,3-dihydrophenylpropionate dehydrogenase [EC:1.3.1.87] [RN:R06785] K05711 M00545 Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA 0,0,1,0 C12623 trans-2,3-Dihydroxycinnamate C12622 cis-3-(3-Carboxyethenyl)-3,5-cyclohexadiene-1,2-diol
+mhpA; 3-(3-hydroxy-phenyl)propionate hydroxylase [EC:1.14.13.127] [RN:R06787] K05712 M00545 Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA 0,1 C12623 trans-2,3-Dihydroxycinnamate C12621 trans-3-Hydroxycinnamate
+2,3-dihydroxyphenylpropionate 1,2-dioxygenase [EC:1.13.11.16] [RN:R06788] K05713 M00545 Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA 1,0 C12624 2-Hydroxy-6-ketononatrienedioate C12623 trans-2,3-Dihydroxycinnamate
+2-hydroxy-6-ketonona-2,4-dienedioic acid hydrolase [EC:3.7.1.14] [RN:R06789] K05714 M00545 Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA 2,0 C00596 2-Hydroxy-2,4-pentadienoate C12624 2-Hydroxy-6-ketononatrienedioate
+2-keto-4-pentenoate hydratase [EC:4.2.1.80] [RN:R02601] K02554 M00545 Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA 3,0 C03589 4-Hydroxy-2-oxopentanoate C00596 2-Hydroxy-2,4-pentadienoate
+4-hydroxy 2-oxovalerate aldolase [EC:4.1.3.39] [RN:R00750] K01666 M00545 Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA 4,0 C00084 Acetaldehyde C03589 4-Hydroxy-2-oxopentanoate
+acetaldehyde dehydrogenase [EC:1.2.1.10] [RN:R00228] K04073 M00545 Trans-cinnamate degradation, trans-cinnamate => acetyl-CoA 5,0 C00024 Acetyl-CoA C00084 Acetaldehyde
+xanthine dehydrogenase [EC:1.17.1.4 1.17.3.2] [RN:R02103 R02107] K00106 M00546 Purine degradation, xanthine => urea 0,0 C00366 Urate C00385 Xanthine
+xanthine dehydrogenase [EC:1.17.1.4 1.17.3.2] [RN:R02103 R02107] K00087 M00546 Purine degradation, xanthine => urea 0,1 C00366 Urate C00385 Xanthine
+xanthine dehydrogenase [EC:1.17.1.4 1.17.3.2] [RN:R02103 R02107] K13479 M00546 Purine degradation, xanthine => urea 0,1 C00366 Urate C00385 Xanthine
+xanthine dehydrogenase [EC:1.17.1.4 1.17.3.2] [RN:R02103 R02107] K13480 M00546 Purine degradation, xanthine => urea 0,1 C00366 Urate C00385 Xanthine
+xanthine dehydrogenase [EC:1.17.1.4 1.17.3.2] [RN:R02103 R02107] K13481 M00546 Purine degradation, xanthine => urea 0,2 C00366 Urate C00385 Xanthine
+xanthine dehydrogenase [EC:1.17.1.4 1.17.3.2] [RN:R02103 R02107] K13482 M00546 Purine degradation, xanthine => urea 0,2 C00366 Urate C00385 Xanthine
+xanthine dehydrogenase [EC:1.17.1.4 1.17.3.2] [RN:R02103 R02107] K11177 M00546 Purine degradation, xanthine => urea 0,3 C00366 Urate C00385 Xanthine
+xanthine dehydrogenase [EC:1.17.1.4 1.17.3.2] [RN:R02103 R02107] K11178 M00546 Purine degradation, xanthine => urea 0,3 C00366 Urate C00385 Xanthine
+xanthine dehydrogenase [EC:1.17.1.4 1.17.3.2] [RN:R02103 R02107] K13483 M00546 Purine degradation, xanthine => urea 0,3 C00366 Urate C00385 Xanthine
+urate oxidase [EC:1.7.3.3] [RN:R02106] K00365 M00546 Purine degradation, xanthine => urea 1,0 C11821 5-Hydroxyisourate C00366 Urate
+urate oxidase [EC:1.7.3.3] [RN:R02106] K16838 M00546 Purine degradation, xanthine => urea 1,1 C11821 5-Hydroxyisourate C00366 Urate
+FAD-dependent urate hydroxylase [EC:1.14.13.113] [RN:R09514] K16839 M00546 Purine degradation, xanthine => urea 1,2 C11821 5-Hydroxyisourate C00366 Urate
+FAD-dependent urate hydroxylase [EC:1.14.13.113] [RN:R09514] K22879 M00546 Purine degradation, xanthine => urea 1,3 C11821 5-Hydroxyisourate C00366 Urate
+5-hydroxyisourate hydrolase / 2-oxo-4-hydroxy-4-carboxy-5-ureidoimidazoline decarboxylase [EC:3.5.2.17 4.1.1.97] [RN:R06601+R06604] K13484 M00546 Purine degradation, xanthine => urea 2,0
+5-hydroxyisourate hydrolase [EC:3.5.2.17] [RN:R06601] K07127 M00546 Purine degradation, xanthine => urea 2,1,0,0 C12248 5-Hydroxy-2-oxo-4-ureido-2,5-dihydro-1H-imidazole-5-carboxylate C11821 5-Hydroxyisourate
+2-oxo-4-hydroxy-4-carboxy-5-ureidoimidazoline decarboxylase [EC:4.1.1.97] [RN:R06604] K13485 M00546 Purine degradation, xanthine => urea 2,1,1,0 C02350 (S)(+)-Allantoin C12248 5-Hydroxy-2-oxo-4-ureido-2,5-dihydro-1H-imidazole-5-carboxylate
+urate oxidase [EC:1.7.3.3] [RN:R02106] K16838 M00546 Purine degradation, xanthine => urea 2,1,1,1 C11821 5-Hydroxyisourate C00366 Urate
+2-oxo-4-hydroxy-4-carboxy-5-ureidoimidazoline decarboxylase [EC:4.1.1.97] [RN:R06604] K16840 M00546 Purine degradation, xanthine => urea 2,1,1,2 C02350 (S)(+)-Allantoin C12248 5-Hydroxy-2-oxo-4-ureido-2,5-dihydro-1H-imidazole-5-carboxylate
+allantoinase [EC:3.5.2.5] [RN:R02425] K01466 M00546 Purine degradation, xanthine => urea 3,0 C00499 Allantoate C02350 (S)(+)-Allantoin
+allantoinase [EC:3.5.2.5] [RN:R02425] K16842 M00546 Purine degradation, xanthine => urea 3,1 C00499 Allantoate C02350 (S)(+)-Allantoin
+allantoicase [EC:3.5.3.4] [RN:R02422] K01477 M00546 Purine degradation, xanthine => urea 4,0 C00086 Urea C00499 Allantoate
+benzene/toluene dioxygenase subunit alpha [EC:1.14.12.3 1.14.12.11] [RN:R03543 R03559] K03268 M00547 Benzene/toluene degradation, benzene => catechol / toluene => 3-methylcatechol 0,0 C04592 Toluene-cis-dihydrodiol C01455 Toluene
+benzene/toluene dioxygenase subunit alpha [EC:1.14.12.3 1.14.12.11] [RN:R03543 R03559] K16268 M00547 Benzene/toluene degradation, benzene => catechol / toluene => 3-methylcatechol 0,0 C04592 Toluene-cis-dihydrodiol C01455 Toluene
+benzene/toluene dioxygenase subunit alpha [EC:1.14.12.3 1.14.12.11] [RN:R03543 R03559] K18089 M00547 Benzene/toluene degradation, benzene => catechol / toluene => 3-methylcatechol 0,0 C04592 Toluene-cis-dihydrodiol C01455 Toluene
+benzene/toluene dioxygenase subunit alpha [EC:1.14.12.3 1.14.12.11] [RN:R03543 R03559] K18090 M00547 Benzene/toluene degradation, benzene => catechol / toluene => 3-methylcatechol 0,0 C04592 Toluene-cis-dihydrodiol C01455 Toluene
+cis-1,2-dihydrobenzene-1,2-diol dehydrogenase [EC:1.3.1.19] [RN:R00812 R04088] K16269 M00547 Benzene/toluene degradation, benzene => catechol / toluene => 3-methylcatechol 1,0 C02923 2,3-Dihydroxytoluene C04592 Toluene-cis-dihydrodiol
+dmpK; phenol 2-monooxygenase (NADH) P0/A0 [RN:R10042 R10043] K16249 M00548 Benzene degradation, benzene => catechol 0,0 C00090 Catechol C00146 Phenol
+dmpL; phenol 2-monooxygenase (NADH) P1/A1 [EC:1.14.13.244] [RN:R10042 R10043] K16243 M00548 Benzene degradation, benzene => catechol 0,0 C00090 Catechol C00146 Phenol
+dmpM; phenol 2-monooxygenase (NADH) P2/A2 [EC:1.14.13.244] [RN:R10042 R10043] K16244 M00548 Benzene degradation, benzene => catechol 0,0 C00090 Catechol C00146 Phenol
+dmpN; phenol 2-monooxygenase (NADH) P3/A3 [EC:1.14.13.244] [RN:R10042 R10043] K16242 M00548 Benzene degradation, benzene => catechol 0,0 C00090 Catechol C00146 Phenol
+dmpO; phenol 2-monooxygenase (NADH) P4/A4 [EC:1.14.13.244] [RN:R10042 R10043] K16245 M00548 Benzene degradation, benzene => catechol 0,0 C00090 Catechol C00146 Phenol
+dmpP; phenol 2-monooxygenase (NADH) P5/A5 [EC:1.14.13.244] [RN:R10042 R10043] K16246 M00548 Benzene degradation, benzene => catechol 0,0 C00090 Catechol C00146 Phenol
+hexokinase [EC:2.7.1.1] [RN:R01786] K00844 M00549 Nucleotide sugar biosynthesis, glucose => UDP-glucose 0,0 C00668 alpha-D-Glucose 6-phosphate C00267 alpha-D-Glucose
+glucokinase [EC:2.7.1.2] [RN:R01786] K00845 M00549 Nucleotide sugar biosynthesis, glucose => UDP-glucose 0,1 C00668 alpha-D-Glucose 6-phosphate C00267 alpha-D-Glucose
+glucokinase [EC:2.7.1.2] [RN:R01786] K12407 M00549 Nucleotide sugar biosynthesis, glucose => UDP-glucose 0,2 C00668 alpha-D-Glucose 6-phosphate C00267 alpha-D-Glucose
+polyphosphate glucokinase [EC:2.7.1.63] [RN:R02189] K00886 M00549 Nucleotide sugar biosynthesis, glucose => UDP-glucose 0,3 C00668 alpha-D-Glucose 6-phosphate C00267 alpha-D-Glucose
+phosphoglucomutase [EC:5.4.2.2] [RN:R00959] K01835 M00549 Nucleotide sugar biosynthesis, glucose => UDP-glucose 1,0 C00103 D-Glucose 1-phosphate C00668 alpha-D-Glucose 6-phosphate
+UTP--glucose-1-phosphate uridylyltransferase [EC:2.7.7.9] [RN:R00289] K00963 M00549 Nucleotide sugar biosynthesis, glucose => UDP-glucose 2,0 C00029 UDP-glucose C00103 D-Glucose 1-phosphate
+PTS system, ascorbate-specific [EC:2.7.1.194] [RN:R07671] K02821 M00550 Ascorbate degradation, ascorbate => D-xylulose-5P 0,0 C16186 L-Ascorbate 6-phosphate C00072 Ascorbate
+PTS system, ascorbate-specific [EC:2.7.1.194] [RN:R07671] K02822 M00550 Ascorbate degradation, ascorbate => D-xylulose-5P 0,0 C16186 L-Ascorbate 6-phosphate C00072 Ascorbate
+PTS system, ascorbate-specific [EC:2.7.1.194] [RN:R07671] K03475 M00550 Ascorbate degradation, ascorbate => D-xylulose-5P 0,0 C16186 L-Ascorbate 6-phosphate C00072 Ascorbate
+L-ascorbate 6-phosphate lactonase [EC:3.1.1.-] [RN:R07677] K03476 M00550 Ascorbate degradation, ascorbate => D-xylulose-5P 1,0 C14899 3-Dehydro-L-gulonate 6-phosphate C16186 L-Ascorbate 6-phosphate
+3-dehydro-L-gulonate-6-phosphate decarboxylase [EC:4.1.1.85] [RN:R07125] K03078 M00550 Ascorbate degradation, ascorbate => D-xylulose-5P 2,0 C03291 L-Xylulose 5-phosphate C14899 3-Dehydro-L-gulonate 6-phosphate
+L-ribulose-5-phosphate 3-epimerase [EC:5.1.3.22] [RN:R03244] K03079 M00550 Ascorbate degradation, ascorbate => D-xylulose-5P 3,0 C01101 L-Ribulose 5-phosphate C03291 L-Xylulose 5-phosphate
+L-ribulose-5-phosphate 4-epimerase [EC:5.1.3.4] [RN:R05850] K03077 M00550 Ascorbate degradation, ascorbate => D-xylulose-5P 4,0 C00231 D-Xylulose 5-phosphate C01101 L-Ribulose 5-phosphate
+benzoate/toluate 1,2-dioxygenase [EC:1.14.12.10 1.14.12.-] [RN:R05621 R05290 R05428 R05665] K05549 M00551 Benzoate degradation, benzoate => catechol / methylbenzoate => methylcatechol 0,0 C06720 1,6-Dihydroxy-5-methylcyclohexa-2,4-dienecarboxylate C07211 m-Methylbenzoate
+benzoate/toluate 1,2-dioxygenase [EC:1.14.12.10 1.14.12.-] [RN:R05621 R05290 R05428 R05665] K05550 M00551 Benzoate degradation, benzoate => catechol / methylbenzoate => methylcatechol 0,0 C06720 1,6-Dihydroxy-5-methylcyclohexa-2,4-dienecarboxylate C07211 m-Methylbenzoate
+benzoate/toluate 1,2-dioxygenase [EC:1.14.12.10 1.14.12.-] [RN:R05621 R05290 R05428 R05665] K05784 M00551 Benzoate degradation, benzoate => catechol / methylbenzoate => methylcatechol 0,0 C06720 1,6-Dihydroxy-5-methylcyclohexa-2,4-dienecarboxylate C07211 m-Methylbenzoate
+1,6-dihydroxycyclohexa-2,4-diene-1-carboxylate dehydrogenase [EC:1.3.1.25] [RN:R00813 R05292 R05314 R05309] K05783 M00551 Benzoate degradation, benzoate => catechol / methylbenzoate => methylcatechol 1,0 C02923 2,3-Dihydroxytoluene C06720 1,6-Dihydroxy-5-methylcyclohexa-2,4-dienecarboxylate
+galactonate dehydratase [EC:4.2.1.6] [RN:R03033] K01684 M00552 D-galactonate degradation, De Ley-Doudoroff pathway, D-galactonate => glycerate-3P 0,0 C01216 2-Dehydro-3-deoxy-D-galactonate C00880 D-Galactonate
+2-dehydro-3-deoxygalactonokinase [EC:2.7.1.58] [RN:R03387] K00883 M00552 D-galactonate degradation, De Ley-Doudoroff pathway, D-galactonate => glycerate-3P 1,0 C01286 2-Dehydro-3-deoxy-6-phospho-D-galactonate C01216 2-Dehydro-3-deoxy-D-galactonate
+2-dehydro-3-deoxyphosphogalactonate aldolase [EC:4.1.2.21] [RN:R01064] K01631 M00552 D-galactonate degradation, De Ley-Doudoroff pathway, D-galactonate => glycerate-3P 2,0 C00118 D-Glyceraldehyde 3-phosphate C01286 2-Dehydro-3-deoxy-6-phospho-D-galactonate
+glyceraldehyde 3-phosphate dehydrogenase [EC:1.2.1.12] [RN:R01061] K00134 M00552 D-galactonate degradation, De Ley-Doudoroff pathway, D-galactonate => glycerate-3P 3,0 C00236 3-Phospho-D-glyceroyl phosphate C00118 D-Glyceraldehyde 3-phosphate
+phosphoglycerate kinase [EC:2.7.2.3] [RN:R01512] K00927 M00552 D-galactonate degradation, De Ley-Doudoroff pathway, D-galactonate => glycerate-3P 4,0 C00197 3-Phospho-D-glycerate C00236 3-Phospho-D-glyceroyl phosphate
+galactokinase [EC:2.7.1.6] [RN:R01092] K00849 M00554 Nucleotide sugar biosynthesis, galactose => UDP-galactose 0,0 C00446 alpha-D-Galactose 1-phosphate C00124 D-Galactose
+UDPglucose--hexose-1-phosphate uridylyltransferase [EC:2.7.7.12] [RN:R00955] K00965 M00554 Nucleotide sugar biosynthesis, galactose => UDP-galactose 1,0 C00052 UDP-D-galactose C00446 alpha-D-Galactose 1-phosphate
+choline oxidase [EC:1.1.3.17] [R01022 R08211] K17755 M00555 Betaine biosynthesis, choline => betaine 0,0 C00719 Betaine C00576 Betaine aldehyde
+choline dehydrogenase [EC:1.1.99.1] [RN:R01025 R08557 R08558] K00108 M00555 Betaine biosynthesis, choline => betaine 0,1,0,0 C00576 Betaine aldehyde C00114 Choline
+choline dehydrogenase [EC:1.1.99.1] [RN:R01025 R08557 R08558] K11440 M00555 Betaine biosynthesis, choline => betaine 0,1,0,1 C00576 Betaine aldehyde C00114 Choline
+betaine-aldehyde dehydrogenase [EC:1.2.1.8] [R02565 R02566] K00130 M00555 Betaine biosynthesis, choline => betaine 0,1,1,0 C00719 Betaine C00576 Betaine aldehyde
+mtbA; [methyl-Co(III) methylamine-specific corrinoid protein]:coenzyme M methyltransferase [EC:2.1.1.247] [RN:R09998] K14082 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 0,0 C03920 2-(Methylthio)ethanesulfonate C00218 Methylamine
+mtmC; monomethylamine corrinoid protein [RN:R09998] K16177 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 1,0 C03920 2-(Methylthio)ethanesulfonate C00218 Methylamine
+mtmB; methylamine---corrinoid protein Co-methyltransferase [EC:2.1.1.248] [RN:R09998] K16176 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 1,0 C03920 2-(Methylthio)ethanesulfonate C00218 Methylamine
+mtbC; dimethylamine corrinoid protein [RN:R09999] K16179 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 1,1 C03920 2-(Methylthio)ethanesulfonate C00543 Dimethylamine
+mtbB; dimethylamine---corrinoid protein Co-methyltransferase [EC:2.1.1.249] [RN:R09999] K16178 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 1,1 C03920 2-(Methylthio)ethanesulfonate C00543 Dimethylamine
+mttC; trimethylamine corrinoid protein [RN:R09124] K14084 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 1,2 C03920 2-(Methylthio)ethanesulfonate C00565 Trimethylamine
+mttB; trimethylamine---corrinoid protein Co-methyltransferase [EC:2.1.1.250] [RN:R09124] K14083 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 1,2 C03920 2-(Methylthio)ethanesulfonate C00565 Trimethylamine
+methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] K00399 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 2,0 C01438,C04832 Methane,Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide C03920,C04628 2-(Methylthio)ethanesulfonate,Coenzyme B
+methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] K00401 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 2,0 C01438,C04832 Methane,Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide C03920,C04628 2-(Methylthio)ethanesulfonate,Coenzyme B
+methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] K00402 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 2,0 C01438,C04832 Methane,Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide C03920,C04628 2-(Methylthio)ethanesulfonate,Coenzyme B
+heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] K22480 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 3,0 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] K22481 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 3,0 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] K22482 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 3,0 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03388 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 3,1 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03389 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 3,1 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03390 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 3,1 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase [EC:1.8.98.1] [RN:R04540] K08264 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 3,2 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase [EC:1.8.98.1] [RN:R04540] K08265 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 3,2 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03388 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 3,3 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03389 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 3,3 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03390 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 3,3 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+F420-non-reducing hydrogenase iron-sulfur subunit [EC:1.8.98.5 1.8.98.6] [RN:R11943 R11944] K14127 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 3,3 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+F420-non-reducing hydrogenase [EC:1.8.98.5] [RN:R11943] K14126 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 3,3 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+F420-non-reducing hydrogenase [EC:1.8.98.5] [RN:R11943] K14128 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 3,3 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+formate dehydrogenase (coenzyme F420) [EC:1.8.98.6] [RN:R11944] K22516 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 3,3 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+formate dehydrogenase (coenzyme F420) [EC:1.8.98.6] [RN:R11944] K00125 M00563 Methanogenesis, methylamine/dimethylamine/trimethylamine => methane 3,3 C04628 Coenzyme B C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+cagA; cytotoxicity-associated immunodominant antigen K15842 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 0,0
+cag1; cag pathogenicity island protein 1 K12086 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 1,0
+cag2; cag pathogenicity island protein 2 K12087 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 2,0
+cag3; cag pathogenicity island protein 3 K12088 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 3,0
+cag4; cag pathogenicity island protein 4 K12089 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 4,0
+cag5; cag pathogenicity island protein 5 K12090 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 5,0
+virB11; type IV secretion system protein VirB11 K03196 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 6,0
+cag6; cag pathogenicity island protein 6 K12091 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 7,0
+cag7; cag pathogenicity island protein 7 K12092 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 8,0
+cag8; cag pathogenicity island protein 8 K12093 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 9,0
+cag9; cag pathogenicity island protein 9 K12094 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 10,0
+cag10; cag pathogenicity island protein 10 K12095 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 11,0
+cag11; cag pathogenicity island protein 11 K12096 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 12,0
+cag12; cag pathogenicity island protein 12 K12097 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 13,0
+cag13; cag pathogenicity island protein 13 K12098 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 14,0
+cag14; cag pathogenicity island protein 14 K12099 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 15,0
+cag15; cag pathogenicity island protein 15 K12100 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 16,0
+cag16; cag pathogenicity island protein 16 K12101 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 17,0
+cag17; cag pathogenicity island protein 17 K12102 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 18,0
+cag18; cag pathogenicity island protein 18 K12103 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 19,0
+cag19; cag pathogenicity island protein 19 K12104 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 20,0
+cag20; cag pathogenicity island protein 20 K12105 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 21,0
+cag21; cag pathogenicity island protein 21 K12106 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 22,0
+cag22; cag pathogenicity island protein 22 K12107 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 23,0
+cag23; cag pathogenicity island protein 23 K12108 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 24,0
+cag24; cag pathogenicity island protein 24 K12109 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 25,0
+cag25; cag pathogenicity island protein 25 K12110 M00564 Helicobacter pylori pathogenicity signature, cagA pathogenicity island 26,0
+glgC; glucose-1-phosphate adenylyltransferase [EC:2.7.7.27] [RN:R00948] K00975 M00565 Trehalose biosynthesis, D-glucose 1P => trehalose 0,0 C00498 ADP-glucose C00103 D-Glucose 1-phosphate
+starch synthase [EC:2.4.1.21] [RN:R02421] K00703 M00565 Trehalose biosynthesis, D-glucose 1P => trehalose 1,0 C00718 Amylose C00498 ADP-glucose
+1,4-alpha-glucan branching enzyme [EC:2.4.1.18] [RN:R02110] K00700 M00565 Trehalose biosynthesis, D-glucose 1P => trehalose 2,0 C00369 Starch C00718 Amylose
+1,4-alpha-glucan branching enzyme [EC:2.4.1.18] [RN:R02110] K16149 M00565 Trehalose biosynthesis, D-glucose 1P => trehalose 2,1 C00369 Starch C00718 Amylose
+ISA; isoamylase [EC:3.2.1.68] [RN:R11261] K01214 M00565 Trehalose biosynthesis, D-glucose 1P => trehalose 3,0 C01935 Maltodextrin C00369 Starch
+treY; (1->4)-alpha-D-glucan 1-alpha-D-glucosylmutase [EC:5.4.99.15] [RN:R01824] K06044 M00565 Trehalose biosynthesis, D-glucose 1P => trehalose 4,0 C06400 Maltooligosyltrehalose C01935 Maltodextrin
+treZ; maltooligosyltrehalose trehalohydrolase [EC:3.2.1.141] [RN:R11256] K01236 M00565 Trehalose biosynthesis, D-glucose 1P => trehalose 5,0 C01083 Trehalose C06400 Maltooligosyltrehalose
+formylmethanofuran dehydrogenase [EC:1.2.99.5] [RN:R03015] K00200 M00567 Methanogenesis, CO2 => methane 0,0 C01001 Formylmethanofuran C00011 CO2
+formylmethanofuran dehydrogenase [EC:1.2.99.5] [RN:R03015] K00201 M00567 Methanogenesis, CO2 => methane 0,0 C01001 Formylmethanofuran C00011 CO2
+formylmethanofuran dehydrogenase [EC:1.2.99.5] [RN:R03015] K00202 M00567 Methanogenesis, CO2 => methane 0,0 C01001 Formylmethanofuran C00011 CO2
+formylmethanofuran dehydrogenase [EC:1.2.99.5] [RN:R03015] K00203 M00567 Methanogenesis, CO2 => methane 0,0 C01001 Formylmethanofuran C00011 CO2
+formylmethanofuran dehydrogenase [EC:1.2.99.5] [RN:R03015] K11261 M00567 Methanogenesis, CO2 => methane 0,0 C01001 Formylmethanofuran C00011 CO2
+4Fe-4S ferredoxin K00205 M00567 Methanogenesis, CO2 => methane 0,0 C01001 Formylmethanofuran C00011 CO2
+4Fe-4S ferredoxin K11260 M00567 Methanogenesis, CO2 => methane 0,0 C01001 Formylmethanofuran C00011 CO2
+4Fe-4S ferredoxin K00204 M00567 Methanogenesis, CO2 => methane 0,0 C01001 Formylmethanofuran C00011 CO2
+formylmethanofuran--tetrahydromethanopterin N-formyltransferase [EC:2.3.1.101] [RN:R03390] K00672 M00567 Methanogenesis, CO2 => methane 1,0 C01274 5-Formyl-5,6,7,8-tetrahydromethanopterin C01001 Formylmethanofuran
+methenyltetrahydromethanopterin cyclohydrolase [EC:3.5.4.27] [RN:R03464] K01499 M00567 Methanogenesis, CO2 => methane 2,0 C04330 5,10-Methenyltetrahydromethanopterin C01274 5-Formyl-5,6,7,8-tetrahydromethanopterin
+methylenetetrahydromethanopterin dehydrogenase [EC:1.5.99.9] [RN:R04456] K00319 M00567 Methanogenesis, CO2 => methane 3,0 C04377 5,10-Methylenetetrahydromethanopterin C04330 5,10-Methenyltetrahydromethanopterin
+5,10-methenyltetrahydromethanopterin hydrogenase [EC:1.12.98.2] [RN:R04455] K13942 M00567 Methanogenesis, CO2 => methane 3,1 C04377 5,10-Methylenetetrahydromethanopterin C04330 5,10-Methenyltetrahydromethanopterin
+coenzyme F420-dependent N5,N10-methenyltetrahydromethanopterin reductase [EC:1.5.99.11] [RN:R04464] K00320 M00567 Methanogenesis, CO2 => methane 4,0 C04488 5-Methyl-5,6,7,8-tetrahydromethanopterin C04377 5,10-Methylenetetrahydromethanopterin
+tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] K00577 M00567 Methanogenesis, CO2 => methane 5,0 C03920 2-(Methylthio)ethanesulfonate C04488,C03576 5-Methyl-5,6,7,8-tetrahydromethanopterin,Coenzyme M
+tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] K00578 M00567 Methanogenesis, CO2 => methane 5,0 C03920 2-(Methylthio)ethanesulfonate C04488,C03576 5-Methyl-5,6,7,8-tetrahydromethanopterin,Coenzyme M
+tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] K00579 M00567 Methanogenesis, CO2 => methane 5,0 C03920 2-(Methylthio)ethanesulfonate C04488,C03576 5-Methyl-5,6,7,8-tetrahydromethanopterin,Coenzyme M
+tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] K00580 M00567 Methanogenesis, CO2 => methane 5,0 C03920 2-(Methylthio)ethanesulfonate C04488,C03576 5-Methyl-5,6,7,8-tetrahydromethanopterin,Coenzyme M
+tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] K00581 M00567 Methanogenesis, CO2 => methane 5,0 C03920 2-(Methylthio)ethanesulfonate C04488,C03576 5-Methyl-5,6,7,8-tetrahydromethanopterin,Coenzyme M
+tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] K00582 M00567 Methanogenesis, CO2 => methane 5,0 C03920 2-(Methylthio)ethanesulfonate C04488,C03576 5-Methyl-5,6,7,8-tetrahydromethanopterin,Coenzyme M
+tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] K00583 M00567 Methanogenesis, CO2 => methane 5,0 C03920 2-(Methylthio)ethanesulfonate C04488,C03576 5-Methyl-5,6,7,8-tetrahydromethanopterin,Coenzyme M
+tetrahydromethanopterin S-methyltransferase [EC:2.1.1.86] [RN:R04347] K00584 M00567 Methanogenesis, CO2 => methane 5,0 C03920 2-(Methylthio)ethanesulfonate C04488,C03576 5-Methyl-5,6,7,8-tetrahydromethanopterin,Coenzyme M
+methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] K00399 M00567 Methanogenesis, CO2 => methane 6,0 C01438,C04832 Methane,Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide C03920,C04628 2-(Methylthio)ethanesulfonate,Coenzyme B
+methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] K00401 M00567 Methanogenesis, CO2 => methane 6,0 C01438,C04832 Methane,Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide C03920,C04628 2-(Methylthio)ethanesulfonate,Coenzyme B
+methyl-coenzyme M reductase [EC:2.8.4.1] [RN:R04541] K00402 M00567 Methanogenesis, CO2 => methane 6,0 C01438,C04832 Methane,Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide C03920,C04628 2-(Methylthio)ethanesulfonate,Coenzyme B
+heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] K22480 M00567 Methanogenesis, CO2 => methane 7,0 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] K22481 M00567 Methanogenesis, CO2 => methane 7,0 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 1 [EC:1.8.7.3] [RN:R11931] K22482 M00567 Methanogenesis, CO2 => methane 7,0 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03388 M00567 Methanogenesis, CO2 => methane 7,1 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03389 M00567 Methanogenesis, CO2 => methane 7,1 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03390 M00567 Methanogenesis, CO2 => methane 7,1 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase [EC:1.8.98.1] [RN:R04540] K08264 M00567 Methanogenesis, CO2 => methane 7,2 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase [EC:1.8.98.1] [RN:R04540] K08265 M00567 Methanogenesis, CO2 => methane 7,2 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03388 M00567 Methanogenesis, CO2 => methane 7,3 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03389 M00567 Methanogenesis, CO2 => methane 7,3 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+heterodisulfide reductase 2 [EC:1.8.7.3 1.8.98.4 1.8.98.5 1.8.98.6] [RN:R11928 R11931 R11943 R11944] K03390 M00567 Methanogenesis, CO2 => methane 7,3 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+F420-non-reducing hydrogenase iron-sulfur subunit [EC:1.8.98.5 1.8.98.6] [RN:R11943 R11944] K14127 M00567 Methanogenesis, CO2 => methane 7,3 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+F420-non-reducing hydrogenase [EC:1.8.98.5] [RN:R11943] K14126 M00567 Methanogenesis, CO2 => methane 7,3 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+F420-non-reducing hydrogenase [EC:1.8.98.5] [RN:R11943] K14128 M00567 Methanogenesis, CO2 => methane 7,3 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+formate dehydrogenase (coenzyme F420) [EC1.8.98.6] [RN:R11944] K22516 M00567 Methanogenesis, CO2 => methane 7,3 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+formate dehydrogenase (coenzyme F420) [EC1.8.98.6] [RN:R11944] K00125 M00567 Methanogenesis, CO2 => methane 7,3 C04628,C03576 Coenzyme B,Coenzyme M C04832 Coenzyme M 7-mercaptoheptanoylthreonine-phosphate heterodisulfide
+catechol 1,2-dioxygenase [EC:1.13.11.1] [RN:R00817] K03381 M00568 Catechol ortho-cleavage, catechol => 3-oxoadipate 0,0 C02480 cis,cis-Muconate C00090 Catechol
+muconate cycloisomerase [EC:5.5.1.1] [RN:R06989] K01856 M00568 Catechol ortho-cleavage, catechol => 3-oxoadipate 1,0 C14610 (S)-5-Oxo-2,5-dihydrofuran-2-acetate C02480 cis,cis-Muconate
+muconolactone D-isomerase [EC:5.3.3.4] [RN:R06990] K03464 M00568 Catechol ortho-cleavage, catechol => 3-oxoadipate 2,0 C03586 2-Oxo-2,3-dihydrofuran-5-acetate C14610 (S)-5-Oxo-2,5-dihydrofuran-2-acetate
+3-oxoadipate enol-lactonase [EC:3.1.1.24] [RN:R02991] K01055 M00568 Catechol ortho-cleavage, catechol => 3-oxoadipate 3,0 C00846 3-Oxoadipate C03586 2-Oxo-2,3-dihydrofuran-5-acetate
+oxoadipate enol-lactonase / 4-carboxymuconolactone decarboxylase [EC:3.1.1.24 4.1.1.44] K14727 M00568 Catechol ortho-cleavage, catechol => 3-oxoadipate 3,1 C00846 3-Oxoadipate C03586 2-Oxo-2,3-dihydrofuran-5-acetate
+catechol 2,3-dioxygenase [EC:1.13.11.2] [RN:R00816 R05295] K00446 M00569 Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA 0,0 C06760 2-Hydroxy-5-methyl-cis,cis-muconic semialdehyde C06730 4-Methylcatechol
+catechol 2,3-dioxygenase [EC:1.13.11.2] [RN:R00816 R05295] K07104 M00569 Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA 0,1 C06760 2-Hydroxy-5-methyl-cis,cis-muconic semialdehyde C06730 4-Methylcatechol
+2-hydroxymuconate-6-semialdehyde dehydrogenase [EC:1.2.1.85] [RN:R02762 R05353] K10217 M00569 Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA 1,0,0,0 C07478 2-Hydroxy-5-methyl-cis,cis-muconate C06760 2-Hydroxy-5-methyl-cis,cis-muconic semialdehyde
+4-oxalocrotonate tautomerase [EC:5.3.2.6] [RN:R03966 R05389] K01821 M00569 Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA 1,0,1,0 C07479 2-Oxo-5-methyl-cis-muconate C07478 2-Hydroxy-5-methyl-cis,cis-muconate
+4-oxalocrotonate decarboxylase [EC:4.1.1.77] [RN:R02602 R05374] K01617 M00569 Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA 1,0,2,0 C11354 2-Hydroxy-cis-hex-2,4-dienoate C07479 2-Oxo-5-methyl-cis-muconate
+2-hydroxymuconate-semialdehyde hydrolase [EC:3.7.1.9] [RN:R02604 R05865] K10216 M00569 Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA 1,1 C11354 2-Hydroxy-cis-hex-2,4-dienoate C06760 2-Hydroxy-5-methyl-cis,cis-muconic semialdehyde
+2-oxopent-4-enoate/cis-2-oxohex-4-enoate hydratase [EC:4.2.1.80 4.2.1.132] [RN:R02601 R05864] K18364 M00569 Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA 2,0 C06762 4-Hydroxy-2-oxohexanoic acid C11354 2-Hydroxy-cis-hex-2,4-dienoate
+2-keto-4-pentenoate hydratase [EC:4.2.1.80] [RN:R02601] K02554 M00569 Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA 2,1 C03589 4-Hydroxy-2-oxopentanoate C00596 2-Hydroxy-2,4-pentadienoate
+4-hydroxy-2-oxovalerate/4-hydroxy-2-oxohexanoate aldolase [EC:4.1.3.39 4.1.3.43] [RN:R00750 R05298] K18365 M00569 Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA 3,0 C00022,C00479 Pyruvate,Propanal C06762 4-Hydroxy-2-oxohexanoic acid
+4-hydroxy 2-oxovalerate aldolase [EC:4.1.3.39] [RN:R00750] K01666 M00569 Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA 3,1 C00022,C00084 Pyruvate,Acetaldehyde C03589 4-Hydroxy-2-oxopentanoate
+acetaldehyde/propanal dehydrogenase [EC:1.2.1.10 1.2.1.87] [RN:R00228 R09097] K18366 M00569 Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA 4,0 C00100 Propanoyl-CoA C00479 Propanal
+acetaldehyde dehydrogenase [EC:1.2.1.10] [RN:R00228] K04073 M00569 Catechol meta-cleavage, catechol => acetyl-CoA / 4-methylcatechol => propanoyl-CoA 4,1 C00024 Acetyl-CoA C00084 Acetaldehyde
+threonine dehydratase [EC:4.3.1.19] [RN:R00996] K17989 M00570 Isoleucine biosynthesis, threonine => 2-oxobutanoate => isoleucine 0,0 C00109 2-Oxobutanoate C00188 L-Threonine
+threonine dehydratase [EC:4.3.1.19] [RN:R00996] K01754 M00570 Isoleucine biosynthesis, threonine => 2-oxobutanoate => isoleucine 0,1 C00109 2-Oxobutanoate C00188 L-Threonine
+acetolactate synthase [EC:2.2.1.6] [RN:R08648] K01652 M00570 Isoleucine biosynthesis, threonine => 2-oxobutanoate => isoleucine 1,0 C06006 (S)-2-Aceto-2-hydroxybutanoate C00109 2-Oxobutanoate
+acetolactate synthase [EC:2.2.1.6] [RN:R08648] K01653 M00570 Isoleucine biosynthesis, threonine => 2-oxobutanoate => isoleucine 1,0 C06006 (S)-2-Aceto-2-hydroxybutanoate C00109 2-Oxobutanoate
+acetolactate synthase [EC:2.2.1.6] [RN:R08648] K11258 M00570 Isoleucine biosynthesis, threonine => 2-oxobutanoate => isoleucine 1,0 C06006 (S)-2-Aceto-2-hydroxybutanoate C00109 2-Oxobutanoate
+ketol-acid reductoisomerase [EC:1.1.1.86] [RN:R05069 R05068] K00053 M00570 Isoleucine biosynthesis, threonine => 2-oxobutanoate => isoleucine 2,0 C06007 (R)-2,3-Dihydroxy-3-methylpentanoate C14463 (R)-3-Hydroxy-3-methyl-2-oxopentanoate
+dihydroxy-acid dehydratase [EC:4.2.1.9] [RN:R05070] K01687 M00570 Isoleucine biosynthesis, threonine => 2-oxobutanoate => isoleucine 3,0 C00671 (S)-3-Methyl-2-oxopentanoic acid C06007 (R)-2,3-Dihydroxy-3-methylpentanoate
+branched-chain amino acid aminotransferase [EC:2.6.1.42] [RN:R02199] K00826 M00570 Isoleucine biosynthesis, threonine => 2-oxobutanoate => isoleucine 4,0 C00407 L-Isoleucine C00671 (S)-3-Methyl-2-oxopentanoic acid
+malonyl-CoA O-methyltransferase [EC:2.1.1.197] [RN:R09543] K02169 M00572 Pimeloyl-ACP biosynthesis, BioC-BioH pathway, malonyl-ACP => pimeloyl-ACP 0,0 C19673 Malonyl-[acp] methyl ester C01209 Malonyl-[acp]
+3-oxoacyl-[acyl-carrier-protein] synthase [EC:2.3.1.41 2.3.1.179] [RN:R10115 R10119] K00647 M00572 Pimeloyl-ACP biosynthesis, BioC-BioH pathway, malonyl-ACP => pimeloyl-ACP 1,0 C20376 3-Ketopimeloyl-[acp] methyl ester C20375 Glutaryl-[acp] methyl ester
+3-oxoacyl-[acyl-carrier-protein] synthase [EC:2.3.1.41 2.3.1.179] [RN:R10115 R10119] K09458 M00572 Pimeloyl-ACP biosynthesis, BioC-BioH pathway, malonyl-ACP => pimeloyl-ACP 1,1 C20376 3-Ketopimeloyl-[acp] methyl ester C20375 Glutaryl-[acp] methyl ester
+3-oxoacyl-[acyl-carrier protein] reductase [EC:1.1.1.100] [RN:R10116 R10120] K00059 M00572 Pimeloyl-ACP biosynthesis, BioC-BioH pathway, malonyl-ACP => pimeloyl-ACP 2,0 C20377 3-Hydroxypimeloyl-[acp] methyl ester C20376 3-Ketopimeloyl-[acp] methyl ester
+3-hydroxyacyl-[acyl-carrier-protein] dehydratase [EC:4.2.1.59] [RN:R10117 R10121] K02372 M00572 Pimeloyl-ACP biosynthesis, BioC-BioH pathway, malonyl-ACP => pimeloyl-ACP 3,0 C20378 Enoylpimeloyl-[acp] methyl ester C20377 3-Hydroxypimeloyl-[acp] methyl ester
+enoyl-[acyl-carrier protein] reductase [EC:1.3.1.10] [RN:R10118 R10122] K00208 M00572 Pimeloyl-ACP biosynthesis, BioC-BioH pathway, malonyl-ACP => pimeloyl-ACP 4,0 C19846 Pimelyl-[acp] methyl ester C20378 Enoylpimeloyl-[acp] methyl ester
+pimelyl-[acyl-carrier protein] methyl ester esterase [EC:3.1.1.85] [RN:R09725] K02170 M00572 Pimeloyl-ACP biosynthesis, BioC-BioH pathway, malonyl-ACP => pimeloyl-ACP 5,0 C19845 Pimelyl-[acp] C19846 Pimelyl-[acp] methyl ester
+pimelyl-[acyl-carrier protein] methyl ester esterase [EC:3.1.1.85] [RN:R09725] K09789 M00572 Pimeloyl-ACP biosynthesis, BioC-BioH pathway, malonyl-ACP => pimeloyl-ACP 5,1 C19845 Pimelyl-[acp] C19846 Pimelyl-[acp] methyl ester
+pimelyl-[acyl-carrier protein] methyl ester esterase [EC:3.1.1.85] [RN:R09725] K19560 M00572 Pimeloyl-ACP biosynthesis, BioC-BioH pathway, malonyl-ACP => pimeloyl-ACP 5,2 C19845 Pimelyl-[acp] C19846 Pimelyl-[acp] methyl ester
+pimelyl-[acyl-carrier protein] methyl ester esterase [EC:3.1.1.85] [RN:R09725] K19561 M00572 Pimeloyl-ACP biosynthesis, BioC-BioH pathway, malonyl-ACP => pimeloyl-ACP 5,3 C19845 Pimelyl-[acp] C19846 Pimelyl-[acp] methyl ester
+pimeloyl-[acyl-carrier protein] synthase [EC:1.14.14.46] [RN:R10123] K16593 M00573 Biotin biosynthesis, BioI pathway, long-chain-acyl-ACP => pimeloyl-ACP => biotin 0,0 C19845 Pimelyl-[acyl-carrier protein] C00173 Acyl-[acyl-carrier protein]
+8-amino-7-oxononanoate synthase [EC:2.3.1.47] [RN:R10124] K00652 M00573 Biotin biosynthesis, BioI pathway, long-chain-acyl-ACP => pimeloyl-ACP => biotin 1,0 C01092 8-Amino-7-oxononanoate C19845 Pimelyl-[acyl-carrier protein]
+adenosylmethionine---8-amino-7-oxononanoate aminotransferase [EC:2.6.1.62] [RN:R03231] K00833 M00573 Biotin biosynthesis, BioI pathway, long-chain-acyl-ACP => pimeloyl-ACP => biotin 2,0 C01037 7,8-Diaminononanoate C01092 8-Amino-7-oxononanoate
+lysine---8-amino-7-oxononanoate aminotransferase [EC:2.6.1.105] [RN:R10699] K19563 M00573 Biotin biosynthesis, BioI pathway, long-chain-acyl-ACP => pimeloyl-ACP => biotin 2,1 C01037 7,8-Diaminononanoate C01092 8-Amino-7-oxononanoate
+dethiobiotin synthetase [EC:6.3.3.3] [RN:R03182] K01935 M00573 Biotin biosynthesis, BioI pathway, long-chain-acyl-ACP => pimeloyl-ACP => biotin 3,0 C01909 Dethiobiotin C01037 7,8-Diaminononanoate
+biotin synthetase [EC:2.8.1.6] [RN:R01078] K01012 M00573 Biotin biosynthesis, BioI pathway, long-chain-acyl-ACP => pimeloyl-ACP => biotin 4,0 C00120 Biotin C01909 Dethiobiotin
+ptxA; pertussis toxin subunit 1 [EC:2.4.2.-] K11023 M00574 Pertussis pathogenicity signature, pertussis toxin 0,0
+ptxB; pertussis toxin subunit 2 K11024 M00574 Pertussis pathogenicity signature, pertussis toxin 1,0
+ptxC; pertussis toxin subunit 3 K11025 M00574 Pertussis pathogenicity signature, pertussis toxin 2,0
+ptxD; pertussis toxin subunit 4 K11026 M00574 Pertussis pathogenicity signature, pertussis toxin 3,0
+ptxE; pertussis toxin subunit 5 K11027 M00574 Pertussis pathogenicity signature, pertussis toxin 4,0
+cyaA; bifunctional hemolysin/adenylate cyclase [EC:4.6.1.1] K22944 M00575 Pertussis pathogenicity signature, T1SS 0,0
+hlyB; ATP-binding cassette, subfamily B, bacterial HlyB/CyaB K11004 M00575 Pertussis pathogenicity signature, T1SS 1,0
+cyaC; cytolysin-activating lysine-acyltransferase [EC:2.3.1.-] K07389 M00575 Pertussis pathogenicity signature, T1SS 2,0
+hlyD; hemolysin D K11003 M00575 Pertussis pathogenicity signature, T1SS 3,0
+tolC; outer membrane channel protein K12340 M00575 Pertussis pathogenicity signature, T1SS 4,0
+ctxA; cholera enterotoxin subunit A [EC:2.4.2.36] K10928 M00576 ETEC pathogenicity signature, heat-labile and heat-stable enterotoxins 0,0
+ctxB; cholera enterotoxin subunit B K10929 M00576 ETEC pathogenicity signature, heat-labile and heat-stable enterotoxins 0,0
+sta; heat-stable enterotoxin STa/STI K16883 M00576 ETEC pathogenicity signature, heat-labile and heat-stable enterotoxins 1,0
+stb; heat-stable enterotoxin STb/STII K16884 M00576 ETEC pathogenicity signature, heat-labile and heat-stable enterotoxins 1,1
+6-carboxyhexanoate--CoA ligase [EC:6.2.1.14] [RN:R03209] K01906 M00577 Biotin biosynthesis, BioW pathway, pimelate => pimeloyl-CoA => biotin 0,0 C01063 6-Carboxyhexanoyl-CoA C02656 Pimelate
+8-amino-7-oxononanoate synthase [EC:2.3.1.47] [RN:R03210] K00652 M00577 Biotin biosynthesis, BioW pathway, pimelate => pimeloyl-CoA => biotin 1,0 C01092 8-Amino-7-oxononanoate C01063 6-Carboxyhexanoyl-CoA
+adenosylmethionine---8-amino-7-oxononanoate aminotransferase [EC:2.6.1.62] [RN:R03231] K00833 M00577 Biotin biosynthesis, BioW pathway, pimelate => pimeloyl-CoA => biotin 2,0 C01037 7,8-Diaminononanoate C01092 8-Amino-7-oxononanoate
+lysine---8-amino-7-oxononanoate aminotransferase [EC:2.6.1.105] [RN:R10699] K19563 M00577 Biotin biosynthesis, BioW pathway, pimelate => pimeloyl-CoA => biotin 2,1 C01037 7,8-Diaminononanoate C01092 8-Amino-7-oxononanoate
+dethiobiotin synthetase [EC:6.3.3.3] [RN:R03182] K01935 M00577 Biotin biosynthesis, BioW pathway, pimelate => pimeloyl-CoA => biotin 3,0 C01909 Dethiobiotin C01037 7,8-Diaminononanoate
+biotin synthetase [EC:2.8.1.6] [RN:R01078] K01012 M00577 Biotin biosynthesis, BioW pathway, pimelate => pimeloyl-CoA => biotin 4,0 C00120 Biotin C01909 Dethiobiotin
+phosphate acetyltransferase [EC:2.3.1.8] [RN:R00230] K00625 M00579 Phosphate acetyltransferase-acetate kinase pathway, acetyl-CoA => acetate 0,0 C00227 Acetyl phosphate C00024 Acetyl-CoA
+phosphate acetyltransferase [EC:2.3.1.8] [RN:R00230] K13788 M00579 Phosphate acetyltransferase-acetate kinase pathway, acetyl-CoA => acetate 0,1 C00227 Acetyl phosphate C00024 Acetyl-CoA
+phosphate acetyltransferase [EC:2.3.1.8] [RN:R00230] K15024 M00579 Phosphate acetyltransferase-acetate kinase pathway, acetyl-CoA => acetate 0,2 C00227 Acetyl phosphate C00024 Acetyl-CoA
+acetate kinase [EC:2.7.2.1] [RN:R00315] K00925 M00579 Phosphate acetyltransferase-acetate kinase pathway, acetyl-CoA => acetate 1,0 C00033 Acetate C00227 Acetyl phosphate
+6-phospho-3-hexuloisomerase [EC:5.3.1.27] [RN:R09780] K08094 M00580 Pentose phosphate pathway, archaea, fructose 6P => ribose 5P 0,0,0,0 C06019 D-arabino-Hex-3-ulose 6-phosphate C05345 beta-D-Fructose 6-phosphate
+3-hexulose-6-phosphate synthase [EC:4.1.2.43] [RN:R05338] K08093 M00580 Pentose phosphate pathway, archaea, fructose 6P => ribose 5P 0,0,1,0 C00199 D-Ribulose 5-phosphate C06019 D-arabino-Hex-3-ulose 6-phosphate
+3-hexulose-6-phosphate synthase [EC:4.1.2.43] [RN:R05338] K13812 M00580 Pentose phosphate pathway, archaea, fructose 6P => ribose 5P 0,0,1,1 C00199 D-Ribulose 5-phosphate C06019 D-arabino-Hex-3-ulose 6-phosphate
+6-phospho-3-hexuloisomerase [EC:5.3.1.27] [RN:R09780] K13831 M00580 Pentose phosphate pathway, archaea, fructose 6P => ribose 5P 0,1 C06019 D-arabino-Hex-3-ulose 6-phosphate C05345 beta-D-Fructose 6-phosphate
+ribose 5-phosphate isomerase A [EC:5.3.1.6] [RN:R01056] K01807 M00580 Pentose phosphate pathway, archaea, fructose 6P => ribose 5P 1,0 C00117 D-Ribose 5-phosphate C00199 D-Ribulose 5-phosphate
+soxA; sulfur-oxidizing protein SoxA K17222 M00595 Thiosulfate oxidation by SOX complex, thiosulfate => sulfate 0,0 C00059 Sulfate C00320 Thiosulfate
+soxX; sulfur-oxidizing protein SoxX K17223 M00595 Thiosulfate oxidation by SOX complex, thiosulfate => sulfate 0,0 C00059 Sulfate C00320 Thiosulfate
+soxB; sulfur-oxidizing protein SoxB K17224 M00595 Thiosulfate oxidation by SOX complex, thiosulfate => sulfate 0,0 C00059 Sulfate C00320 Thiosulfate
+soxC; S-disulfanyl-L-cysteine oxidoreductase SoxC [EC:1.8.2.6] K17225 M00595 Thiosulfate oxidation by SOX complex, thiosulfate => sulfate 0,0 C00059 Sulfate C00320 Thiosulfate
+soxD; S-disulfanyl-L-cysteine oxidoreductase SoxD [EC:1.8.2.6] K22622 M00595 Thiosulfate oxidation by SOX complex, thiosulfate => sulfate 0,0 C00059 Sulfate C00320 Thiosulfate
+soxY; sulfur-oxidizing protein SoxY K17226 M00595 Thiosulfate oxidation by SOX complex, thiosulfate => sulfate 0,0 C00059 Sulfate C00320 Thiosulfate
+soxZ; sulfur-oxidizing protein SoxZ K17227 M00595 Thiosulfate oxidation by SOX complex, thiosulfate => sulfate 0,0 C00059 Sulfate C00320 Thiosulfate
+sulfate adenylyltransferase [EC:2.7.7.4] [RN:R00529] K00956 M00596 Dissimilatory sulfate reduction, sulfate => H2S 0,0 C00224 Adenylyl sulfate C00059 Sulfate
+sulfate adenylyltransferase [EC:2.7.7.4] [RN:R00529] K00957 M00596 Dissimilatory sulfate reduction, sulfate => H2S 0,0 C00224 Adenylyl sulfate C00059 Sulfate
+sulfate adenylyltransferase [EC:2.7.7.4] [RN:R00529] K00958 M00596 Dissimilatory sulfate reduction, sulfate => H2S 0,1 C00224 Adenylyl sulfate C00059 Sulfate
+adenylylsulfate reductase [EC:1.8.99.2] [RN:R08553] K00394 M00596 Dissimilatory sulfate reduction, sulfate => H2S 1,0 C00094 Sulfite C00224 Adenylyl sulfate
+adenylylsulfate reductase [EC:1.8.99.2] [RN:R08553] K00395 M00596 Dissimilatory sulfate reduction, sulfate => H2S 1,0 C00094 Sulfite C00224 Adenylyl sulfate
+sulfite reductase, dissimilatory-type [EC:1.8.99.5] [RN:R00861] K11180 M00596 Dissimilatory sulfate reduction, sulfate => H2S 2,0 C00283 Hydrogen sulfide C00094 Sulfite
+sulfite reductase, dissimilatory-type [EC:1.8.99.5] [RN:R00861] K11181 M00596 Dissimilatory sulfate reduction, sulfate => H2S 2,0 C00283 Hydrogen sulfide C00094 Sulfite
+pufL; photosynthetic reaction center L subunit K08928 M00597 Anoxygenic photosystem II 0,0
+pufM; photosynthetic reaction center M subunit K08929 M00597 Anoxygenic photosystem II 0,0
+pscA; photosystem P840 reaction center large subunit K08940 M00598 Anoxygenic photosystem I 0,0
+pscB; photosystem P840 reaction center iron-sulfur protein K08941 M00598 Anoxygenic photosystem I 0,0
+pscC; photosystem P840 reaction center cytochrome c551 K08942 M00598 Anoxygenic photosystem I 0,0
+pscD; photosystem P840 reaction center protein PscD K08943 M00598 Anoxygenic photosystem I 0,0
+methanogen homocitrate synthase [EC:2.3.3.14 2.3.3.-] [RN:R00271 R08331 R08332] K10977 M00608 2-Oxocarboxylic acid chain extension, 2-oxoglutarate => 2-oxoadipate => 2-oxopimelate => 2-oxosuberate 0,0 C16598 (R)-(Homo)3-citrate C16588,C00024 2-Oxopimelate,Acetyl-CoA
+methanogen homoaconitase large subunit [EC:4.2.1.114] [RN:R03444 R04371 R09720 R10392 R10393 R10391 R10395 R10396 R10394] K16792 M00608 2-Oxocarboxylic acid chain extension, 2-oxoglutarate => 2-oxoadipate => 2-oxopimelate => 2-oxosuberate 1,0 C16600 (-)-threo-Iso(homo)3-citrate C16598 (R)-(Homo)3-citrate
+methanogen homoaconitase large subunit [EC:4.2.1.114] [RN:R03444 R04371 R09720 R10392 R10393 R10391 R10395 R10396 R10394] K16793 M00608 2-Oxocarboxylic acid chain extension, 2-oxoglutarate => 2-oxoadipate => 2-oxopimelate => 2-oxosuberate 1,0 C16600 (-)-threo-Iso(homo)3-citrate C16598 (R)-(Homo)3-citrate
+methanogen homoisocitrate dehydrogenase [EC:1.1.1.87 1.1.1.-] [RN:R01934 R08214 R08215] K10978 M00608 2-Oxocarboxylic acid chain extension, 2-oxoglutarate => 2-oxoadipate => 2-oxopimelate => 2-oxosuberate 2,0 C16589 2-Oxosuberate C16600 (-)-threo-Iso(homo)3-citrate
+S-adenosylmethionine synthetase [EC:2.5.1.6] [RN:R00177] K00789 M00609 Cysteine biosynthesis, methionine => cysteine 0,0 C00019 S-Adenosyl-L-methionine C00073 L-Methionine
+putative AdoMet-dependent methyltransferase [EC:2.1.1.-] [RN:R10404] K17462 M00609 Cysteine biosynthesis, methionine => cysteine 1,0 C00021 S-Adenosyl-L-homocysteine C00019 S-Adenosyl-L-methionine
+S-adenosylhomocysteine/5'-methylthioadenosine nucleosidase [EC:3.2.2.9] [RN:R00194] K01243 M00609 Cysteine biosynthesis, methionine => cysteine 2,0 C03539 S-Ribosyl-L-homocysteine C00021 S-Adenosyl-L-homocysteine
+S-adenosylhomocysteine/5'-methylthioadenosine nucleosidase [EC:3.2.2.9] [RN:R00194] K18284 M00609 Cysteine biosynthesis, methionine => cysteine 2,1 C03539 S-Ribosyl-L-homocysteine C00021 S-Adenosyl-L-homocysteine
+S-ribosylhomocysteine lyase [EC:4.4.1.21] [RN:R01291] K07173 M00609 Cysteine biosynthesis, methionine => cysteine 3,0 C00155 L-Homocysteine C03539 S-Ribosyl-L-homocysteine
+cystathionine beta-synthase (O-acetyl-L-serine) [EC:2.5.1.134] [RN:R10305] K17216 M00609 Cysteine biosynthesis, methionine => cysteine 4,0 C02291 L-Cystathionine C00155 L-Homocysteine
+cystathionine gamma-lyase [EC:4.4.1.1] [RN:R01001] K17217 M00609 Cysteine biosynthesis, methionine => cysteine 5,0 C00097 L-Cysteine C02291 L-Cystathionine
+NRT; MFS transporter, NNP family, nitrate/nitrite transporter K02575 M00615 Nitrate assimilation 0,0
+pyruvate ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] K00169 M00620 Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate 0,0 C00022 Pyruvate C00024 Acetyl-CoA
+pyruvate ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] K00170 M00620 Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate 0,0 C00022 Pyruvate C00024 Acetyl-CoA
+pyruvate ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] K00171 M00620 Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate 0,0 C00022 Pyruvate C00024 Acetyl-CoA
+pyruvate ferredoxin oxidoreductase [EC:1.2.7.1] [RN:R01196] K00172 M00620 Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate 0,0 C00022 Pyruvate C00024 Acetyl-CoA
+pyruvate carboxylase [EC:6.4.1.1] [RN:R00344] K01959 M00620 Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate 1,0 C00036 Oxaloacetate C00022 Pyruvate
+pyruvate carboxylase [EC:6.4.1.1] [RN:R00344] K01960 M00620 Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate 1,0 C00036 Oxaloacetate C00022 Pyruvate
+malate dehydrogenase [EC:1.1.1.37] [RN:R00342] K00024 M00620 Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate 2,0 C00149 (S)-Malate C00036 Oxaloacetate
+fumarate hydratase [EC:4.2.1.2] [RN:R01082] K01677 M00620 Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate 3,0 C00122 Fumarate C00149 (S)-Malate
+fumarate hydratase [EC:4.2.1.2] [RN:R01082] K01678 M00620 Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate 3,0 C00122 Fumarate C00149 (S)-Malate
+fumarate reductase (CoM/CoB) [EC:1.3.4.1] [RN:R10660] K18209 M00620 Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate 4,0 C00042 Succinate C00122 Fumarate
+fumarate reductase (CoM/CoB) [EC:1.3.4.1] [RN:R10660] K18210 M00620 Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate 4,0 C00042 Succinate C00122 Fumarate
+succinyl-CoA synthetase [EC:6.2.1.5] [RN:R00405] K01902 M00620 Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate 5,0 C00091 Succinyl-CoA C00042 Succinate
+succinyl-CoA synthetase [EC:6.2.1.5] [RN:R00405] K01903 M00620 Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate 5,0 C00091 Succinyl-CoA C00042 Succinate
+2-oxoglutarate ferredoxin oxidoreductase [EC:1.2.7.3] [RN:R01197] K00174 M00620 Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate 6,0 C00026 2-Oxoglutarate C00091 Succinyl-CoA
+2-oxoglutarate ferredoxin oxidoreductase [EC:1.2.7.3] [RN:R01197] K00175 M00620 Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate 6,0 C00026 2-Oxoglutarate C00091 Succinyl-CoA
+2-oxoglutarate ferredoxin oxidoreductase [EC:1.2.7.3] [RN:R01197] K00176 M00620 Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate 6,0 C00026 2-Oxoglutarate C00091 Succinyl-CoA
+2-oxoglutarate ferredoxin oxidoreductase [EC:1.2.7.3] [RN:R01197] K00177 M00620 Incomplete reductive citrate cycle, acetyl-CoA => oxoglutarate 6,0 C00026 2-Oxoglutarate C00091 Succinyl-CoA
+nicotinate dehydrogenase [EC:1.17.2.1] [RN:R09473] K18029 M00622 Nicotinate degradation, nicotinate => fumarate 0,0 C01020 6-Hydroxynicotinate C00253 Nicotinate
+nicotinate dehydrogenase [EC:1.17.2.1] [RN:R09473] K18030 M00622 Nicotinate degradation, nicotinate => fumarate 0,0 C01020 6-Hydroxynicotinate C00253 Nicotinate
+6-hydroxynicotinate 3-monooxygenase [EC:1.14.13.114] [RN:R08764] K14974 M00622 Nicotinate degradation, nicotinate => fumarate 1,0 C01059 2,5-Dihydroxypyridine C01020 6-Hydroxynicotinate
+2,5-dihydroxypyridine 5,6-dioxygenase [EC:1.13.11.9] [RN:R09125] K18028 M00622 Nicotinate degradation, nicotinate => fumarate 2,0 C18232 N-Formylmaleamic acid C01059 2,5-Dihydroxypyridine
+N-formylmaleamate deformylase [EC:3.5.1.106] [RN:R09126] K15357 M00622 Nicotinate degradation, nicotinate => fumarate 3,0 C01596 Maleamate C18232 N-Formylmaleamic acid
+maleamate amidohydrolase [EC:3.5.1.107] [RN:R03540] K13995 M00622 Nicotinate degradation, nicotinate => fumarate 4,0 C01384 Maleic acid C01596 Maleamate
+maleate isomerase [EC:5.2.1.1] [RN:R01087] K01799 M00622 Nicotinate degradation, nicotinate => fumarate 5,0 C00122 Fumarate C01384 Maleic acid
+phthalate 4,5-dioxygenase [EC:1.14.12.7] [RN:R03630] K18068 M00623 Phthalate degradation, phthalate => protocatechuate 0,0 C04783 cis-4,5-Dihydroxycyclohexa-1(6),2-diene-1,2-dicarboxylate C01606 Phthalate
+phthalate 4,5-dioxygenase [EC:1.14.12.7] [RN:R03630] K18069 M00623 Phthalate degradation, phthalate => protocatechuate 0,0 C04783 cis-4,5-Dihydroxycyclohexa-1(6),2-diene-1,2-dicarboxylate C01606 Phthalate
+phthalate 4,5-cis-dihydrodiol dehydrogenase [EC:1.3.1.64] [RN:R05275] K18067 M00623 Phthalate degradation, phthalate => protocatechuate 1,0 C03233 4,5-Dihydroxyphthalate C04783 cis-4,5-Dihydroxycyclohexa-1(6),2-diene-1,2-dicarboxylate
+4,5-dihydroxyphthalate decarboxylase [EC:4.1.1.55] [RN:R01635] K04102 M00623 Phthalate degradation, phthalate => protocatechuate 2,0 C00230 3,4-Dihydroxybenzoate C03233 4,5-Dihydroxyphthalate
+K18075,K18077 terephthalate 1,2-dioxygenase [EC:1.14.12.15] [RN:R05148] K18074 M00624 Terephthalate degradation, terephthalate => 3,4-dihydroxybenzoate 0,0 C06318 (3S,4R)-3,4-Dihydroxycyclohexa-1,5-diene-1,4-dicarboxylate C06337 Terephthalate
+tphA3 K18075 M00624 Terephthalate degradation, terephthalate => 3,4-dihydroxybenzoate 0,0 C06318 (3S,4R)-3,4-Dihydroxycyclohexa-1,5-diene-1,4-dicarboxylate C06337 Terephthalate
+tphA1 K18077 M00624 Terephthalate degradation, terephthalate => 3,4-dihydroxybenzoate 0,0 C06318 (3S,4R)-3,4-Dihydroxycyclohexa-1,5-diene-1,4-dicarboxylate C06337 Terephthalate
+1,2-dihydroxy-3,5-cyclohexadiene-1,4-dicarboxylate dehydrogenase [EC:1.3.1.53] [RN:R01633] K18076 M00624 Terephthalate degradation, terephthalate => 3,4-dihydroxybenzoate 1,0 C00230 3,4-Dihydroxybenzoate C06318 (3S,4R)-3,4-Dihydroxycyclohexa-1,5-diene-1,4-dicarboxylate
+mecR1; methicillin resistance protein K02547 M00625 Methicillin resistance 0,0
+mecI; methicillin resistance regulatory protein K02546 M00625 Methicillin resistance 1,0
+mecA; penicillin-binding protein 2 prime K02545 M00625 Methicillin resistance 2,0
+blaR1; bla regulator protein blaR1 K02172 M00627 beta-Lactam resistance, Bla system 0,0
+blaI; BlaI family transcriptional regulator, penicillinase repressor K02171 M00627 beta-Lactam resistance, Bla system 1,0
+blaZ; beta-lactamase class A BlaZ [EC:3.5.2.6] K18766 M00627 beta-Lactam resistance, Bla system 2,0
+penP; beta-lactamase class A [EC:3.5.2.6] K17836 M00627 beta-Lactam resistance, Bla system 2,1
+D-galacturonate reductase [EC:1.1.1.-] [RN:R07676 R10565] K18106 M00630 D-Galacturonate degradation (fungi), D-galacturonate => glycerol 0,0 C15930 L-Galactonate C00333 D-Galacturonate
+D-galacturonate reductase [EC:1.1.1.365] [RN:R07676] K19634 M00630 D-Galacturonate degradation (fungi), D-galacturonate => glycerol 0,1 C15930 L-Galactonate C00333 D-Galacturonate
+L-galactonate dehydratase [EC:4.2.1.146] [RN:R10532] K18102 M00630 D-Galacturonate degradation (fungi), D-galacturonate => glycerol 1,0 C20680 2-Dehydro-3-deoxy-L-galactonate C15930 L-Galactonate
+L-threo-3-deoxy-hexylosonate aldolase [EC:4.1.2.54] [RN:R10550] K18103 M00630 D-Galacturonate degradation (fungi), D-galacturonate => glycerol 2,0 C02426 L-Glyceraldehyde C20680 2-Dehydro-3-deoxy-L-galactonate
+L-glyceraldehyde reductase [EC:1.1.1.372] [RN:R10563] K18107 M00630 D-Galacturonate degradation (fungi), D-galacturonate => glycerol 3,0 C00116 Glycerol C02426 L-Glyceraldehyde
+glucuronate isomerase [EC:5.3.1.12] [RN:R01983] K01812 M00631 D-Galacturonate degradation (bacteria), D-galacturonate => pyruvate + D-glyceraldehyde 3P 0,0 C00558 D-Tagaturonate C00333 D-Galacturonate
+tagaturonate reductase [EC:1.1.1.58] [RN:R02555] K00041 M00631 D-Galacturonate degradation (bacteria), D-galacturonate => pyruvate + D-glyceraldehyde 3P 1,0 C00817 D-Altronate C00558 D-Tagaturonate
+altronate hydrolase [EC:4.2.1.7] [RN:R01540] K01685 M00631 D-Galacturonate degradation (bacteria), D-galacturonate => pyruvate + D-glyceraldehyde 3P 2,0 C00204 2-Dehydro-3-deoxy-D-gluconate C00817 D-Altronate
+altronate hydrolase [EC:4.2.1.7] [RN:R01540] K16849 M00631 D-Galacturonate degradation (bacteria), D-galacturonate => pyruvate + D-glyceraldehyde 3P 2,1 C00204 2-Dehydro-3-deoxy-D-gluconate C00817 D-Altronate
+altronate hydrolase [EC:4.2.1.7] [RN:R01540] K16850 M00631 D-Galacturonate degradation (bacteria), D-galacturonate => pyruvate + D-glyceraldehyde 3P 2,1 C00204 2-Dehydro-3-deoxy-D-gluconate C00817 D-Altronate
+2-dehydro-3-deoxygluconokinase [EC:2.7.1.45] [RN:R01541] K00874 M00631 D-Galacturonate degradation (bacteria), D-galacturonate => pyruvate + D-glyceraldehyde 3P 3,0 C04442 2-Dehydro-3-deoxy-6-phospho-D-gluconate C00204 2-Dehydro-3-deoxy-D-gluconate
+2-dehydro-3-deoxy-phosphogluconate aldolase [EC:4.1.2.14] [RN:R05605] K01625 M00631 D-Galacturonate degradation (bacteria), D-galacturonate => pyruvate + D-glyceraldehyde 3P 4,0 C00022,C00118 Pyruvate,D-Glyceraldehyde 3-phosphate C04442 2-Dehydro-3-deoxy-6-phospho-D-gluconate
+2-dehydro-3-deoxy-phosphogluconate aldolase [EC:4.1.2.14] [RN:R05605] K17463 M00631 D-Galacturonate degradation (bacteria), D-galacturonate => pyruvate + D-glyceraldehyde 3P 4,1 C00022,C00118 Pyruvate,D-Glyceraldehyde 3-phosphate C04442 2-Dehydro-3-deoxy-6-phospho-D-gluconate
+aldose 1-epimerase [EC:5.1.3.3] [RN:R10619] K01785 M00632 Galactose degradation, Leloir pathway, galactose => alpha-D-glucose-1P 0,0 C00984 alpha-D-Galactose C00124 D-Galactose
+galactokinase [EC:2.7.1.6] [RN:R01092] K00849 M00632 Galactose degradation, Leloir pathway, galactose => alpha-D-glucose-1P 1,0 C00446 alpha-D-Galactose 1-phosphate C00984 alpha-D-Galactose
+UDPglucose--hexose-1-phosphate uridylyltransferase [EC:2.7.7.12] [RN:R00955] K00965 M00632 Galactose degradation, Leloir pathway, galactose => alpha-D-glucose-1P 2,0 C00052,C00103 UDP-alpha-D-galactose,D-Glucose 1-phosphate C00446,C00029 alpha-D-Galactose 1-phosphate,UDP-glucose
+UDP-glucose 4-epimerase [EC:5.1.3.2] [RN:R00291] K01784 M00632 Galactose degradation, Leloir pathway, galactose => alpha-D-glucose-1P 3,0 C00029 UDP-glucose C00052 UDP-alpha-D-galactose
+gluconate dehydratase [EC:4.2.1.140] [RN:R01538 R03033] K05308 M00633 Semi-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate-3P 0,0 C01216 2-Dehydro-3-deoxy-D-galactonate C00880 D-Galactonate
+2-dehydro-3-deoxygluconokinase [EC:2.7.1.178] [RN:R01541 R03387] K18126 M00633 Semi-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate-3P 1,0 C01286 2-Dehydro-3-deoxy-6-phospho-D-galactonate C01216 2-Dehydro-3-deoxy-D-galactonate
+2-dehydro-3-deoxyphosphogluconate aldolase [EC:4.1.2.55] [RN:R05605 R01064] K11395 M00633 Semi-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate-3P 2,0 C00118 D-Glyceraldehyde 3-phosphate C01286 2-Dehydro-3-deoxy-6-phospho-D-galactonate
+glyceraldehyde-3-phosphate dehydrogenase (NADP+) [EC:1.2.1.9] [RN:R01058] K00131 M00633 Semi-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate-3P 3,0 C00197 3-Phospho-D-glycerate C00118 D-Glyceraldehyde 3-phosphate
+glyceraldehyde-3-phosphate dehydrogenase [NAD(P)+] [EC:1.2.1.90] [RN:R01058 R10860] K18978 M00633 Semi-phosphorylative Entner-Doudoroff pathway, gluconate/galactonate => glycerate-3P 3,1 C00197 3-Phospho-D-glycerate C00118 D-Glyceraldehyde 3-phosphate
+phtA; phthalate 3,4-dioxygenase [EC:1.14.12.-] [RN:R09227] K18251 M00636 Phthalate degradation, phthalate => protocatechuate 0,0 C18314 Phthalate 3,4-cis-dihydrodiol C01606 Phthalate
+phtA; phthalate 3,4-dioxygenase [EC:1.14.12.-] [RN:R09227] K18252 M00636 Phthalate degradation, phthalate => protocatechuate 0,0 C18314 Phthalate 3,4-cis-dihydrodiol C01606 Phthalate
+phtA; phthalate 3,4-dioxygenase [EC:1.14.12.-] [RN:R09227] K18253 M00636 Phthalate degradation, phthalate => protocatechuate 0,0 C18314 Phthalate 3,4-cis-dihydrodiol C01606 Phthalate
+phtA; phthalate 3,4-dioxygenase [EC:1.14.12.-] [RN:R09227] K18254 M00636 Phthalate degradation, phthalate => protocatechuate 0,0 C18314 Phthalate 3,4-cis-dihydrodiol C01606 Phthalate
+phtB; phthalate 3,4-cis-dihydrodiol dehydrogenase [EC:1.3.1.-] [RN:R09228] K18255 M00636 Phthalate degradation, phthalate => protocatechuate 1,0 C03223 3,4-Dihydroxyphthalate C18314 Phthalate 3,4-cis-dihydrodiol
+phtC; 3,4-dihydroxyphthalate decarboxylase [EC:4.1.1.69] [RN:R01634] K18256 M00636 Phthalate degradation, phthalate => protocatechuate 2,0 C00230 3,4-Dihydroxybenzoate C03223 3,4-Dihydroxyphthalate
+anthranilate 1,2-dioxygenase [EC:1.14.12.1] [RN:R00823 R00825] K05599 M00637 Anthranilate degradation, anthranilate => catechol 0,0 C00090 Catechol C00108 Anthranilate
+anthranilate 1,2-dioxygenase [EC:1.14.12.1] [RN:R00823 R00825] K05600 M00637 Anthranilate degradation, anthranilate => catechol 0,0 C00090 Catechol C00108 Anthranilate
+anthranilate 1,2-dioxygenase [EC:1.14.12.1] [RN:R00823 R00825] K11311 M00637 Anthranilate degradation, anthranilate => catechol 0,0 C00090 Catechol C00108 Anthranilate
+anthranilate 1,2-dioxygenase [EC:1.14.12.1] K16319 M00637 Anthranilate degradation, anthranilate => catechol 0,1 C00090 Catechol C00108 Anthranilate
+anthranilate 1,2-dioxygenase [EC:1.14.12.1] K16320 M00637 Anthranilate degradation, anthranilate => catechol 0,1 C00090 Catechol C00108 Anthranilate
+anthranilate 1,2-dioxygenase [EC:1.14.12.1] K18248 M00637 Anthranilate degradation, anthranilate => catechol 0,1 C00090 Catechol C00108 Anthranilate
+anthranilate 1,2-dioxygenase [EC:1.14.12.1] K18249 M00637 Anthranilate degradation, anthranilate => catechol 0,1 C00090 Catechol C00108 Anthranilate
+salicylate 5-hydroxylase [EC:1.14.13.172] [RN:R07709 R07710] K18242 M00638 Salicylate degradation, salicylate => gentisate 0,0 C00628 2,5-Dihydroxybenzoate C00805 Salicylate
+salicylate 5-hydroxylase [EC:1.14.13.172] [RN:R07709 R07710] K18243 M00638 Salicylate degradation, salicylate => gentisate 0,0 C00628 2,5-Dihydroxybenzoate C00805 Salicylate
+salicylate 5-hydroxylase [EC:1.14.13.172] [RN:R07709 R07710] K14578 M00638 Salicylate degradation, salicylate => gentisate 0,0 C00628 2,5-Dihydroxybenzoate C00805 Salicylate
+salicylate 5-hydroxylase [EC:1.14.13.172] [RN:R07709 R07710] K14581 M00638 Salicylate degradation, salicylate => gentisate 0,0 C00628 2,5-Dihydroxybenzoate C00805 Salicylate
+nfxB; TetR/AcrR family transcriptional regulator, mexCD-oprJ operon repressor K18294 M00639 Multidrug resistance, efflux pump MexCD-OprJ 0,0
+mexC; membrane fusion protein K18295 M00639 Multidrug resistance, efflux pump MexCD-OprJ 1,0
+mexD; multidrug efflux pump K18296 M00639 Multidrug resistance, efflux pump MexCD-OprJ 1,0
+oprJ; multidrug resistance outer membrane protein OprJ K08721 M00639 Multidrug resistance, efflux pump MexCD-OprJ 1,0
+mexT; LysR family transcriptional regulator, mexEF-oprN operon transcriptional activator K18297 M00641 Multidrug resistance, efflux pump MexEF-OprN 0,0
+mexE; membrane fusion protein K18298 M00641 Multidrug resistance, efflux pump MexEF-OprN 1,0
+mexF; multidrug efflux pump K18299 M00641 Multidrug resistance, efflux pump MexEF-OprN 1,0
+oprN; outer membrane protein K18300 M00641 Multidrug resistance, efflux pump MexEF-OprN 1,0
+mexL; TetR/AcrR family transcriptional regulator, mexJK operon transcriptional repressor K18301 M00642 Multidrug resistance, efflux pump MexJK-OprM 0,0
+mexJ; membrane fusion protein K18302 M00642 Multidrug resistance, efflux pump MexJK-OprM 1,0
+mexK; multidrug efflux pump K18303 M00642 Multidrug resistance, efflux pump MexJK-OprM 1,0
+oprM; outer membrane protein K18139 M00642 Multidrug resistance, efflux pump MexJK-OprM 1,0
+mexZ; TetR/AcrR family transcriptional regulator, mexXY operon repressor K18129 M00643 Multidrug resistance, efflux pump MexXY-OprM 0,0
+mexX; membrane fusion protein K18094 M00643 Multidrug resistance, efflux pump MexXY-OprM 1,0
+mexY; multidrug efflux pump K18095 M00643 Multidrug resistance, efflux pump MexXY-OprM 1,0
+oprM; outer membrane protein K18139 M00643 Multidrug resistance, efflux pump MexXY-OprM 1,0
+adeS; two-component system, OmpR family, sensor histidine kinase AdeS [EC:2.7.13.3] K18143 M00649 Multidrug resistance, efflux pump AdeABC 0,0
+adeR; two-component system, OmpR family, response regulator AdeR K18144 M00649 Multidrug resistance, efflux pump AdeABC 1,0
+adeA; membrane fusion protein K18145 M00649 Multidrug resistance, efflux pump AdeABC 2,0
+adeB; multidrug efflux pump K18146 M00649 Multidrug resistance, efflux pump AdeABC 2,0
+adeC; outer membrane protein K18147 M00649 Multidrug resistance, efflux pump AdeABC 2,0
+vanSB; two-component system, OmpR family, sensor histidine kinase VanS [EC:2.7.13.3] K18345 M00651 Vancomycin resistance, D-Ala-D-Lac type 0,0,0,0
+vanRB; two-component system, OmpR family, response regulator VanR K18344 M00651 Vancomycin resistance, D-Ala-D-Lac type 0,0,1,0
+vanY; D-alanyl-D-alanine carboxypeptidase [EC:3.4.16.4] K07260 M00651 Vancomycin resistance, D-Ala-D-Lac type 0,0,2,0
+vanW; vancomycin resistance protein VanW K18346 M00651 Vancomycin resistance, D-Ala-D-Lac type 0,0,3,0
+vanSAc; two-component system, OmpR family, sensor histidine kinase VanS [EC:2.7.13.3] K18351 M00651 Vancomycin resistance, D-Ala-D-Lac type 0,1,0,0
+vanRAc; two-component system, OmpR family, response regulator VanR K18352 M00651 Vancomycin resistance, D-Ala-D-Lac type 0,1,1,0
+vanK; vancomycin resistance protein VanK K18354 M00651 Vancomycin resistance, D-Ala-D-Lac type 0,1,2,0
+vanJ; vancomycin resistance protein VanJ K18353 M00651 Vancomycin resistance, D-Ala-D-Lac type 0,1,3,0
+vanH; D-specific alpha-keto acid dehydrogenase [EC:1.1.1.-] K18347 M00651 Vancomycin resistance, D-Ala-D-Lac type 1,0,0,0
+vanB; D-alanine---(R)-lactate ligase [EC:6.1.2.1] K15739 M00651 Vancomycin resistance, D-Ala-D-Lac type 1,0,1,0
+vanX; D-alanyl-D-alanine dipeptidase [EC:3.4.13.22] K08641 M00651 Vancomycin resistance, D-Ala-D-Lac type 1,0,2,0
+vanSE; two-component system, OmpR family, sensor histidine kinase VanS [EC:2.7.13.3] K18350 M00652 Vancomycin resistance, D-Ala-D-Ser type 0,0
+vanRE; two-component system, OmpR family, response regulator VanR K18349 M00652 Vancomycin resistance, D-Ala-D-Ser type 1,0
+vanT; serine/alanine racemase [EC:5.1.1.18 5.1.1.1] K18348 M00652 Vancomycin resistance, D-Ala-D-Ser type 2,0
+vanC; D-alanine---D-serine ligase [EC:6.3.2.35] K18856 M00652 Vancomycin resistance, D-Ala-D-Ser type 3,0
+vanXY; D-alanyl-D-alanine dipeptidase/carboxypeptidase [EC:3.4.13.22 3.4.16.4] K18866 M00652 Vancomycin resistance, D-Ala-D-Ser type 4,0
+yscJ; type III secretion protein SctJ K03222 M00660 Xanthomonas spp. pathogenicity signature, T3SS and effectors 0,0
+yscR; type III secretion protein SctR K03226 M00660 Xanthomonas spp. pathogenicity signature, T3SS and effectors 0,0
+yscS; type III secretion protein SctS K03227 M00660 Xanthomonas spp. pathogenicity signature, T3SS and effectors 0,0
+yscT; type III secretion protein SctT K03228 M00660 Xanthomonas spp. pathogenicity signature, T3SS and effectors 0,0
+yscU; type III secretion protein SctU K03229 M00660 Xanthomonas spp. pathogenicity signature, T3SS and effectors 0,0
+yscV; type III secretion protein SctV K03230 M00660 Xanthomonas spp. pathogenicity signature, T3SS and effectors 0,0
+yscN; ATP synthase in type III secretion protein SctN [EC:3.6.3.14] K03224 M00660 Xanthomonas spp. pathogenicity signature, T3SS and effectors 0,0
+yscQ; type III secretion protein SctQ K03225 M00660 Xanthomonas spp. pathogenicity signature, T3SS and effectors 0,0
+yscL; type III secretion protein SctL K03223 M00660 Xanthomonas spp. pathogenicity signature, T3SS and effectors 0,0
+hrpB2; type III secretion inner rod protein HrpB2 K18374 M00660 Xanthomonas spp. pathogenicity signature, T3SS and effectors 0,0
+hrpF; type III secretion translocon protein HrpF K18376 M00660 Xanthomonas spp. pathogenicity signature, T3SS and effectors 0,0
+hrpB1; type III secretion protein HrpB1 K18373 M00660 Xanthomonas spp. pathogenicity signature, T3SS and effectors 1,0
+hrpE; type III secretion hrp pilus HrpE K18375 M00660 Xanthomonas spp. pathogenicity signature, T3SS and effectors 2,0
+hpa2; lysozyme-related protein Hpa2 K18377 M00660 Xanthomonas spp. pathogenicity signature, T3SS and effectors 3,0
+hpa1; type III secretion harpin protein Hpa1 K18378 M00660 Xanthomonas spp. pathogenicity signature, T3SS and effectors 4,0
+K18379; type III secretion regulatory protein HpaA K18379 M00660 Xanthomonas spp. pathogenicity signature, T3SS and effectors 5,0
+K18380; type III secretion control protein HpaB K18380 M00660 Xanthomonas spp. pathogenicity signature, T3SS and effectors 6,0
+K18381; type III secretion control protein HpaP K18381 M00660 Xanthomonas spp. pathogenicity signature, T3SS and effectors 7,0
+geranylgeranyldiphosphate transferase [RN:R10349] K18385 M00661 Paspaline biosynthesis, geranylgeranyl-PP + indoleglycerol phosphate => paspaline 0,0 C20525 3-Geranylgeranylindole C00353,C03506 Geranylgeranyl diphosphate,Indoleglycerol phosphate
+FAD dependent monooxygenase [EC:1.14.13.-] [RN:R10350 R10351] K18386 M00661 Paspaline biosynthesis, geranylgeranyl-PP + indoleglycerol phosphate => paspaline 1,0 C20529 14,15-Epoxyemindole SB C20527 Emindole SB
+paspaline synthase [RN:R10352 R10353] K18387 M00661 Paspaline biosynthesis, geranylgeranyl-PP + indoleglycerol phosphate => paspaline 2,0 C20530 Paspaline C20529 14,15-Epoxyemindole SB
+nodA; nodulation protein A [EC:2.3.1.-] K14658 M00664 Nodulation 0,0
+nodB; chitooligosaccharide deacetylase [EC:3.5.1.-] K14659 M00664 Nodulation 1,0
+nodC; N-acetylglucosaminyltransferase [EC:2.4.1.-] K14666 M00664 Nodulation 2,0
+nodD; LysR family transcriptional regulator, nod-box dependent transcriptional activator K14657 M00664 Nodulation 3,0
+N-(5-amino-5-carboxypentanoyl)-L-cysteinyl-D-valine synthase [EC:6.3.2.26] [RN:R04870] K12743 M00672 Penicillin biosynthesis, aminoadipate + cycteine + valine => penicillin 0,0 C05556 delta-(L-2-Aminoadipyl)-L-cysteinyl-D-valine C00956,C00183,C00097 L-2-Aminoadipate,L-Valine,L-Cysteine
+isopenicillin-N synthase [EC:1.21.3.1] [RN:R04872] K04126 M00672 Penicillin biosynthesis, aminoadipate + cycteine + valine => penicillin 1,0 C05557 Isopenicillin N C05556 delta-(L-2-Aminoadipyl)-L-cysteinyl-D-valine
+isopenicillin-N N-acyltransferase [EC:2.3.1.164] [RN:R06361] K10852 M00672 Penicillin biosynthesis, aminoadipate + cycteine + valine => penicillin 2,0 C00395 Penicillin C05557 Isopenicillin N
+N-(5-amino-5-carboxypentanoyl)-L-cysteinyl-D-valine synthase [EC:6.3.2.26] [RN:R04870] K12743 M00673 Cephamycin C biosynthesis, aminoadipate + cycteine + valine => cephamycin C 0,0 C05556 delta-(L-2-Aminoadipyl)-L-cysteinyl-D-valine C00956,C00183,C00097 L-2-Aminoadipate,L-Valine,L-Cysteine
+isopenicillin-N synthase [EC:1.21.3.1] [RN:R04872] K04126 M00673 Cephamycin C biosynthesis, aminoadipate + cycteine + valine => cephamycin C 1,0 C05557 Isopenicillin N C05556 delta-(L-2-Aminoadipyl)-L-cysteinyl-D-valine
+isopenicillin-N epimerase [EC:5.1.1.17] [RN:R04147] K04127 M00673 Cephamycin C biosynthesis, aminoadipate + cycteine + valine => cephamycin C 2,0 C06564 Penicillin N C05557 Isopenicillin N
+deacetoxycephalosporin-C synthase [EC:1.14.20.1] [RN:R05301] K12744 M00673 Cephamycin C biosynthesis, aminoadipate + cycteine + valine => cephamycin C 3,0 C06565 Deacetoxycephalosporin C C06564 Penicillin N
+deacetoxycephalosporin-C hydroxylase [EC:1.14.11.26] [RN:R05229] K12745 M00673 Cephamycin C biosynthesis, aminoadipate + cycteine + valine => cephamycin C 4,0 C03112 Deacetylcephalosporin C C06565 Deacetoxycephalosporin C
+hydroxymethyl cephem carbamoyltransferase [EC:2.1.3.7] [RN:R05230] K04128 M00673 Cephamycin C biosynthesis, aminoadipate + cycteine + valine => cephamycin C 5,0 C06568 O-Carbamoyl-deacetylcephalosporin C C03112 Deacetylcephalosporin C
+cephamycin C biosynthesis protein [RN:R05302] K18062 M00673 Cephamycin C biosynthesis, aminoadipate + cycteine + valine => cephamycin C 6,0 C06569 7a-Hydroxy-O-carbamoyl-deacetylcephalosporin C C06568 O-Carbamoyl-deacetylcephalosporin C
+cephamycin C biosynthesis protein [RN:R05303] K18063 M00673 Cephamycin C biosynthesis, aminoadipate + cycteine + valine => cephamycin C 7,0 C06566 Cephamycin C C06569 7a-Hydroxy-O-carbamoyl-deacetylcephalosporin C
+N2-(2-carboxyethyl)arginine synthase [EC:2.5.1.66] [RN:R05465] K12673 M00674 Clavaminate biosynthesis, arginine + glyceraldehyde-3P => clavaminate 0,0 C06655 L-N2-(2-Carboxyethyl)arginine C00062,C00118 L-Arginine,D-Glyceraldehyde 3-phosphate
+(carboxyethyl)arginine beta-lactam-synthase [EC:6.3.3.4] [RN:R05467] K12674 M00674 Clavaminate biosynthesis, arginine + glyceraldehyde-3P => clavaminate 1,0 C06656 Deoxyguanidinoproclavaminic acid C06655 L-N2-(2-Carboxyethyl)arginine
+clavaminate synthase [EC:1.14.11.21] [RN:R05466 R05468 R05469] K12675 M00674 Clavaminate biosynthesis, arginine + glyceraldehyde-3P => clavaminate 2,0 C06660 Clavaminic acid C06659 Dihydroclavaminic acid
+proclavaminate amidinohydrolase [EC:3.5.3.22] [RN:R05357] K12676 M00674 Clavaminate biosynthesis, arginine + glyceraldehyde-3P => clavaminate 3,0 C06658 Proclavaminic acid C06657 Guanidinoproclavaminic acid
+carboxymethylproline synthase [EC:2.3.1.226] [RN:R10485] K18317 M00675 Carbapenem-3-carboxylate biosynthesis, pyrroline-5-carboxylate + malonyl-CoA => carbapenem-3-carboxylate 0,0 C17366 (2S,5S)-trans-Carboxymethylproline C03912,C00083 (S)-1-Pyrroline-5-carboxylate,Malonyl-CoA
+carbapenam-3-carboxylate synthase [EC:6.3.3.6] [RN:R10556] K18316 M00675 Carbapenem-3-carboxylate biosynthesis, pyrroline-5-carboxylate + malonyl-CoA => carbapenem-3-carboxylate 1,0 C17367 (3S,5S)-Carbapenam-3-carboxylic acid C17366 (2S,5S)-trans-Carboxymethylproline
+(5R)-carbapenem-3-carboxylate synthase [EC:1.14.20.3] [RN:R10415] K18315 M00675 Carbapenem-3-carboxylate biosynthesis, pyrroline-5-carboxylate + malonyl-CoA => carbapenem-3-carboxylate 2,0 C06669 (5R)-Carbapen-2-em-3-carboxylate C17367 (3S,5S)-Carbapenam-3-carboxylic acid
+envR, acrS; TetR/AcrR family transcriptional regulator, acrEF/envCD operon repressor [COG:COG1309] K18140 M00696 Multidrug resistance, efflux pump AcrEF-TolC 0,0
+acrE; membrane fusion protein [COG:COG0845] [TC:2.A.6.2] K18141 M00696 Multidrug resistance, efflux pump AcrEF-TolC 1,0
+acrF; multidrug efflux pump [COG:COG0841] [TC:2.A.6.2] K18142 M00696 Multidrug resistance, efflux pump AcrEF-TolC 1,0
+tolC; outer membrane channel protein [COG:COG1538] [TC:1.B.17 2.A.6.2] K12340 M00696 Multidrug resistance, efflux pump AcrEF-TolC 1,0
+evgA, bvgA; two-component system, NarL family, response regulator EvgA [COG:COG2197] [GO:0000156] K07690 M00697 Multidrug resistance, efflux pump MdtEF-TolC 0,0
+mdtE; membrane fusion protein [COG:COG0845] [TC:8.A.1.6.3 2.A.6.2] K18898 M00697 Multidrug resistance, efflux pump MdtEF-TolC 1,0
+mdtF; multidrug efflux pump [COG:COG0841] [TC:2.A.6.2.13] K18899 M00697 Multidrug resistance, efflux pump MdtEF-TolC 1,0
+tolC; outer membrane channel protein [COG:COG1538] [TC:1.B.17 2.A.6.2] K12340 M00697 Multidrug resistance, efflux pump MdtEF-TolC 1,0
+bpeT; LysR family transcriptional regulator, regulator for bpeEF and oprC [COG:COG0583] K18900 M00698 Multidrug resistance, efflux pump BpeEF-OprC 0,0
+bpeE; membrane fusion protein [COG:COG0845] [TC:8.A.1 2.A.6.2] K18901 M00698 Multidrug resistance, efflux pump BpeEF-OprC 1,0
+bpeF; multidrug efflux pump [COG:COG0841] [TC:2.A.6.2] K18902 M00698 Multidrug resistance, efflux pump BpeEF-OprC 1,0
+oprC, opcM; outer membrane protein [COG:COG1538] [TC:1.B.17.3.3] K18903 M00698 Multidrug resistance, efflux pump BpeEF-OprC 1,0
+mgrA; MarR family transcriptional regulator, multiple gene regulator MgrA [COG:COG1846] K18906 M00700 Multidrug resistance, efflux pump AbcA 0,0
+norG; GntR family transcriptional regulator, regulator for abcA and norABC [COG:COG1167] K18907 M00700 Multidrug resistance, efflux pump AbcA 0,1
+abcA, bmrA; ATP-binding cassette, subfamily B, bacterial AbcA/BmrA [EC:3.6.3.44] [COG:COG1132] [GO:0008559] [TC:3.A.1.117 3.A.1.123] K18104 M00700 Multidrug resistance, efflux pump AbcA 1,0
+mgrA; MarR family transcriptional regulator, multiple gene regulator MgrA [COG:COG1846] K18906 M00702 Multidrug resistance, efflux pump NorB 0,0
+norG; GntR family transcriptional regulator, regulator for abcA and norABC [COG:COG1167] K18907 M00702 Multidrug resistance, efflux pump NorB 0,1
+BLTL; MFS transporter, DHA2 family, multidrug resistance protein [COG:COG0477] [TC:2.A.1.3] K08170 M00702 Multidrug resistance, efflux pump NorB 1,0
+mgrA; MarR family transcriptional regulator, multiple gene regulator MgrA [COG:COG1846] K18906 M00704 Tetracycline resistance, efflux pump Tet38 0,0
+tetB; MFS transporter, DHA2 family, metal-tetracycline-proton antiporter [COG:COG0477] [TC:2.A.1.3] K08168 M00704 Tetracycline resistance, efflux pump Tet38 1,0
+mepR; MarR family transcriptional regulator, repressor for mepA [COG:COG1846] K18909 M00705 Multidrug resistance, efflux pump MepA 0,0
+mepA; multidrug efflux pump [COG:COG0534] [TC:2.A.66.1.13] K18908 M00705 Multidrug resistance, efflux pump MepA 1,0
+qacR; TetR/AcrR family transcriptional regulator, repressor for qacA K18938 M00714 Multidrug resistance, efflux pump QacA 0,0
+smvA; MFS transporter, DHA2 family, multidrug resistance protein K08167 M00714 Multidrug resistance, efflux pump QacA 1,0
+mexR; MarR family transcriptional regulator, repressor of the mexAB-oprM multidrug resistance operon K18131 M00718 Multidrug resistance, efflux pump MexAB-OprM 0,0
+acrA; membrane fusion protein, multidrug efflux system K03585 M00718 Multidrug resistance, efflux pump MexAB-OprM 1,0
+acrB; multidrug efflux pump K18138 M00718 Multidrug resistance, efflux pump MexAB-OprM 1,0
+oprM; outer membrane protein, multidrug efflux system K18139 M00718 Multidrug resistance, efflux pump MexAB-OprM 1,0
+graS; two-component system, OmpR family, sensor histidine kinase GraS [EC:2.7.13.3] [COG:COG0642] [GO:0000155] K19077 M00725 Cationic antimicrobial peptide (CAMP) resistance, dltABCD operon 0,0
+graR; two-component system, OmpR family, response regulator protein GraR [COG:COG0745] [GO:0000156] K19078 M00725 Cationic antimicrobial peptide (CAMP) resistance, dltABCD operon 1,0
+dltA; D-alanine--poly(phosphoribitol) ligase subunit 1 [EC:6.1.1.13] [COG:COG1020] [GO:0047473] K03367 M00725 Cationic antimicrobial peptide (CAMP) resistance, dltABCD operon 2,0
+dltB; membrane protein involved in D-alanine export [COG:COG1696] K03739 M00725 Cationic antimicrobial peptide (CAMP) resistance, dltABCD operon 2,0
+dltC; D-alanine--poly(phosphoribitol) ligase subunit 2 [EC:6.1.1.13] [COG:COG0236] [GO:0047473] K14188 M00725 Cationic antimicrobial peptide (CAMP) resistance, dltABCD operon 2,0
+dltD; D-alanine transfer protein [COG:COG3966] K03740 M00725 Cationic antimicrobial peptide (CAMP) resistance, dltABCD operon 2,0
+graS; two-component system, OmpR family, sensor histidine kinase GraS [EC:2.7.13.3] [COG:COG0642] [GO:0000155] K19077 M00726 Cationic antimicrobial peptide (CAMP) resistance, lysyl-phosphatidylglycerol (L-PG) synthase MprF 0,0
+graR; two-component system, OmpR family, response regulator protein GraR [COG:COG0745] [GO:0000156] K19078 M00726 Cationic antimicrobial peptide (CAMP) resistance, lysyl-phosphatidylglycerol (L-PG) synthase MprF 1,0
+mprF, fmtC; phosphatidylglycerol lysyltransferase [EC:2.3.2.3] [COG:COG0392 COG2898] [GO:0050071] [TC:2 K14205 M00726 Cationic antimicrobial peptide (CAMP) resistance, lysyl-phosphatidylglycerol (L-PG) synthase MprF 2,0
+graS; two-component system, OmpR family, sensor histidine kinase GraS [EC:2.7.13.3] [COG:COG0642] [GO:0000155] K19077 M00730 Cationic antimicrobial peptide (CAMP) resistance, VraFG transporter 0,0
+graR; two-component system, OmpR family, response regulator protein GraR [COG:COG0745] [GO:0000156] K19078 M00730 Cationic antimicrobial peptide (CAMP) resistance, VraFG transporter 1,0
+vraF; cationic antimicrobial peptide transport system ATP-binding protein [COG:COG1136] [TC:3.A.1.134.7] K19079 M00730 Cationic antimicrobial peptide (CAMP) resistance, VraFG transporter 2,0
+vraG; cationic antimicrobial peptide transport system permease protein [COG:COG0577] [TC:3.A.1.134.7] K19080 M00730 Cationic antimicrobial peptide (CAMP) resistance, VraFG transporter 2,0
+nocardicin nonribosomal peptide synthetase [RN:R10880] K19102 M00736 Nocardicin A biosynthesis, L-pHPG + arginine + serine => nocardicin A 0,0 C17355 Nocardicin G C12323,C00062,C00065 L-4-Hydroxyphenylglycine,L-Arginine,L-Serine
+nocardicin nonribosomal peptide synthetase [RN:R10880] K19103 M00736 Nocardicin A biosynthesis, L-pHPG + arginine + serine => nocardicin A 0,0 C17355 Nocardicin G C12323,C00062,C00065 L-4-Hydroxyphenylglycine,L-Arginine,L-Serine
+MbtH protein [RN:R10880] K05375 M00736 Nocardicin A biosynthesis, L-pHPG + arginine + serine => nocardicin A 0,0 C17355 Nocardicin G C12323,C00062,C00065 L-4-Hydroxyphenylglycine,L-Arginine,L-Serine
+isonocardicin synthase [EC:2.5.1.38] [RN:R10881 R03072] K19104 M00736 Nocardicin A biosynthesis, L-pHPG + arginine + serine => nocardicin A 1,0 C00927 Isonocardicin A C01739 Nocardicin E
+nocardicin-A epimerase [EC:5.1.1.14] [RN:R10883 R03073] K19105 M00736 Nocardicin A biosynthesis, L-pHPG + arginine + serine => nocardicin A 2,0 C01941 Nocardicin A C00927 Isonocardicin A
+nocardicin N-oxygenase [EC:1.14.13.-] [RN:R10882] K19106 M00736 Nocardicin A biosynthesis, L-pHPG + arginine + serine => nocardicin A 3,0 C01941 Nocardicin A C17351 Nocardicin C
+citrate synthase [EC:2.3.3.1] [RN:R00351] K01647 M00740 Methylaspartate cycle 0,0 C00158 Citrate C00036,C00024 Oxaloacetate,Acetyl-CoA
+aconitate hydratase [EC:4.2.1.3] [RN:R01325 R01900] K01681 M00740 Methylaspartate cycle 1,0 C00311 Isocitrate C00417 cis-Aconitate
+isocitrate dehydrogenase [EC:1.1.1.42] [RN:R01899 R00268] K00031 M00740 Methylaspartate cycle 2,0 C00026 2-Oxoglutarate C05379 Oxalosuccinate
+glutamate dehydrogenase (NAD(P)+) [EC:1.4.1.3] [RN:R00248] K00261 M00740 Methylaspartate cycle 3,0 C00025 L-Glutamate C00026 2-Oxoglutarate
+methylaspartate mutase epsilon subunit [EC:5.4.99.1] [RN:R00262] K19268 M00740 Methylaspartate cycle 4,0 C03618 L-threo-3-Methylaspartate C00025 L-Glutamate
+methylaspartate mutase epsilon subunit [EC:5.4.99.1] [RN:R00262] K01846 M00740 Methylaspartate cycle 4,0 C03618 L-threo-3-Methylaspartate C00025 L-Glutamate
+methylaspartate ammonia-lyase [EC:4.3.1.2] [RN:R03696] K04835 M00740 Methylaspartate cycle 5,0 C01732 Mesaconate C03618 L-threo-3-Methylaspartate
+succinyl-CoA:mesaconate CoA transferase [EC:2.8.3.-] [RN:R10904] K19280 M00740 Methylaspartate cycle 6,0 C06028 2-Methylfumaryl-CoA C01732 Mesaconate
+2-methylfumaryl-CoA hydratase [EC:4.2.1.148] [RN:R05076] K14449 M00740 Methylaspartate cycle 7,0 C06027 L-erythro-3-Methylmalyl-CoA C06028 2-Methylfumaryl-CoA
+beta-methylmalyl-CoA/(S)-malyl-CoA lyase [EC:4.1.3.24] [RN:R00934] K19281 M00740 Methylaspartate cycle 8,0 C00048 Glyoxylate C06027 L-erythro-3-Methylmalyl-CoA
+bifunctional (S)-malyl-CoA lyase/thioesterase [EC:4.1.3.24 3.1.2.30] [RN:R00473 R10612] K19282 M00740 Methylaspartate cycle 9,0 C00149 (S)-Malate C04348 L-Malyl-CoA
+malate dehydrogenase [EC:1.1.1.37] [RN:R00342] K00024 M00740 Methylaspartate cycle 10,0 C00036 Oxaloacetate C00149 (S)-Malate
+propionyl-CoA carboxylase [EC:6.4.1.3] [RN:R01859] K01965 M00741 Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA 0,0 C00683 (S)-Methylmalonyl-CoA C00100 Propanoyl-CoA
+propionyl-CoA carboxylase [EC:6.4.1.3] [RN:R01859] K01966 M00741 Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA 0,0 C00683 (S)-Methylmalonyl-CoA C00100 Propanoyl-CoA
+propionyl-CoA carboxylase [EC:6.4.1.3] [RN:R01859] K11263 M00741 Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA 0,1 C00683 (S)-Methylmalonyl-CoA C00100 Propanoyl-CoA
+propionyl-CoA carboxylase [EC:6.4.1.3] [RN:R01859] K18472 M00741 Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA 0,1 C00683 (S)-Methylmalonyl-CoA C00100 Propanoyl-CoA
+propionyl-CoA carboxylase [EC:6.4.1.3] [RN:R01859] K19312 M00741 Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA 0,1 C00683 (S)-Methylmalonyl-CoA C00100 Propanoyl-CoA
+propionyl-CoA carboxylase [EC:6.4.1.3] [RN:R01859] K22568 M00741 Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA 0,1 C00683 (S)-Methylmalonyl-CoA C00100 Propanoyl-CoA
+propionyl-CoA carboxylase [EC:6.4.1.3] [RN:R01859] K01964 M00741 Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA 0,2 C00683 (S)-Methylmalonyl-CoA C00100 Propanoyl-CoA
+propionyl-CoA carboxylase [EC:6.4.1.3] [RN:R01859] K15036 M00741 Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA 0,2 C00683 (S)-Methylmalonyl-CoA C00100 Propanoyl-CoA
+propionyl-CoA carboxylase [EC:6.4.1.3] [RN:R01859] K15037 M00741 Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA 0,2 C00683 (S)-Methylmalonyl-CoA C00100 Propanoyl-CoA
+methylmalonyl-CoA/ethylmalonyl-CoA epimerase [EC:5.1.99.1] [RN:R02765] K05606 M00741 Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA 1,0 C01213 (R)-Methylmalonyl-CoA C00683 (S)-Methylmalonyl-CoA
+methylmalonyl-CoA mutase [EC:5.4.99.2] [RN:R00833] K01847 M00741 Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA 2,0 C00091 Succinyl-CoA C01213 (R)-Methylmalonyl-CoA
+methylmalonyl-CoA mutase [EC:5.4.99.2] [RN:R00833] K01848 M00741 Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA 2,1 C00091 Succinyl-CoA C01213 (R)-Methylmalonyl-CoA
+methylmalonyl-CoA mutase [EC:5.4.99.2] [RN:R00833] K01849 M00741 Propanoyl-CoA metabolism, propanoyl-CoA => succinyl-CoA 2,1 C00091 Succinyl-CoA C01213 (R)-Methylmalonyl-CoA
+phoQ; two-component system, OmpR family, sensor histidine kinase PhoQ [EC:2.7.13.3] [COG:COG0642] [GO:0000155] K07637 M00744 Cationic antimicrobial peptide (CAMP) resistance, protease PgtE 0,0
+phoP; two-component system, OmpR family, response regulator PhoP [COG:COG0745] [GO:0000156] K07660 M00744 Cationic antimicrobial peptide (CAMP) resistance, protease PgtE 1,0
+pgtE; outer membrane protease E [EC:3.4.21.-] [COG:COG4571] K08477 M00744 Cationic antimicrobial peptide (CAMP) resistance, protease PgtE 2,0
+parS; two-component system, OmpR family, sensor kinase ParS [EC:2.7.13.3] [COG:COG0642] [GO:0000155] K18072 M00745 Imipenem resistance, repression of porin OprD 0,0,0,0
+parR; two-component system, OmpR family, response regulator ParR [COG:COG0745] [GO:0000156] K18073 M00745 Imipenem resistance, repression of porin OprD 0,0,1,0
+cusS, copS, silS; two-component system, OmpR family, heavy metal sensor histidine kinase CusS [EC:2.7.13.3] [COG:COG0642] [GO:0000155] K07644 M00745 Imipenem resistance, repression of porin OprD 0,1,0,0
+cusR, copR, silR; two-component system, OmpR family, copper resistance phosphate regulon response regulator CusR [COG:COG0745] [GO:0000156] K07665 M00745 Imipenem resistance, repression of porin OprD 0,1,1,0
+mexT; LysR family transcriptional regulator, mexEF-oprN operon transcriptional activator [COG:COG0583] K18297 M00745 Imipenem resistance, repression of porin OprD 0,2
+oprD; imipenem/basic amino acid-specific outer membrane pore [EC:3.4.21.-] [TC:1.B.25.1.1] K18093 M00745 Imipenem resistance, repression of porin OprD 1,0
+marA; AraC family transcriptional regulator, mar-sox-rob regulon activator [COG:COG2207] K13632 M00746 Multidrug resistance, repression of porin OmpF 0,0
+micF; small regulatory RNA MicF K18513 M00746 Multidrug resistance, repression of porin OmpF 1,0
+ompF; outer membrane pore protein F [COG:COG3203] [TC:1.B.1.1.1] K09476 M00746 Multidrug resistance, repression of porin OmpF 2,0
+UDP-4-amino-4-deoxy-L-arabinose formyltransferase / UDP-glucuronic acid dehydrogenase (UDP-4-keto-hexauronic acid decarboxylating) [EC:2.1.2.13 1.1.1.305] [RN:R07658 R07660] K10011 M00761 Undecaprenylphosphate alpha-L-Ara4N biosynthesis, UDP-GlcA => undecaprenyl phosphate alpha-L-Ara4N 0,0 C16154 UDP-L-Ara4FN C16153 UDP-L-Ara4N
+UDP-4-amino-4-deoxy-L-arabinose-oxoglutarate aminotransferase [EC:2.6.1.87] [RN:R07659] K07806 M00761 Undecaprenylphosphate alpha-L-Ara4N biosynthesis, UDP-GlcA => undecaprenyl phosphate alpha-L-Ara4N 1,0 C16153 UDP-L-Ara4N C16155 UDP-L-Ara4O
+undecaprenyl-phosphate 4-deoxy-4-formamido-L-arabinose transferase [EC:2.4.2.53] [RN:R07661] K10012 M00761 Undecaprenylphosphate alpha-L-Ara4N biosynthesis, UDP-GlcA => undecaprenyl phosphate alpha-L-Ara4N 2,0 C16156 Undecaprenyl phosphate alpha-L-Ara4FN C16154 UDP-L-Ara4FN
+undecaprenyl phosphate-alpha-L-ara4FN deformylase [EC:3.5.-.-] [RN:R07662] K13014 M00761 Undecaprenylphosphate alpha-L-Ara4N biosynthesis, UDP-GlcA => undecaprenyl phosphate alpha-L-Ara4N 3,0 C16157 Undecaprenyl phosphate alpha-L-Ara4N C16156 Undecaprenyl phosphate alpha-L-Ara4FN
+glutamate--LysW ligase ArgX [EC:6.3.2.-] [RN:R10929] K19412 M00763 Ornithine biosynthesis, mediated by LysW, glutamate => ornithine 0,0 C20948 LysW-L-glutamate C00025 L-Glutamate
+LysW-L-glutamate kinase [EC:2.7.2.-] [RN:R10930] K05828 M00763 Ornithine biosynthesis, mediated by LysW, glutamate => ornithine 1,0 C20949 LysW-L-glutamyl 5-phosphate C20948 LysW-L-glutamate
+LysW-L-glutamyl-5-phosphate reductase [EC:1.2.1.-] [RN:R10931] K05829 M00763 Ornithine biosynthesis, mediated by LysW, glutamate => ornithine 2,0 C20950 LysW-L-glutamate 5-semialdehyde C20949 LysW-L-glutamyl 5-phosphate
+LysW-L-ornithine aminotransferase [EC:2.6.1.-] [RN:R10932] K05830 M00763 Ornithine biosynthesis, mediated by LysW, glutamate => ornithine 3,0 C20951 LysW-L-ornithine C20950 LysW-L-glutamate 5-semialdehyde
+LysW-L-ornithine carboxypeptidase [RN:R10933] K05831 M00763 Ornithine biosynthesis, mediated by LysW, glutamate => ornithine 4,0 C00077 L-Ornithine C20951 LysW-L-ornithine
+lasR; LuxR family transcriptional regulator, quorum-sensing transcription factor LasR K18304 M00769 Multidrug resistance, efflux pump MexPQ-OpmE 0,0
+cueR; MerR family transcriptional regulator, copper efflux regulator K19591 M00769 Multidrug resistance, efflux pump MexPQ-OpmE 1,0
+gesA; membrane fusion protein, gold/copper resistance efflux system K19595 M00769 Multidrug resistance, efflux pump MexPQ-OpmE 2,0
+gesB; gold/copper resistance efflux pump K19594 M00769 Multidrug resistance, efflux pump MexPQ-OpmE 2,0
+opmE; outer membrane protein, multidrug efflux system K19593 M00769 Multidrug resistance, efflux pump MexPQ-OpmE 2,0
+tylG; tylactone synthase [RN:R06448] K15988 M00773 Tylosin biosynthesis, methylmalonyl-CoA + malonyl-CoA => tylactone => tylosin 0,0 C12000 Tylactone C02557,C00083 Methylmalonyl-CoA,Malonyl-CoA
+tylMII; tylactone mycaminosyltransferase [EC:2.4.1.316] [RN:R06450] K15989 M00773 Tylosin biosynthesis, methylmalonyl-CoA + malonyl-CoA => tylactone => tylosin 1,0 C12001 5-O-beta-D-Mycaminosyltylactone C12000 Tylactone
+tylMIII; tylactone mycaminosyltransferase auxiliary protein [RN:R06450] K15990 M00773 Tylosin biosynthesis, methylmalonyl-CoA + malonyl-CoA => tylactone => tylosin 1,0 C12001 5-O-beta-D-Mycaminosyltylactone C12000 Tylactone
+tylI; cytochrome P450 TylI [RN:R06449] K15992 M00773 Tylosin biosynthesis, methylmalonyl-CoA + malonyl-CoA => tylactone => tylosin 2,0 C20760 20-Oxo-5-O-beta-mycaminosyltylactone C12001 5-O-beta-D-Mycaminosyltylactone
+tylHI; 20-oxo-5-O-mycaminosyltylactone 23-monooxygenase [EC:1.14.15.34] [RN:R10656] K15991 M00773 Tylosin biosynthesis, methylmalonyl-CoA + malonyl-CoA => tylactone => tylosin 3,0 C12002 5-O-beta-D-Mycaminosyltylonolide C20760 20-Oxo-5-O-beta-mycaminosyltylactone
+tylN; O-mycaminosyltylonolide 6-deoxyallosyltransferase [EC:2.4.1.317] [RN:R06451] K15993 M00773 Tylosin biosynthesis, methylmalonyl-CoA + malonyl-CoA => tylactone => tylosin 4,0 C12003 Demethyllactenocin C12002 5-O-beta-D-Mycaminosyltylonolide
+tylCV; demethyllactenocin mycarosyltransferase [EC:2.4.1.318] [RN:R06452] K15994 M00773 Tylosin biosynthesis, methylmalonyl-CoA + malonyl-CoA => tylactone => tylosin 5,0 C02400 Demethylmacrocin C12003 Demethyllactenocin
+tylE; demethylmacrocin O-methyltransferase [EC:2.1.1.102] [RN:R02859] K15995 M00773 Tylosin biosynthesis, methylmalonyl-CoA + malonyl-CoA => tylactone => tylosin 6,0 C00744 Macrocin C02400 Demethylmacrocin
+tylF; macrocin O-methyltransferase [EC:2.1.1.101] [RN:R02858] K15996 M00773 Tylosin biosynthesis, methylmalonyl-CoA + malonyl-CoA => tylactone => tylosin 7,0 C01457 Tylosin C00744 Macrocin
+eryA; 6-deoxyerythronolide-B synthase [EC:2.3.1.94] [RN:R00918] K10817 M00774 Erythromycin biosynthesis, propanoyl-CoA + methylmalonyl-CoA => deoxyerythronolide B => erythromycin A/B 0,0 C03240 6-Deoxyerythronolide B C00100,C00683 Propanoyl-CoA,(S)-Methylmalonyl-CoA
+eryF; 6-deoxyerythronolide B hydroxylase [EC:1.14.15.35] [RN:R05270] K14366 M00774 Erythromycin biosynthesis, propanoyl-CoA + methylmalonyl-CoA => deoxyerythronolide B => erythromycin A/B 1,0 C06635 Erythronolide B C03240 6-Deoxyerythronolide B
+eryBV; erythronolide mycarosyltransferase [EC:2.4.1.328] [RN:R05530] K14367 M00774 Erythromycin biosynthesis, propanoyl-CoA + methylmalonyl-CoA => deoxyerythronolide B => erythromycin A/B 2,0 C06630 3-O-alpha-Mycarosylerythronolide B C06635 Erythronolide B
+eryCIII; 3-alpha-mycarosylerythronolide B desosaminyl transferase [EC:2.4.1.278] [RN:R05531] K14368 M00774 Erythromycin biosynthesis, propanoyl-CoA + methylmalonyl-CoA => deoxyerythronolide B => erythromycin A/B 3,0 C06633 Erythromycin D C06630 3-O-alpha-Mycarosylerythronolide B
+eryCII; 3-alpha-mycarosylerythronolide B desosaminyl transferase auxiliary protein [RN:R05531] K15997 M00774 Erythromycin biosynthesis, propanoyl-CoA + methylmalonyl-CoA => deoxyerythronolide B => erythromycin A/B 3,0 C06633 Erythromycin D C06630 3-O-alpha-Mycarosylerythronolide B
+eryK; erythromycin 12 hydroxylase [EC:1.14.13.154] [RN:R05522] K14370 M00774 Erythromycin biosynthesis, propanoyl-CoA + methylmalonyl-CoA => deoxyerythronolide B => erythromycin A/B 4,0 C06616 Erythromycin C C06633 Erythromycin D
+eryG; erythromycin 3''-O-methyltransferase [EC:2.1.1.254] [RN:R05520 R05532] K14369 M00774 Erythromycin biosynthesis, propanoyl-CoA + methylmalonyl-CoA => deoxyerythronolide B => erythromycin A/B 5,0 C06653 Erythromycin B C06633 Erythromycin D
+oleA; 8,8a-deoxyoleandolide synthase [RN:R06453] K16007 M00775 Oleandomycin biosynthesis, malonyl-CoA + methylmalonyl-CoA => 8,8a-deoxyoleandolide => oleandomycin 0,0 C11989 8,8a-Deoxyoleandolide C00083,C02557 Malonyl-CoA,Methylmalonyl-CoA
+oleP; cytochrome P450 monooxygenase OleP [RN:R06454] K16008 M00775 Oleandomycin biosynthesis, malonyl-CoA + methylmalonyl-CoA => 8,8a-deoxyoleandolide => oleandomycin 1,0 C11990 Oleandolide C11989 8,8a-Deoxyoleandolide
+oleGII; glycosyltransferase OleGII [RN:R06455] K16009 M00775 Oleandomycin biosynthesis, malonyl-CoA + methylmalonyl-CoA => 8,8a-deoxyoleandolide => oleandomycin 2,0 C11991 L-Olivosyl-oleandolide C11990 Oleandolide
+oleY; L-olivosyl-oleandolide 3-O-methyltransferase [EC:2.1.1.239] [RN:R06456] K13320 M00775 Oleandomycin biosynthesis, malonyl-CoA + methylmalonyl-CoA => 8,8a-deoxyoleandolide => oleandomycin 3,0 C11992 L-Oleandrosyl-oleandolide C11991 L-Olivosyl-oleandolide
+oleGI; desosaminyltransferase OleGI [RN:R06457] K16010 M00775 Oleandomycin biosynthesis, malonyl-CoA + methylmalonyl-CoA => 8,8a-deoxyoleandolide => oleandomycin 4,0 C01946 Oleandomycin C11992 L-Oleandrosyl-oleandolide
+pikAI; narbonolide/10-deoxymethynolide synthase [EC:2.3.1.240 2.3.1.239] [RN:R06459 R06458] K16000 M00776 Pikromycin/methymycin biosynthesis, methylmalonyl-CoA + malonyl-CoA => narbonolide/10-deoxymethynolide => pikromycin/methymycin 0,0 C11993 10-Deoxymethynolide C00683,C00083 (S)-Methylmalonyl-CoA,Malonyl-CoA
+pikAII; narbonolide/10-deoxymethynolide synthase [EC:2.3.1.240 2.3.1.239] [RN:R06459 R06458] K16001 M00776 Pikromycin/methymycin biosynthesis, methylmalonyl-CoA + malonyl-CoA => narbonolide/10-deoxymethynolide => pikromycin/methymycin 0,0 C11993 10-Deoxymethynolide C00683,C00083 (S)-Methylmalonyl-CoA,Malonyl-CoA
+pikAIII; narbonolide/10-deoxymethynolide synthase [EC:2.3.1.240 2.3.1.239] [RN:R06459 R06458] K16002 M00776 Pikromycin/methymycin biosynthesis, methylmalonyl-CoA + malonyl-CoA => narbonolide/10-deoxymethynolide => pikromycin/methymycin 0,0 C11993 10-Deoxymethynolide C00683,C00083 (S)-Methylmalonyl-CoA,Malonyl-CoA
+pikAIV; narbonolide synthase [EC:2.3.1.240] [RN:R06459] K16003 M00776 Pikromycin/methymycin biosynthesis, methylmalonyl-CoA + malonyl-CoA => narbonolide/10-deoxymethynolide => pikromycin/methymycin 0,0 C11997 Narbonolide C00683,C00083 (S)-Methylmalonyl-CoA,Malonyl-CoA
+desVII; narbonolide/10-deoxymethynolide desosaminyltransferase [EC:2.4.1.277] [RN:R06461 R06460] K16004 M00776 Pikromycin/methymycin biosynthesis, methylmalonyl-CoA + malonyl-CoA => narbonolide/10-deoxymethynolide => pikromycin/methymycin 1,0 C11994 10-Deoxymethymycin C11993 10-Deoxymethynolide
+desVIII; narbonolide/10-deoxymethynolide desosaminyltransferase auxiliary protein [RN:R06461 R06460] K16005 M00776 Pikromycin/methymycin biosynthesis, methylmalonyl-CoA + malonyl-CoA => narbonolide/10-deoxymethynolide => pikromycin/methymycin 2,0 C11994 10-Deoxymethymycin C11993 10-Deoxymethynolide
+pikC; pikromycin synthase [EC:1.14.15.33] [RN:R06464 R06463] K16006 M00776 Pikromycin/methymycin biosynthesis, methylmalonyl-CoA + malonyl-CoA => narbonolide/10-deoxymethynolide => pikromycin/methymycin 3,0 C11996 Methymycin C11994 10-Deoxymethymycin
+aveA; type I polyketide synthase AVES [RN:R06481 R06483] K14371 M00777 Avermectin biosynthesis, 2-methylbutanoyl-CoA/isobutyryl-CoA => 6,8a-Seco-6,8a-deoxy-5-oxoavermectin 1a/1b aglycone => avermectin A1a/B1a/A1b/B1b 0,0 C11961 6,8a-Seco-6,8a-deoxy-5-oxoavermectin ''1b'' aglycone C00630 2-Methylpropanoyl-CoA
+aveE; cytochrome P450 hydroxylase [EC:1.14.-.-] [RN:R06467 R06470] K14372 M00777 Avermectin biosynthesis, 2-methylbutanoyl-CoA/isobutyryl-CoA => 6,8a-Seco-6,8a-deoxy-5-oxoavermectin 1a/1b aglycone => avermectin A1a/B1a/A1b/B1b 1,0 C11962 5-Oxoavermectin ''1b'' aglycone C11961 6,8a-Seco-6,8a-deoxy-5-oxoavermectin ''1b'' aglycone
+aveF; C-5 ketoreductase [RN:R06473 R06475] K14373 M00777 Avermectin biosynthesis, 2-methylbutanoyl-CoA/isobutyryl-CoA => 6,8a-Seco-6,8a-deoxy-5-oxoavermectin 1a/1b aglycone => avermectin A1a/B1a/A1b/B1b 2,0 C11963 Avermectin B1b aglycone C11962 5-Oxoavermectin ''1b'' aglycone
+aveD; avermectin B 5-O-methyltransferase [EC:2.1.1.-] [RN:R06477 R06479] K14374 M00777 Avermectin biosynthesis, 2-methylbutanoyl-CoA/isobutyryl-CoA => 6,8a-Seco-6,8a-deoxy-5-oxoavermectin 1a/1b aglycone => avermectin A1a/B1a/A1b/B1b 3,0 C11964 Avermectin A1b aglycone C11963 Avermectin B1b aglycone
+aveBI; dTDP-L-oleandrosyltransferase [EC:2.4.1.-] [RN:R06490 R06491 R06488 R06489 R06498 R06499 R06496 R06497] K14375 M00777 Avermectin biosynthesis, 2-methylbutanoyl-CoA/isobutyryl-CoA => 6,8a-Seco-6,8a-deoxy-5-oxoavermectin 1a/1b aglycone => avermectin A1a/B1a/A1b/B1b 4,0 C11967 Avermectin B1b C11965 Avermectin B1b monosaccharide
+actI1, oxyA, tcmK, snoa1, mtmP; minimal PKS ketosynthase (KS/KS alpha) [EC:2.3.1.- 2.3.1.260 2.3.1.235] [RN:R09258 R09259 R11516 R06643] K05551 M00778 Type II polyketide backbone biosynthesis, acyl-CoA + malonyl-CoA => polyketide 0,0 C12354 3,5,7,9,11,13,15,17,19-Nonaoxo-eicosanoyl-[acp] C00083 Malonyl-CoA
+actI2, oxyB, tcmL, snoa2, mtmK; minimal PKS chain-length factor (CLF/KS beta) [EC:2.3.1.- 2.3.1.260 2.3.1.235] [RN:R09258 R09259 R11516 R06643] K05552 M00778 Type II polyketide backbone biosynthesis, acyl-CoA + malonyl-CoA => polyketide 0,0 C12354 3,5,7,9,11,13,15,17,19-Nonaoxo-eicosanoyl-[acp] C00083 Malonyl-CoA
+actI3, oxyC, tcmM, snoa3, mtmS; minimal PKS acyl carrier protein [RN:R09258 R09259 R11516 R06643] K05553 M00778 Type II polyketide backbone biosynthesis, acyl-CoA + malonyl-CoA => polyketide 0,0 C12354 3,5,7,9,11,13,15,17,19-Nonaoxo-eicosanoyl-[acp] C00083 Malonyl-CoA
+actIII, oxyJ, snoaD; ketoreductase [EC:1.1.1.-] [RN:R09262 R06642 R09263] K12420 M00778 Type II polyketide backbone biosynthesis, acyl-CoA + malonyl-CoA => polyketide 1,0 C18331 7,9,12-Decaketide intermediate 2 C18330 7,9,12-Decaketide intermediate 1
+actVII; aromatase [EC:4.2.1.-] [RN:R09265] K05554 M00778 Type II polyketide backbone biosynthesis, acyl-CoA + malonyl-CoA => polyketide 2,0,0,0 C18329 7,9,12-Octaketide intermediate 3 C18328 7,9,12-Octaketide intermediate 2
+oxyK; bifunctional cyclase/aromatase [EC:4.2.1.-] [RN:R09187] K14249 M00778 Type II polyketide backbone biosynthesis, acyl-CoA + malonyl-CoA => polyketide 2,0,0,1 C18293 Nonaketamide monocyclic intermediate C12442 C-9 Reduced nonaketamide
+snoaE; bifunctional aromatase (cyclase/dehydratase) [EC:4.2.1.-] [RN:R09266] K15884 M00778 Type II polyketide backbone biosynthesis, acyl-CoA + malonyl-CoA => polyketide 2,0,0,2 C18332 7,9,12-Decaketide intermediate 3 C18331 7,9,12-Decaketide intermediate 2
+mtmQ; C7-C12 aromatase (ARO/CYC) [EC:4.2.1.-] [RN:R09268] K15885 M00778 Type II polyketide backbone biosynthesis, acyl-CoA + malonyl-CoA => polyketide 2,0,0,3 C18336 7,12-Decaketide intermediate 1 C12354 3,5,7,9,11,13,15,17,19-Nonaoxo-eicosanoyl-[acp]
+actIV; cyclase [EC:4.-.-.-] [RN:R09305] K05555 M00778 Type II polyketide backbone biosynthesis, acyl-CoA + malonyl-CoA => polyketide 2,0,1,0 C18353 Octaketide bicyclic intermediate C18329 7,9,12-Octaketide intermediate 3
+oxyN, snoaM, mtmY; cyclase [RN:R09188 R09325 R09350] K14250 M00778 Type II polyketide backbone biosynthesis, acyl-CoA + malonyl-CoA => polyketide 2,0,1,1 C18709 Decaketide tricyclic intermediate C18336 7,12-Decaketide intermediate 1
+tcmN; multifunctional cyclase / dehydratase / O-methyltransferase [EC:2.3.1.235] [RN:R09269 R09355] K15886 M00778 Type II polyketide backbone biosynthesis, acyl-CoA + malonyl-CoA => polyketide 2,1 C18337 9,14-Decaketide intermediate 1 C12354 3,5,7,9,11,13,15,17,19-Nonaoxo-eicosanoyl-[acp]
+actVI1; ketoreductase RED1 [EC:1.1.1.-] [RN:R09306 R09307 R09308] K05556 M00779 Dihydrokalafungin biosynthesis, octaketide => dihydrokalafungin 0,0 C12434 (S)-DNPA C18356 (S)-Hemiketal
+actVIA; actinorhodin biosynthesis protein ActVIA [RN:R09308] K14626 M00779 Dihydrokalafungin biosynthesis, octaketide => dihydrokalafungin 1,0 C12434 (S)-DNPA C18356 (S)-Hemiketal
+actVI3; dehydratase [EC:4.2.1.-] [RN:R09308] K14627 M00779 Dihydrokalafungin biosynthesis, octaketide => dihydrokalafungin 1,1 C12434 (S)-DNPA C18356 (S)-Hemiketal
+actVI2; enoyl reductase [RN:R06695] K14628 M00779 Dihydrokalafungin biosynthesis, octaketide => dihydrokalafungin 2,0 C12435 6-Deoxydihydrokalafungin C12434 (S)-DNPA
+actVI4; enoyl reductase [RN:R06695] K14629 M00779 Dihydrokalafungin biosynthesis, octaketide => dihydrokalafungin 2,1 C12435 6-Deoxydihydrokalafungin C12434 (S)-DNPA
+actVA5; two-component flavin-dependent monooxygenase [EC:1.14.14.-] [RN:R09314] K14630 M00779 Dihydrokalafungin biosynthesis, octaketide => dihydrokalafungin 3,0 C12436 Dihydrokalafungin C12435 6-Deoxydihydrokalafungin
+actVB; flavin reductase ActVB [EC:1.5.1.-] [RN:R05705] K14631 M00779 Dihydrokalafungin biosynthesis, octaketide => dihydrokalafungin 3,0 C12436 Dihydrokalafungin C12435 6-Deoxydihydrokalafungin
+actVA6; C-6 monooxygenase [RN:R06696] K14632 M00779 Dihydrokalafungin biosynthesis, octaketide => dihydrokalafungin 3,1 C12436 Dihydrokalafungin C12435 6-Deoxydihydrokalafungin
+oxyF; C-methyltransferase [EC:2.1.1.-] [RN:R09189] K14251 M00780 Tetracycline/oxytetracycline biosynthesis, pretetramide => tetracycline/oxytetracycline 0,0 C06629 6-Methylpretetramide C18295 Pretetramid
+oxyL; 6-methylpretetramide 4-monooxygenase / 4-hydroxy-6-methylpretetramide 12a-monooxygenase [EC:1.14.13.232 1.14.13.233] [RN:R09190 R05462] K14252 M00780 Tetracycline/oxytetracycline biosynthesis, pretetramide => tetracycline/oxytetracycline 1,0 C06627 4-Keto-anhydrotetracycline C06628 4-Hydroxy-6-methylpretetramide
+oxyE; 6-methylpretetramide 4-monooxygenase [EC:1.14.13.232] [RN:R05463] K14253 M00780 Tetracycline/oxytetracycline biosynthesis, pretetramide => tetracycline/oxytetracycline 2,0 C06628 4-Hydroxy-6-methylpretetramide C06629 6-Methylpretetramide
+oxyQ; aminotransferase [RN:R09197] K14254 M00780 Tetracycline/oxytetracycline biosynthesis, pretetramide => tetracycline/oxytetracycline 3,0 C06654 4-Amino-anhydrotetracycline C06627 4-Keto-anhydrotetracycline
+oxyT, ctcO, cts6; 4-amino-anhydrotetracycline N4-methyltransferase [EC:2.1.1.335] [RN:R09191] K14255 M00780 Tetracycline/oxytetracycline biosynthesis, pretetramide => tetracycline/oxytetracycline 4,0 C02811 Anhydrotetracycline C06654 4-Amino-anhydrotetracycline
+oxyS, cts8; anhydrotetracycline 6-monooxygenase / 5a,11a-dehydrotetracycline 5-monooxygenase [EC:1.14.13.38 1.14.13.234] [RN:R04060 R09198] K14256 M00780 Tetracycline/oxytetracycline biosynthesis, pretetramide => tetracycline/oxytetracycline 5,0 C18296 5a,11a-Dehydrooxytetracycline C03206 5a,11a-Dehydrotetracycline
+oxyR; 5a,11a-dehydrotetracycline reductase [EC:1.3.98.4] [RN:R09192 R05459] K21301 M00780 Tetracycline/oxytetracycline biosynthesis, pretetramide => tetracycline/oxytetracycline 6,0 C06570 Tetracycline C03206 5a,11a-Dehydrotetracycline
+snoaB, dnrG; deoxynogalonate / 12-deoxyaklanonic acid monooxygenase [EC:1.13.12.22 1.13.12.-] [RN:R09327 R06679] K15941 M00781 Nogalavinone/aklavinone biosynthesis, deoxynogalonate/deoxyaklanonate => nogalavinone/aklavinone 0,0 C12421 Aklanonate C12420 12-Deoxyaklanonic acid
+snoaC, dnrC; O-methyltransferase / aklanonic acid methyltransferase [EC:2.1.1.- 2.1.1.288] [RN:R06675 R06680] K15942 M00781 Nogalavinone/aklavinone biosynthesis, deoxynogalonate/deoxyaklanonate => nogalavinone/aklavinone 1,0 C12422 Methyl aklanonate C12421 Aklanonate
+snoaL, dnrD; nogalonic acid methyl ester cyclase / aklanonic acid methyl ester cyclase [EC:5.5.1.26 5.5.1.23] [RN:R09328 R06681] K15943 M00781 Nogalavinone/aklavinone biosynthesis, deoxynogalonate/deoxyaklanonate => nogalavinone/aklavinone 2,0 C12423 Aklaviketone C12422 Methyl aklanonate
+snoaF, dnrE; nogalaviketone/aklaviketone reductase [EC:1.1.1.- 1.1.1.362] [RN:R09329 R06682] K15944 M00781 Nogalavinone/aklavinone biosynthesis, deoxynogalonate/deoxyaklanonate => nogalavinone/aklavinone 3,0 C12424 Aklavinone C12423 Aklaviketone
+mtmMI; O-methyltransferase [EC:2.1.1.-] [RN:R06715] K15959 M00782 Mithramycin biosynthesis, 4-demethylpremithramycinone => mithramycin 0,0 C12383 Premithramycinone C12382 4-Demethylpremithramycinone
+mtmGIV; glycosyltransferase [EC:2.4.1.-] [RN:R06716 R06718] K15960 M00782 Mithramycin biosynthesis, 4-demethylpremithramycinone => mithramycin 1,0 C12386 Premithramycin A3' C12385 Premithramycin A2'
+mtmGIII; glycosyltransferase [EC:2.4.1.-] [RN:R06717] K15961 M00782 Mithramycin biosynthesis, 4-demethylpremithramycinone => mithramycin 2,0 C12385 Premithramycin A2' C12384 Premithramycin A1
+mtmMII; C-methyltransferase [EC:2.1.1.-] [RN:R06719] K15963 M00782 Mithramycin biosynthesis, 4-demethylpremithramycinone => mithramycin 3,0 C12387 Premithramycin A3 C12386 Premithramycin A3'
+mtmGI; glycosyltransferase [EC:2.4.1.-] [RN:R09351] K15964 M00782 Mithramycin biosynthesis, 4-demethylpremithramycinone => mithramycin 4,0 C18710 3A-Deolivosylpremithramycin B C12387 Premithramycin A3
+mtmGII; glycosyltransferase [EC:2.4.1.-] [RN:R09352] K15965 M00782 Mithramycin biosynthesis, 4-demethylpremithramycinone => mithramycin 5,0 C12388 Premithramycin B C18710 3A-Deolivosylpremithramycin B
+mtmOIV; monooxygenase [EC:1.14.13.-] [RN:R09353] K15966 M00782 Mithramycin biosynthesis, 4-demethylpremithramycinone => mithramycin 6,0 C18711 Mithramycin DK C12388 Premithramycin B
+mtmW; ketoreductase [RN:R09354] K15967 M00782 Mithramycin biosynthesis, 4-demethylpremithramycinone => mithramycin 7,0 C12389 Mithramycin C18711 Mithramycin DK
+tcmI; tetracenomycin F2 cyclase [EC:4.2.1.154] [RN:R06699] K15968 M00783 Tetracenomycin C/8-demethyltetracenomycin C biosynthesis, tetracenomycin F2 => tetracenomycin C/8-demethyltetracenomycin C 0,0 C12367 Tetracenomycin F1 C12366 Tetracenomycin F2
+tcmH; tetracenomycin F1 monooxygenase [EC:1.13.12.21] [RN:R06700] K15969 M00783 Tetracenomycin C/8-demethyltetracenomycin C biosynthesis, tetracenomycin F2 => tetracenomycin C/8-demethyltetracenomycin C 1,0 C12368 Tetracenomycin D3 C12367 Tetracenomycin F1
+tcmN; multifunctional cyclase / dehydratase / O-methyltransferase [EC:2.3.1.235] [RN:R06701] K15886 M00783 Tetracenomycin C/8-demethyltetracenomycin C biosynthesis, tetracenomycin F2 => tetracenomycin C/8-demethyltetracenomycin C 2,0 C12369 Tetracenomycin B3 C12368 Tetracenomycin D3
+tcmO; 8-O-methyltransferase [RN:R06702] K15970 M00783 Tetracenomycin C/8-demethyltetracenomycin C biosynthesis, tetracenomycin F2 => tetracenomycin C/8-demethyltetracenomycin C 3,0 C12370 Tetracenomycin E C12369 Tetracenomycin B3
+tcmP; O-methyltransferase [EC:2.1.1.-] [RN:R06703 R06713] K15971 M00783 Tetracenomycin C/8-demethyltetracenomycin C biosynthesis, tetracenomycin F2 => tetracenomycin C/8-demethyltetracenomycin C 4,0 C12378 Tetracenomycin B2 C12369 Tetracenomycin B3
+tcmG; tetracenomycin A2 monooxygenase-dioxygenase [EC:1.14.13.200] [RN:R06704 R10954] K15972 M00783 Tetracenomycin C/8-demethyltetracenomycin C biosynthesis, tetracenomycin F2 => tetracenomycin C/8-demethyltetracenomycin C 5,0 C12379 8-Demethyltetracenomycin C C12378 Tetracenomycin B2
+elmGT; 8-demethyltetracenomycin C L-rhamnosyltransferase [EC:2.4.1.331] [RN:R10955] K19566 M00784 Elloramycin biosynthesis, 8-demethyltetracenomycin C => elloramycin A 0,0 C20974 8-Demethyl-8-alpha-L-rhamnosyltetracenomycin C C12379 8-Demethyltetracenomycin C
+elmMI; 8-demethyl-8-alpha-L-rhamnosyltetracenomycin-C 2'-O-methyltransferase [EC:2.1.1.305] [RN:R10956] K19567 M00784 Elloramycin biosynthesis, 8-demethyltetracenomycin C => elloramycin A 1,0 C20975 8-Demethyl-8-(2-O-methyl-alpha-L-rhamnosyl)tetracenomycin C C20974 8-Demethyl-8-alpha-L-rhamnosyltetracenomycin C
+elmMII; 8-demethyl-8-(2-methoxy-alpha-L-rhamnosyl)tetracenomycin-C 3'-O-methyltransferase [EC:2.1.1.306] [RN:R10957] K19568 M00784 Elloramycin biosynthesis, 8-demethyltetracenomycin C => elloramycin A 2,0 C20976 8-Demethyl-8-(2,3-di-O-methyl-alpha-L-rhamnosyl)tetracenomycin C C20975 8-Demethyl-8-(2-O-methyl-alpha-L-rhamnosyl)tetracenomycin C
+elmMIII; 8-demethyl-8-(2,3-dimethoxy-alpha-L-rhamnosyl)tetracenomycin-C 4'-O-methyltransferase [EC:2.1.1.307] [RN:R10958] K19569 M00784 Elloramycin biosynthesis, 8-demethyltetracenomycin C => elloramycin A 3,0 C20977 8-Demethyl-8-(2,3,4-tri-O-methyl-alpha-L-rhamnosyl)tetracenomycin C C20976 8-Demethyl-8-(2,3-di-O-methyl-alpha-L-rhamnosyl)tetracenomycin C
+elmD; 8-demethyl-8-(2,3,4-trimethoxy-alpha-L-rhamnosyl)tetracenomycin-C O-methyltransferase [EC:2.1.1.-] [RN:R10959] K19570 M00784 Elloramycin biosynthesis, 8-demethyltetracenomycin C => elloramycin A 4,0 C12381 Elloramycin A C20977 8-Demethyl-8-(2,3,4-tri-O-methyl-alpha-L-rhamnosyl)tetracenomycin C
+dcsE; serine/homoserine O-acetyltransferase [EC:2.3.1.30 2.3.1.31] [RN:R00586] K19726 M00785 Cycloserine biosynthesis, arginine/serine => cycloserine 0,0 C00979 O-Acetyl-L-serine C00065 L-Serine
+dcsD; O-ureido-L-serine/cysteine synthase [EC:2.6.99.3 2.5.1.47] [RN:R10461] K19725 M00785 Cycloserine biosynthesis, arginine/serine => cycloserine 1,0 C20639 O-Ureido-L-serine C00979,C07044 O-Acetyl-L-serine,Hydroxyurea
+dcsC; O-ureido-serine racemase [EC:5.1.1.19] [RN:R10488] K19724 M00785 Cycloserine biosynthesis, arginine/serine => cycloserine 2,0 C20651 O-Ureido-D-serine C20639 O-Ureido-L-serine
+dcsG; O-ureido-D-serine cyclo-ligase [EC:6.3.3.5] [RN:R10470] K19727 M00785 Cycloserine biosynthesis, arginine/serine => cycloserine 3,0 C08057 Cycloserine C20651 O-Ureido-D-serine
+FTMA; brevianamide F synthase [RN:R10661] K18281 M00786 Fumitremorgin alkaloid biosynthesis, tryptophan + proline => fumitremorgin C/A 0,0 C20563 Brevianamide F C00078,C00148 L-Tryptophan,L-Proline
+FTMPT1; tryprostatin B synthase [EC:2.5.1.106] [RN:R10340] K14132 M00786 Fumitremorgin alkaloid biosynthesis, tryptophan + proline => fumitremorgin C/A 1,0 C20512 Tryprostatin B C20563 Brevianamide F
+FTMC; tryprostatin B 6-hydroxylase [EC:1.14.14.118] [RN:R10321] K17475 M00786 Fumitremorgin alkaloid biosynthesis, tryptophan + proline => fumitremorgin C/A 2,0 C20513 6-Hydroxytryprostatin B C20512 Tryprostatin B
+FTMD; 6-hydroxytryprostatin B O-methyltransferase [EC:2.1.1.293] [RN:R10588] K18280 M00786 Fumitremorgin alkaloid biosynthesis, tryptophan + proline => fumitremorgin C/A 3,0 C20607 Tryprostatin A C20513 6-Hydroxytryprostatin B
+FTME; fumitremorgin C synthase [EC:1.14.19.71] [RN:R10416] K17827 M00786 Fumitremorgin alkaloid biosynthesis, tryptophan + proline => fumitremorgin C/A 4,0 C20604 Fumitremorgin C C20607 Tryprostatin A
+FTMG; fumitremorgin C monooxygenase [EC:1.14.14.119] [RN:R10414] K17826 M00786 Fumitremorgin alkaloid biosynthesis, tryptophan + proline => fumitremorgin C/A 5,0 C20605 12alpha,13alpha-Dihydroxyfumitremorgin C C20604 Fumitremorgin C
+FTMPT2; 12alpha,13alpha-dihydroxyfumitremorgin C prenyltransferase [EC:2.5.1.110] [RN:R10457] K14134 M00786 Fumitremorgin alkaloid biosynthesis, tryptophan + proline => fumitremorgin C/A 6,0 C20630 Fumitremorgin B C20605 12alpha,13alpha-Dihydroxyfumitremorgin C
+FTMF; verruculogen synthase [EC:1.14.11.38] [RN:R10445] K17825 M00786 Fumitremorgin alkaloid biosynthesis, tryptophan + proline => fumitremorgin C/A 7,0 C20045 Verruculogen C20630 Fumitremorgin B
+FTMPT3; verruculogen prenyltransferase [EC:2.5.1.107] [RN:R10341] K18279 M00786 Fumitremorgin alkaloid biosynthesis, tryptophan + proline => fumitremorgin C/A 8,0 C20564 Fumitremorgin A C20045 Verruculogen
+bacA; bacA; prephenate decarboxylase [EC:4.1.1.100] [RN:R10934] K19546 M00787 Bacilysin biosynthesis, prephenate => bacilysin 0,0 C20953 3-[(4R)-4-Hydroxycyclohexa-1,5-dien-1-yl]-2-oxopropanoate C00254 Prephenate
+bacB; 3-[(4R)-4-hydroxycyclohexa-1,5-dien-1-yl]-2-oxopropanoate isomerase [EC:5.3.3.19] [RN:R11065] K19547 M00787 Bacilysin biosynthesis, prephenate => bacilysin 1,0 C21085 3-[(1E,4R)-4-Hydroxycyclohex-2-en-1-ylidene]-2-oxopropanoate C20953 3-[(4R)-4-Hydroxycyclohexa-1,5-dien-1-yl]-2-oxopropanoate
+bacG; bacilysin biosynthesis oxidoreductase BacG [EC:1.3.1.-] [RN:R11067] K19550 M00787 Bacilysin biosynthesis, prephenate => bacilysin 2,0 C21087 Epoxy-4S-H4HPP C21086 Epoxy-3E-H2HPP
+bacF; bacilysin biosynthesis transaminase BacF [EC:2.6.1.-] [RN:R11068] K19549 M00787 Bacilysin biosynthesis, prephenate => bacilysin 3,0 C20940 L-Dihydroanticapsin C21087 Epoxy-4S-H4HPP
+bacC; dihydroanticapsin dehydrogenase [EC:1.1.1.385] [RN:R10917] K19548 M00787 Bacilysin biosynthesis, prephenate => bacilysin 4,0 C20941 L-Anticapsin C20940 L-Dihydroanticapsin
+bacD; L-alanine-L-anticapsin ligase [EC:6.3.2.49] [RN:R11064] K13037 M00787 Bacilysin biosynthesis, prephenate => bacilysin 5,0 C20942 Bacilysin C20941 L-Anticapsin
+cyc1; terpentedienyl-diphosphate synthase [EC:5.5.1.15] [RN:R09714] K19835 M00788 Terpentecin biosynthesis, GGAP => terpentecin 0,0 C19815 Terpentedienyl diphosphate C00353 Geranylgeranyl diphosphate
+cyc2; terpentetriene synthase [EC:4.2.3.36] [RN:R09684] K19834 M00788 Terpentecin biosynthesis, GGAP => terpentecin 1,0 C19814 Terpentetriene C19815 Terpentedienyl diphosphate
+rebH; tryptophan halogenase [EC:1.14.19.9] [RN:R09570] K14266 M00789 Rebeccamycin biosynthesis, tryptophan => rebeccamycin 0,0 C19687 7-Chloro-L-tryptophan C00078 L-Tryptophan
+rebO; 7-chloro-L-tryptophan oxidase [EC:1.4.3.23] [RN:R09560] K19884 M00789 Rebeccamycin biosynthesis, tryptophan => rebeccamycin 1,0 C19688 2-Imino-3-(7-chloroindol-3-yl)propanoate C19687 7-Chloro-L-tryptophan
+rebD; dichlorochromopyrrolate synthase / catalase [EC:1.21.98.2 1.11.1.6] [RN:R09566] K19885 M00789 Rebeccamycin biosynthesis, tryptophan => rebeccamycin 2,0 C19698 3,4-Bis(7-chloroindol-3-yl)pyrrole-2,5-dicarboxylate C19688 2-Imino-3-(7-chloroindol-3-yl)propanoate
+rebC; flavin-dependent monooxygenase RebC [EC:1.13.12.17] [RN:R09567] K19886 M00789 Rebeccamycin biosynthesis, tryptophan => rebeccamycin 3,0 C19699 Dichloroarcyriaflavin A C19698 3,4-Bis(7-chloroindol-3-yl)pyrrole-2,5-dicarboxylate
+rebP; cytochrome P450 RebP [EC:1.13.12.17] [RN:R09567] K19887 M00789 Rebeccamycin biosynthesis, tryptophan => rebeccamycin 3,0 C19699 Dichloroarcyriaflavin A C19698 3,4-Bis(7-chloroindol-3-yl)pyrrole-2,5-dicarboxylate
+rebG; 4'-demethylrebeccamycin synthase [EC:4.3.3.5] [RN:R09568] K19888 M00789 Rebeccamycin biosynthesis, tryptophan => rebeccamycin 4,0 C19700 4'-O-Demethylrebeccamycin C19699 Dichloroarcyriaflavin A
+rebM; demethylrebeccamycin-D-glucose O-methyltransferase [EC:2.1.1.164] [RN:R09569] K19889 M00789 Rebeccamycin biosynthesis, tryptophan => rebeccamycin 5,0 C19701 Rebeccamycin C19700 4'-O-Demethylrebeccamycin
+prnA; tryptophan halogenase [EC:1.14.19.9] [RN:R09570] K14266 M00790 Pyrrolnitrin biosynthesis, tryptophan => pyrrolnitrin 0,0 C19687 7-Chloro-L-tryptophan C00078 L-Tryptophan
+prnB; monodechloroaminopyrrolnitrin synthase [RN:R11105] K19981 M00790 Pyrrolnitrin biosynthesis, tryptophan => pyrrolnitrin 1,0 C21110 Monodechloroaminopyrrolnitrin C19687 7-Chloro-L-tryptophan
+prnC; FADH2 O2-dependent halogenase [EC:1.14.19.-] [RN:R11106] K14257 M00790 Pyrrolnitrin biosynthesis, tryptophan => pyrrolnitrin 2,0 C21109 Aminopyrrolnitrin C21110 Monodechloroaminopyrrolnitrin
+prnD; aminopyrrolnitrin oxygenase [EC:1.14.13.-] [RN:R11107] K19982 M00790 Pyrrolnitrin biosynthesis, tryptophan => pyrrolnitrin 3,0 C12491 Pyrrolnitrin C21109 Aminopyrrolnitrin
+glucose-1-phosphate thymidylyltransferase [EC:2.7.7.24] [RN:R02328] K00973 M00793 dTDP-L-rhamnose biosynthesis 0,0 C00842 dTDP-glucose C00103 D-Glucose 1-phosphate
+dTDP-glucose 4,6-dehydratase [EC:4.2.1.46] [RN:R06513] K01710 M00793 dTDP-L-rhamnose biosynthesis 1,0 C11907 dTDP-4-oxo-6-deoxy-D-glucose C00842 dTDP-glucose
+dTDP-4-dehydrorhamnose 3,5-epimerase [EC:5.1.3.13] [RN:R06514] K01790 M00793 dTDP-L-rhamnose biosynthesis 2,0 C00688 dTDP-4-dehydro-beta-L-rhamnose C11907 dTDP-4-oxo-6-deoxy-D-glucose
+dTDP-4-dehydrorhamnose reductase [EC:1.1.1.133] [RN:R02777] K00067 M00793 dTDP-L-rhamnose biosynthesis 3,0 C03319 dTDP-L-rhamnose C00688 dTDP-4-dehydro-beta-L-rhamnose
+tylJ; dTDP-4-dehydro-6-deoxy-D-glucose 3-epimerase [EC:5.1.3.27] [RN:R06437] K13312 M00794 dTDP-6-deoxy-D-allose biosynthesis 0,0 C11926 dTDP-4-oxo-6-deoxy-D-allose C11907 dTDP-4-oxo-6-deoxy-D-glucose
+tylD; dTDP-4-dehydro-6-deoxy-alpha-D-gulose 4-ketoreductase [EC:1.1.1.364] [RN:R06438,R10573] K13313 M00794 dTDP-6-deoxy-D-allose biosynthesis 1,0
+novW; dTDP-4-dehydro-6-deoxy-D-glucose 3-epimerase [EC:5.1.3.27] [RN:R06437] K19855 M00795 dTDP-beta-L-noviose biosynthesis 0,0 C11926 dTDP-4-oxo-6-deoxy-D-allose C11907 dTDP-4-oxo-6-deoxy-D-glucose
+novU; C-methyltransferase [EC:2.1.1.-] [RN:R11020] K12710 M00795 dTDP-beta-L-noviose biosynthesis 1,0 C11460 dTDP-4-oxo-5-C-methyl-L-rhamnose C11926 dTDP-4-oxo-6-deoxy-D-allose
+novS; dTDP-4-keto-6-deoxyhexose reductase [EC:1.1.1.-] [RN:R10459] K17625 M00795 dTDP-beta-L-noviose biosynthesis 2,0 C12481 dTDP-5-dimethyl-L-lyxose C11460 dTDP-4-oxo-5-C-methyl-L-rhamnose
+tyl1a; TDP-4-oxo-6-deoxy-alpha-D-glucose-3,4-oxoisomerase [EC:5.3.2.4] [RN:R06424] K19853 M00796 dTDP-D-mycaminose biosynthesis 0,0 C11908 3,6-Dideoxy-3-oxo-dTDP-D-glucose C11907 dTDP-4-oxo-6-deoxy-D-glucose
+tylB; dTDP-3-amino-3,6-dideoxy-alpha-D-glucopyranose transaminase [EC:2.6.1.89] [RN:R06423] K19854 M00796 dTDP-D-mycaminose biosynthesis 1,0 C11925 dTDP-3-amino-3,6-dideoxy-D-glucose C11908 3,6-Dideoxy-3-oxo-dTDP-D-glucose
+tylMI; dTDP-3-amino-3,6-dideoxy-alpha-D-glucopyranose N,N-dimethyltransferase [EC:2.1.1.235] [RN:R06439] K13307 M00796 dTDP-D-mycaminose biosynthesis 2,0 C11933 dTDP-D-mycaminose C11925 dTDP-3-amino-3,6-dideoxy-D-glucose
+desI; dTDP-4-amino-4,6-dideoxy-D-glucose transaminase [EC:2.6.1.33] [RN:R02773] K13308 M00797 dTDP-D-desosamine biosynthesis 0,0 C04268 dTDP-4-amino-4,6-dideoxy-D-glucose C11907 dTDP-4-oxo-6-deoxy-D-glucose
+desII; dTDP-4-amino-4,6-dideoxy-D-glucose ammonia-lyase [EC:4.3.1.30] [RN:R08583] K13309 M00797 dTDP-D-desosamine biosynthesis 1,0 C11909 dTDP-3-oxo-4,6-dideoxy-D-glucose C04268 dTDP-4-amino-4,6-dideoxy-D-glucose
+desV; dTDP-3-amino-3,4,6-trideoxy-alpha-D-glucose transaminase [EC:2.6.1.106] [RN:R06426] K13310 M00797 dTDP-D-desosamine biosynthesis 2,0 C11910 dTDP-3-amino-3,4,6-trideoxy-D-glucose C11909 dTDP-3-oxo-4,6-dideoxy-D-glucose
+megDII; dTDP-3-amino-2,3,6-trideoxy-4-keto-D-glucose/dTDP-3-amino-3,4,6-trideoxy-alpha-D-glucose transaminase [EC:2.6.1.- 2.6.1.106] [RN:R06426] K16436 M00797 dTDP-D-desosamine biosynthesis 2,1 C11910 dTDP-3-amino-3,4,6-trideoxy-D-glucose C11909 dTDP-3-oxo-4,6-dideoxy-D-glucose
+desVI; dTDP-3-amino-3,4,6-trideoxy-alpha-D-glucopyranose N,N-dimethyltransferase [EC:2.1.1.234] [RN:R06427] K13311 M00797 dTDP-D-desosamine biosynthesis 3,0 C11911 dTDP-D-desosamine C11910 dTDP-3-amino-3,4,6-trideoxy-D-glucose
+megDIII; dTDP-3-amino-2,3,6-trideoxy-4-keto-D-glucose/dTDP-3-amino-3,4,6-trideoxy-alpha-D-glucopyranose N,N-dimethyltransferase [EC:2.1.1.- 2.1.1.234] [RN:R06427] K13326 M00797 dTDP-D-desosamine biosynthesis 3,1 C11911 dTDP-D-desosamine C11910 dTDP-3-amino-3,4,6-trideoxy-D-glucose
+eryBVI, tylCVI; dTDP-4-dehydro-6-deoxy-alpha-D-glucopyranose 2,3-dehydratase [EC:4.2.1.159] [RN:R05518] K16435 M00798 dTDP-L-mycarose biosynthesis 0,0 C06620 dTDP-3,4-dioxo-2,6-dideoxy-D-glucose C11907 dTDP-4-oxo-6-deoxy-D-glucose
+eryBII, tylCII; NDP-hexose C3-ketoreductase [EC:1.1.1.-] [RN:R11051] K13315 M00798 dTDP-L-mycarose biosynthesis 1,0 C11928 dTDP-4-oxo-2,6-dideoxy-D-allose C06620 dTDP-3,4-dioxo-2,6-dideoxy-D-glucose
+eryBIII, tylCIII; NDP-4-keto-2,6-dideoxyhexose 3-C-methyltransferase [EC:2.1.1.-] [RN:R08933] K13317 M00798 dTDP-L-mycarose biosynthesis 2,0 C18035 dTDP-3-methyl-4-oxo-2,6-dideoxy-D-glucose C11928 dTDP-4-oxo-2,6-dideoxy-D-allose
+tylCVII; NDP-hexose 5-epimerase [EC:5.1.3.-] [RN:R08934] K13316 M00798 dTDP-L-mycarose biosynthesis 3,0 C11915 dTDP-3-methyl-4-oxo-2,6-dideoxy-L-allose C18035 dTDP-3-methyl-4-oxo-2,6-dideoxy-D-glucose
+eryBVII; 5-epimerase [EC:5.1.3.-] [RN:R08934] K16438 M00798 dTDP-L-mycarose biosynthesis 3,1 C11915 dTDP-3-methyl-4-oxo-2,6-dideoxy-L-allose C18035 dTDP-3-methyl-4-oxo-2,6-dideoxy-D-glucose
+eryBIV, tylCIV; dTDP-4-keto-6-deoxy-L-hexose 4-reductase [EC:1.1.1.-] [RN:R06436] K13318 M00798 dTDP-L-mycarose biosynthesis 4,0 C11916 dTDP-L-mycarose C11915 dTDP-3-methyl-4-oxo-2,6-dideoxy-L-allose
+aveBVI; dTDP-4-dehydro-6-deoxy-alpha-D-glucopyranose 2,3-dehydratase [EC:4.2.1.159] [RN:R05518] K16435 M00799 dTDP-L-oleandrose biosynthesis 0,0 C06620 dTDP-3,4-dioxo-2,6-dideoxy-D-glucose C11907 dTDP-4-oxo-6-deoxy-D-glucose
+aveBVIII; NDP-hexose C3-ketoreductase [EC:1.1.1.-] [RN:R11051] K13315 M00799 dTDP-L-oleandrose biosynthesis 1,0 C11928 dTDP-4-oxo-2,6-dideoxy-D-allose C06620 dTDP-3,4-dioxo-2,6-dideoxy-D-glucose
+aveBV; 5-epimerase [EC:5.1.3.-] [RN:R06433] K16438 M00799 dTDP-L-oleandrose biosynthesis 2,0 C11927 dTDP-4-oxo-2,6-dideoxy-L-mannose C11928 dTDP-4-oxo-2,6-dideoxy-D-allose
+aveBVII; 3-O-methyltransferase [EC:2.1.1.-] [RN:R11041] K19856 M00799 dTDP-L-oleandrose biosynthesis 3,0 C21071 dTDP-3-O-methyl-4-oxo-2,6-dideoxy-L-mannose C11927 dTDP-4-oxo-2,6-dideoxy-L-mannose
+aveBIV; dTDP-4-keto-6-deoxy-L-hexose 4-reductase [RN:R11042] K19857 M00799 dTDP-L-oleandrose biosynthesis 4,0 C11921 dTDP-L-oleandrose C21071 dTDP-3-O-methyl-4-oxo-2,6-dideoxy-L-mannose
+megBVI; dTDP-4-dehydro-6-deoxy-alpha-D-glucopyranose 2,3-dehydratase [EC:4.2.1.159] [RN:R05518] K16435 M00800 dTDP-L-megosamine biosynthesis 0,0 C06620 dTDP-3,4-dioxo-2,6-dideoxy-D-glucose C11907 dTDP-4-oxo-6-deoxy-D-glucose
+megDII; dTDP-3-amino-2,3,6-trideoxy-4-keto-D-glucose/dTDP-3-amino-3,4,6-trideoxy-alpha-D-glucose transaminase [EC:2.6.1.- 2.6.1.106] [RN:R06631] K16436 M00800 dTDP-L-megosamine biosynthesis 1,0 C12318 dTDP-3-amino-2,3,6-trideoxy-4-keto-D-glucose C06620 dTDP-3,4-dioxo-2,6-dideoxy-D-glucose
+megDIII; dTDP-3-amino-2,3,6-trideoxy-4-keto-D-glucose/dTDP-3-amino-3,4,6-trideoxy-alpha-D-glucopyranose N,N-dimethyltransferase [EC:2.1.1.- 2.1.1.234] [RN:R11045] K13326 M00800 dTDP-L-megosamine biosynthesis 2,0 C21073 dTDP-3-N,N-dimethylamino-2,3,6-trideoxy-4-keto-D-glucose C12318 dTDP-3-amino-2,3,6-trideoxy-4-keto-D-glucose
+megDIV; 5-epimerase [EC:5.1.3.-] [RN:R11046] K16438 M00800 dTDP-L-megosamine biosynthesis 3,0 C21074 dTDP-3-N,N-dimethylamino-4-oxo-2,3,6-trideoxy-L-allose C21073 dTDP-3-N,N-dimethylamino-2,3,6-trideoxy-4-keto-D-glucose
+megDV; dTDP-4-keto-6-deoxyhexose 4-ketoreductase [RN:R11047] K13322 M00800 dTDP-L-megosamine biosynthesis 4,0 C11919 dTDP-L-megosamine C21074 dTDP-3-N,N-dimethylamino-4-oxo-2,3,6-trideoxy-L-allose
+oleV; dTDP-4-dehydro-6-deoxy-alpha-D-glucopyranose 2,3-dehydratase [EC:4.2.1.159] [RN:R05518] K16435 M00801 dTDP-L-olivose biosynthesis 0,0 C06620 dTDP-3,4-dioxo-2,6-dideoxy-D-glucose C11907 dTDP-4-oxo-6-deoxy-D-glucose
+oleW; dTDP-3,4-didehydro-2,6-dideoxy-alpha-D-glucose 3-reductase [EC:1.1.1.384] [RN:R05526] K13327 M00801 dTDP-L-olivose biosynthesis 1,0 C11922 dTDP-4-oxo-2,6-dideoxy-D-glucose C06620 dTDP-3,4-dioxo-2,6-dideoxy-D-glucose
+oleL; dTDP-4-oxo-2,6-dideoxy-D-glucose 3,5-epimerase [EC:5.1.3.-] [RN:R08597] K19858 M00801 dTDP-L-olivose biosynthesis 2,0 C11927 dTDP-4-oxo-2,6-dideoxy-L-mannose C11922 dTDP-4-oxo-2,6-dideoxy-D-glucose
+oleU; 4-ketoreductase [RN:R06434] K13319 M00801 dTDP-L-olivose biosynthesis 3,0 C11920 dTDP-L-olivose C11927 dTDP-4-oxo-2,6-dideoxy-L-mannose
+spnO; dTDP-4-dehydro-6-deoxy-alpha-D-glucopyranose 2,3-dehydratase [EC:4.2.1.159] [RN:R05518] K16435 M00802 dTDP-D-forosamine biosynthesis 0,0 C06620 dTDP-3,4-dioxo-2,6-dideoxy-D-glucose C11907 dTDP-4-oxo-6-deoxy-D-glucose
+spnN; dTDP-3,4-didehydro-2,6-dideoxy-alpha-D-glucose 3-reductase [EC:1.1.1.384] [RN:R05526] K13327 M00802 dTDP-D-forosamine biosynthesis 1,0 C11922 dTDP-4-oxo-2,6-dideoxy-D-glucose C06620 dTDP-3,4-dioxo-2,6-dideoxy-D-glucose
+spnQ; dTDP-4-dehydro-2,6-dideoxy-D-glucose 3-dehydratase [EC:4.2.1.164] [RN:R08930] K13328 M00802 dTDP-D-forosamine biosynthesis 2,0 C18032 dTDP-4-oxo-2,3,6-trideoxy-D-glucose C11922 dTDP-4-oxo-2,6-dideoxy-D-glucose
+spnR; dTDP-4-dehydro-2,3,6-trideoxy-D-glucose 4-aminotransferase [EC:2.6.1.110] [RN:R08931] K13329 M00802 dTDP-D-forosamine biosynthesis 3,0 C18033 dTDP-4-amino-2,3,4,6-tetradeoxy-D-glucose C18032 dTDP-4-oxo-2,3,6-trideoxy-D-glucose
+spnS; dTDP-4-amino-2,3,4,6-tetradeoxy-D-glucose N,N-dimethyltransferase [EC:2.1.1.324] [RN:R08932] K13330 M00802 dTDP-D-forosamine biosynthesis 4,0 C18034 dTDP-D-forosamine C18033 dTDP-4-amino-2,3,4,6-tetradeoxy-D-glucose
+ang4; dTDP-4-dehydro-6-deoxy-alpha-D-glucopyranose 2,3-dehydratase [EC:4.2.1.159] [RN:R05518] K16435 M00803 dTDP-D-angolosamine biosynthesis 0,0 C06620 dTDP-3,4-dioxo-2,6-dideoxy-D-glucose C11907 dTDP-4-oxo-6-deoxy-D-glucose
+ang14; dTDP-4-keto-6-deoxyhexose reductase [RN:R08927] K19859 M00803 dTDP-D-angolosamine biosynthesis 1,0 C18029 dTDP-3-oxo-2,6-dideoxy-D-glucose C06620 dTDP-3,4-dioxo-2,6-dideoxy-D-glucose
+angB; dTDP-2,6-dideoxy-D-kanosamine transaminase [RN:R08928] K16436 M00803 dTDP-D-angolosamine biosynthesis 2,0 C18030 dTDP-2,6-dideoxy-D-kanosamine C18029 dTDP-3-oxo-2,6-dideoxy-D-glucose
+angMI; N,N-dimethyltransferase [RN:R08929] K13332 M00803 dTDP-D-angolosamine biosynthesis 3,0 C18031 dTDP-D-angolosamine C18030 dTDP-2,6-dideoxy-D-kanosamine
+ammonia monooxygenase [EC:1.14.99.39] [RN:R00148] K10944 M00804 Complete nitrification, comammox, ammonia => nitrite => nitrate 0,0 C00192 Hydroxylamine C00014 Ammonia
+ammonia monooxygenase [EC:1.14.99.39] [RN:R00148] K10945 M00804 Complete nitrification, comammox, ammonia => nitrite => nitrate 0,0 C00192 Hydroxylamine C00014 Ammonia
+ammonia monooxygenase [EC:1.14.99.39] [RN:R00148] K10946 M00804 Complete nitrification, comammox, ammonia => nitrite => nitrate 0,0 C00192 Hydroxylamine C00014 Ammonia
+hydroxylamine oxidase [EC:1.7.2.6] [RN:R10164] K10535 M00804 Complete nitrification, comammox, ammonia => nitrite => nitrate 1,0 C00088 Nitrite C00192 Hydroxylamine
+nitrite oxidoreductase [EC:1.7.99.4] [RN:R00798] K00370 M00804 Complete nitrification, comammox, ammonia => nitrite => nitrate 2,0 C00244 Nitrate C00088 Nitrite
+nitrite oxidoreductase [EC:1.7.99.4] [RN:R00798] K00371 M00804 Complete nitrification, comammox, ammonia => nitrite => nitrate 2,0 C00244 Nitrate C00088 Nitrite
+staO; tryptophan oxidase StaO [EC:1.4.3.-] [RN:R11119] K20075 M00805 Staurosporine biosynthesis, tryptophan => staurosporine 0,0 C21124 IPA imine C00078 L-Tryptophan
+staD; chromopyrrolic acid synthase [RN:R11120] K20076 M00805 Staurosporine biosynthesis, tryptophan => staurosporine 1,0 C21125 Chromopyrrolate C21124 IPA imine
+staC; flavin-dependent monooxygenase StaC [EC:1.13.12.-] [RN:R11121] K20077 M00805 Staurosporine biosynthesis, tryptophan => staurosporine 2,0 C21126 K-252c C21125 Chromopyrrolate
+staP; cytochrome P450 StaP [EC:1.13.12.-] [RN:R11121] K20078 M00805 Staurosporine biosynthesis, tryptophan => staurosporine 2,0 C21126 K-252c C21125 Chromopyrrolate
+staG; N-glycosyltransferase StaG [EC:2.4.-.-] [RN:R11122] K20079 M00805 Staurosporine biosynthesis, tryptophan => staurosporine 3,0 C21127 Holyrine A C21126 K-252c
+staN; cytochrome P450 StaN [EC:1.14.-.-] [RN:R11123] K20080 M00805 Staurosporine biosynthesis, tryptophan => staurosporine 4,0 C21128 O-Demethyl-N-demethyl-staurosporine C21127 Holyrine A
+staMA; N-methyltransferase StaMA [EC:2.1.1.-] [RN:R11129] K20081 M00805 Staurosporine biosynthesis, tryptophan => staurosporine 5,0 C07349 3'-Demethylstaurosporine C21128 O-Demethyl-N-demethyl-staurosporine
+staMB; O-methyltransferase StaMB [EC:2.1.1.139] [RN:R05757] K20082 M00805 Staurosporine biosynthesis, tryptophan => staurosporine 6,0 C02079 Staurosporine C07349 3'-Demethylstaurosporine
+vioA; tryptophan oxidase VioA [EC:1.4.3.-] [RN:R11119] K20086 M00808 Violacein biosynthesis, tryptophan => violacein 0,0 C21124 IPA imine C00078 L-Tryptophan
+vioB; violacein biosynthesis protein VioB [RN:R11131] K20087 M00808 Violacein biosynthesis, tryptophan => violacein 1,0 C21131 Protodeoxyviolaceinic acid C21124 IPA imine
+vioE; violacein biosynthesis protein VioE [RN:R11131] K20088 M00808 Violacein biosynthesis, tryptophan => violacein 1,0 C21131 Protodeoxyviolaceinic acid C21124 IPA imine
+vioD; flavin-dependent oxygenase VioD [EC:1.14.13.-] [RN:R11134] K20089 M00808 Violacein biosynthesis, tryptophan => violacein 2,0 C21134 Protoviolaceinic acid C21131 Protodeoxyviolaceinic acid
+vioC; flavin-dependent oxygenase VioC [EC:1.14.13.-] [RN:R11135] K20090 M00808 Violacein biosynthesis, tryptophan => violacein 3,0 C21135 Violaceinic acid C21134 Protoviolaceinic acid
+nicotine dehydrogenase [EC:1.5.99.4] [RN:R02860 R07946] K19818 M00810 Nicotine degradation, pyridine pathway, nicotine => 2,6-dihydroxypyridine/succinate semialdehyde 0,0 C03043 (R)-6-Hydroxynicotine C16150 (R,S)-Nicotine
+nicotine dehydrogenase [EC:1.5.99.4] [RN:R02860 R07946] K19819 M00810 Nicotine degradation, pyridine pathway, nicotine => 2,6-dihydroxypyridine/succinate semialdehyde 0,0 C03043 (R)-6-Hydroxynicotine C16150 (R,S)-Nicotine
+nicotine dehydrogenase [EC:1.5.99.4] [RN:R02860 R07946] K19820 M00810 Nicotine degradation, pyridine pathway, nicotine => 2,6-dihydroxypyridine/succinate semialdehyde 0,0 C03043 (R)-6-Hydroxynicotine C16150 (R,S)-Nicotine
+(S)-6-hydroxynicotine oxidase [EC:1.5.3.5] [RN:R11048] K19826 M00810 Nicotine degradation, pyridine pathway, nicotine => 2,6-dihydroxypyridine/succinate semialdehyde 1,0 C21075 5-(N-Methyl-4,5-dihydro-1H-pyrrol-2-yl)pyridin-2-ol C01056 (S)-6-Hydroxynicotine
+(R)-6-hydroxynicotine oxidase [EC:1.5.3.6] [RN:R11050] K19890 M00810 Nicotine degradation, pyridine pathway, nicotine => 2,6-dihydroxypyridine/succinate semialdehyde 1,1 C21075 5-(N-Methyl-4,5-dihydro-1H-pyrrol-2-yl)pyridin-2-ol C03043 (R)-6-Hydroxynicotine
+6-hydroxypseudooxynicotine dehydrogenase [EC:1.5.99.14] [RN:R07514] K19185 M00810 Nicotine degradation, pyridine pathway, nicotine => 2,6-dihydroxypyridine/succinate semialdehyde 2,0 C15986 2,6-Dihydroxypseudooxynicotine C01297 6-Hydroxypseudooxynicotine
+6-hydroxypseudooxynicotine dehydrogenase [EC:1.5.99.14] [RN:R07514] K19186 M00810 Nicotine degradation, pyridine pathway, nicotine => 2,6-dihydroxypyridine/succinate semialdehyde 2,0 C15986 2,6-Dihydroxypseudooxynicotine C01297 6-Hydroxypseudooxynicotine
+6-hydroxypseudooxynicotine dehydrogenase [EC:1.5.99.14] [RN:R07514] K19187 M00810 Nicotine degradation, pyridine pathway, nicotine => 2,6-dihydroxypyridine/succinate semialdehyde 2,0 C15986 2,6-Dihydroxypseudooxynicotine C01297 6-Hydroxypseudooxynicotine
+2,6-dihydroxypseudooxynicotine hydrolase [EC:3.7.1.19] [RN:R07515] K19188 M00810 Nicotine degradation, pyridine pathway, nicotine => 2,6-dihydroxypyridine/succinate semialdehyde 3,0 C03056,C15987 2,6-Dihydroxypyridine,4-Methylaminobutyrate C15986 2,6-Dihydroxypseudooxynicotine
+4-methylaminobutanoate oxidase (methylamine-forming) [EC:1.5.3.21] [RN:R10101] K20155 M00810 Nicotine degradation, pyridine pathway, nicotine => 2,6-dihydroxypyridine/succinate semialdehyde 4,0 C00232 Succinate semialdehyde C15987 4-Methylaminobutyrate
+nicotine oxidoreductase [EC:1.5.3.-] [RN:R11175 R11178] K20170 M00811 Nicotine degradation, pyrrolidine pathway, nicotine => succinate semialdehyde 0,0 C19569 3-Succinoylpyridine C20361 Pseudooxynicotine
+nicotine oxidoreductase [EC:1.5.3.-] [RN:R11175 R11178] K20169 M00811 Nicotine degradation, pyrrolidine pathway, nicotine => succinate semialdehyde 0,1 C19569 3-Succinoylpyridine C20361 Pseudooxynicotine
+nicotine oxidoreductase [EC:1.5.3.-] [RN:R11175 R11178] K20170 M00811 Nicotine degradation, pyrrolidine pathway, nicotine => succinate semialdehyde 1,0 C19569 3-Succinoylpyridine C20361 Pseudooxynicotine
+pseudooxynicotine oxidase [EC:1.4.3.24] [RN:R10103] K20158 M00811 Nicotine degradation, pyrrolidine pathway, nicotine => succinate semialdehyde 1,1,0,0 C19567 4-Oxo-1-(3-pyridyl)-1-butanone C20361 Pseudooxynicotine
+3-succinoylsemialdehyde-pyridine dehydrogenase [EC:1.2.1.83] [RN:R10105] K19700 M00811 Nicotine degradation, pyrrolidine pathway, nicotine => succinate semialdehyde 1,1,1,0 C19569 3-Succinoylpyridine C19567 4-Oxo-1-(3-pyridyl)-1-butanone
+3-succinoylpyridine monooxygenase [RN:R11179] K20171 M00811 Nicotine degradation, pyrrolidine pathway, nicotine => succinate semialdehyde 2,0 C19631 6-Hydroxy-3-succinoylpyridine C19569 3-Succinoylpyridine
+3-succinoylpyridine monooxygenase [RN:R11179] K20172 M00811 Nicotine degradation, pyrrolidine pathway, nicotine => succinate semialdehyde 2,0 C19631 6-Hydroxy-3-succinoylpyridine C19569 3-Succinoylpyridine
+6-hydroxy-3-succinoylpyridine 3-monooxygenase [EC:1.14.13.163] [RN:R09472] K15359 M00811 Nicotine degradation, pyrrolidine pathway, nicotine => succinate semialdehyde 3,0 C01059,C00232 2,5-Dihydroxypyridine,Succinate semialdehyde C19631 6-Hydroxy-3-succinoylpyridine
+6-hydroxy-3-succinoylpyridine 3-monooxygenase [EC:1.14.13.163] [RN:R09472] K18276 M00811 Nicotine degradation, pyrrolidine pathway, nicotine => succinate semialdehyde 3,1 C01059,C00232 2,5-Dihydroxypyridine,Succinate semialdehyde C19631 6-Hydroxy-3-succinoylpyridine
+acbC; 2-epi-5-epi-valiolone synthase [EC:4.2.3.152] [RN:R10937] K19969 M00814 Acarbose biosynthesis, sedoheptulopyranose-7P => acarbose 0,0 C17691 2-epi-5-epi-Valiolone C20956 alpha-D-Sedoheptulopyranose 7-phosphate
+acbM; 2-epi-5-epi-valiolone 7-kinase [EC:2.7.1.188] [RN:R11185] K19979 M00814 Acarbose biosynthesis, sedoheptulopyranose-7P => acarbose 1,0 C17692 2-epi-5-epi-Valiolone 7-phosphate C17691 2-epi-5-epi-Valiolone
+acbO; 2-epi-5-epi-valiolone 7-phosphate 2-epimerase [EC:5.1.3.35] [RN:R11081] K19974 M00814 Acarbose biosynthesis, sedoheptulopyranose-7P => acarbose 2,0 C17693 5-epi-Valiolone 7-phosphate C17692 2-epi-5-epi-Valiolone 7-phosphate
+acbL; 2-epi-valiolone-7-phosphate 1-reductase [EC:1.1.1.-] [RN:R11243] K20424 M00814 Acarbose biosynthesis, sedoheptulopyranose-7P => acarbose 3,0 C21204 5-epi-Valiolol 7-phosphate C17693 5-epi-Valiolone 7-phosphate
+acbN; cyclitol oxidoreductase [RN:R11244] K20425 M00814 Acarbose biosynthesis, sedoheptulopyranose-7P => acarbose 4,0 C21205 1-epi-Valienol 7-phosphate C21204 5-epi-Valiolol 7-phosphate
+acbU; 1-epi-valienol-7-phosphate kinase [EC:2.7.-.-] [RN:R11245] K20426 M00814 Acarbose biosynthesis, sedoheptulopyranose-7P => acarbose 5,0 C21206 1,7-diphospho-1-epi-valienol C21205 1-epi-Valienol 7-phosphate
+acbR; 1-epi-valienol 1,7-diphosphate adenylyltransferases [EC:2.7.7.-] [RN:R11246] K20427 M00814 Acarbose biosynthesis, sedoheptulopyranose-7P => acarbose 6,0 C21207 NDP-1-epi-valienol 7-phosphate C21206 1,7-diphospho-1-epi-valienol
+acbS; glycosyltransferase AcbS [EC:2.4.-.-] [RN:R11247] K20430 M00814 Acarbose biosynthesis, sedoheptulopyranose-7P => acarbose 7,0 C21208 dTDP-acarviose-7-phosphate C04268,C21207 dTDP-4-amino-4,6-dideoxy-D-glucose,NDP-1-epi-valienol 7-phosphate
+valA; 2-epi-5-epi-valiolone synthase [EC:4.2.3.152] [RN:R10937] K19969 M00815 Validamycin A biosynthesis, sedoheptulopyranose-7P => validamycin A 0,0 C17691 2-epi-5-epi-Valiolone C20956 alpha-D-Sedoheptulopyranose 7-phosphate
+valD; 2-epi-5-epi-valiolone epimerase [EC:5.1.3.33] [RN:R11079] K20431 M00815 Validamycin A biosynthesis, sedoheptulopyranose-7P => validamycin A 1,0 C17694 5-epi-Valiolone C17691 2-epi-5-epi-Valiolone
+valK; 5-epi-valiolone dehydratase [EC:4.2.1.-] [RN:R11233] K20432 M00815 Validamycin A biosynthesis, sedoheptulopyranose-7P => validamycin A 2,0 C17696 Valienone C17694 5-epi-Valiolone
+valC; C7-cyclitol kinase [EC:2.7.1.-] [RN:R11234] K20433 M00815 Validamycin A biosynthesis, sedoheptulopyranose-7P => validamycin A 3,0 C17697 Valienone 7-phosphate C17696 Valienone
+valN; cyclitol reductase [RN:R11236] K20434 M00815 Validamycin A biosynthesis, sedoheptulopyranose-7P => validamycin A 4,0 C21218 Validone 7-phosphate C17697 Valienone 7-phosphate
+valM; validone 7-phosphate aminotransferase [EC2.6.1.-] [RN:R11238] K20435 M00815 Validamycin A biosynthesis, sedoheptulopyranose-7P => validamycin A 5,0 C21216 Validamine 7-phosphate C21218 Validone 7-phosphate
+valL; validoxylamine A 7'-phosphate synthase [EC:2.4.1.-] [RN:R11497] K20436 M00815 Validamycin A biosynthesis, sedoheptulopyranose-7P => validamycin A 6,0 C21219 Validoxylamine A 7'-phosphate C21368, C21216
+vldH; validoxylamine A 7'-phosphate phosphatase [EC:3.1.3.101] [RN:R11240] K20437 M00815 Validamycin A biosynthesis, sedoheptulopyranose-7P => validamycin A 7,0 C17700 Validoxylamine A C21219 Validoxylamine A 7'-phosphate
+valG; validoxylamine A glucosyltransferase [EC:2.4.1.338] [RN:R11241] K20438 M00815 Validamycin A biosynthesis, sedoheptulopyranose-7P => validamycin A 8,0 C12112 Validamycin A C17700 Validoxylamine A
+pentalenene synthase [EC:4.2.3.7] [RN:R02305] K12250 M00819 Pentalenolactone biosynthesis, farnesyl-PP => pentalenolactone 0,0 C01841 Pentalenene C00448 trans,trans-Farnesyl diphosphate
+pentalenene oxygenase [EC:1.14.15.32] [RN:R09814] K15907 M00819 Pentalenolactone biosynthesis, farnesyl-PP => pentalenolactone 1,0 C19939 Pentalen-13-al C01841 Pentalenene
+1-deoxypentalenic acid 11beta-hydroxylase [EC:1.14.11.35] [RN:R10157] K18056 M00819 Pentalenolactone biosynthesis, farnesyl-PP => pentalenolactone 3,0 C20403 1-Deoxy-11beta-hydroxypentalenate C20404 1-Deoxypentalenate
+1-deoxy-11beta-hydroxypentalenate dehydrogenase [EC:1.1.1.340] [RN:R10156] K17747 M00819 Pentalenolactone biosynthesis, farnesyl-PP => pentalenolactone 4,0 C20400 1-Deoxy-11-oxopentalenate C20403 1-Deoxy-11beta-hydroxypentalenate
+pentalenolactone D synthase [EC:1.14.13.170 1.14.13.171] [RN:R10154] K18091 M00819 Pentalenolactone biosynthesis, farnesyl-PP => pentalenolactone 5,0 C20399 Pentalenolactone D C20400 1-Deoxy-11-oxopentalenate
+pentalenolactone F synthase [EC:1.14.11.36] [RN:R10145] K18057 M00819 Pentalenolactone biosynthesis, farnesyl-PP => pentalenolactone 6,0 C20397 Pentalenolactone F C20399 Pentalenolactone D
+pentalenolactone synthase [EC:1.14.19.8] [RN:R10162] K17476 M00819 Pentalenolactone biosynthesis, farnesyl-PP => pentalenolactone 7,0 C20407 Pentalenolactone C20397 Pentalenolactone F
+oxyF; C-methyltransferase [EC:2.1.1.-] [RN:R09189] K14251 M00823 Chlortetracycline biosynthesis, pretetramide => chlortetracycline 0,0 C06629 6-Methylpretetramide C18295 Pretetramid
+oxyL; 6-methylpretetramide 4-monooxygenase / 4-hydroxy-6-methylpretetramide 12a-monooxygenase [EC:1.14.13.232 1.14.13.233] [RN:R09190 R05462] K14252 M00823 Chlortetracycline biosynthesis, pretetramide => chlortetracycline 1,0 C06627 4-Keto-anhydrotetracycline C06628 4-Hydroxy-6-methylpretetramide
+oxyE; 6-methylpretetramide 4-monooxygenase [EC:1.14.13.232] [RN:R05463] K14253 M00823 Chlortetracycline biosynthesis, pretetramide => chlortetracycline 2,0 C06628 4-Hydroxy-6-methylpretetramide C06629 6-Methylpretetramide
+oxyQ; aminotransferase [RN:R09197] K14254 M00823 Chlortetracycline biosynthesis, pretetramide => chlortetracycline 3,0 C06654 4-Amino-anhydrotetracycline C06627 4-Keto-anhydrotetracycline
+oxyT, ctcO, cts6; 4-amino-anhydrotetracycline N4-methyltransferase [EC:2.1.1.335] [RN:R09191] K14255 M00823 Chlortetracycline biosynthesis, pretetramide => chlortetracycline 4,0 C02811 Anhydrotetracycline C06654 4-Amino-anhydrotetracycline
+oxyS, cts8; anhydrotetracycline 6-monooxygenase / 5a,11a-dehydrotetracycline 5-monooxygenase [EC:1.14.13.38 1.14.13.234] [RN:R04060 R09198] K14256 M00823 Chlortetracycline biosynthesis, pretetramide => chlortetracycline 5,0 C03206 5a,11a-Dehydrotetracycline C02811 Anhydrotetracycline
+oxyR; 5a,11a-dehydrotetracycline reductase [EC:1.3.98.4] [RN:R09192 R05459] K21301 M00823 Chlortetracycline biosynthesis, pretetramide => chlortetracycline 6,0 C06570 Tetracycline C03206 5a,11a-Dehydrotetracycline
+ctcP; tetracycline 7-halogenase [EC:1.14.19.49] [RN:R11478] K14257 M00823 Chlortetracycline biosynthesis, pretetramide => chlortetracycline 7,0 C06571 Chlortetracycline C06570 Tetracycline
+ctcQ; flavin reductase (NADH) [EC:1.5.1.36] K21297 M00823 Chlortetracycline biosynthesis, pretetramide => chlortetracycline 7,0
+sgcE; enediyne polyketide synthase [RN:R11435] K15314 M00824 9-membered enediyne core biosynthesis, malonyl-CoA => 3-hydroxyhexadeca-4,6,8,10,12,14-hexaenoyl-ACP => 9-membered enediyne core 0,0
+sgcE2; enediyne biosynthesis protein E2 K21160 M00824 9-membered enediyne core biosynthesis, malonyl-CoA => 3-hydroxyhexadeca-4,6,8,10,12,14-hexaenoyl-ACP => 9-membered enediyne core 1,0
+sgcE3; enediyne biosynthesis protein E3 K21161 M00824 9-membered enediyne core biosynthesis, malonyl-CoA => 3-hydroxyhexadeca-4,6,8,10,12,14-hexaenoyl-ACP => 9-membered enediyne core 1,0
+sgcE4; enediyne biosynthesis protein E4 K21162 M00824 9-membered enediyne core biosynthesis, malonyl-CoA => 3-hydroxyhexadeca-4,6,8,10,12,14-hexaenoyl-ACP => 9-membered enediyne core 1,0
+sgcE5; enediyne biosynthesis protein E5 K21163 M00824 9-membered enediyne core biosynthesis, malonyl-CoA => 3-hydroxyhexadeca-4,6,8,10,12,14-hexaenoyl-ACP => 9-membered enediyne core 1,0
+sgcE7; enediyne biosynthesis protein E7 K21164 M00824 9-membered enediyne core biosynthesis, malonyl-CoA => 3-hydroxyhexadeca-4,6,8,10,12,14-hexaenoyl-ACP => 9-membered enediyne core 1,0
+sgcE8; enediyne biosynthesis protein E8 K21165 M00824 9-membered enediyne core biosynthesis, malonyl-CoA => 3-hydroxyhexadeca-4,6,8,10,12,14-hexaenoyl-ACP => 9-membered enediyne core 1,0
+sgcE9; enediyne biosynthesis protein E9 K21166 M00824 9-membered enediyne core biosynthesis, malonyl-CoA => 3-hydroxyhexadeca-4,6,8,10,12,14-hexaenoyl-ACP => 9-membered enediyne core 1,0
+sgcE11; enediyne biosynthesis protein E11 K21167 M00824 9-membered enediyne core biosynthesis, malonyl-CoA => 3-hydroxyhexadeca-4,6,8,10,12,14-hexaenoyl-ACP => 9-membered enediyne core 1,0
+sgcE; enediyne polyketide synthase [RN:R11435] K15314 M00825 10-membered enediyne core biosynthesis, malonyl-CoA => 3-hydroxyhexadeca-4,6,8,10,12,14-hexaenoyl-ACP => 10-membered enediyne core 0,0
+calE1; enediyne biosynthesis protein CalE1 K21168 M00825 10-membered enediyne core biosynthesis, malonyl-CoA => 3-hydroxyhexadeca-4,6,8,10,12,14-hexaenoyl-ACP => 10-membered enediyne core 1,0
+calE2; enediyne biosynthesis protein CalE2 K21169 M00825 10-membered enediyne core biosynthesis, malonyl-CoA => 3-hydroxyhexadeca-4,6,8,10,12,14-hexaenoyl-ACP => 10-membered enediyne core 1,0
+calE3; enediyne biosynthesis protein CalE3 K21170 M00825 10-membered enediyne core biosynthesis, malonyl-CoA => 3-hydroxyhexadeca-4,6,8,10,12,14-hexaenoyl-ACP => 10-membered enediyne core 1,0
+calE4; enediyne biosynthesis protein CalE4 K21171 M00825 10-membered enediyne core biosynthesis, malonyl-CoA => 3-hydroxyhexadeca-4,6,8,10,12,14-hexaenoyl-ACP => 10-membered enediyne core 1,0
+calE5; enediyne biosynthesis protein CalE5 K21172 M00825 10-membered enediyne core biosynthesis, malonyl-CoA => 3-hydroxyhexadeca-4,6,8,10,12,14-hexaenoyl-ACP => 10-membered enediyne core 1,0
+calE6; methionine gamma-lyase K21173 M00825 10-membered enediyne core biosynthesis, malonyl-CoA => 3-hydroxyhexadeca-4,6,8,10,12,14-hexaenoyl-ACP => 10-membered enediyne core 1,0
+calE9; enediyne biosynthesis protein CalE9 K21174 M00825 10-membered enediyne core biosynthesis, malonyl-CoA => 3-hydroxyhexadeca-4,6,8,10,12,14-hexaenoyl-ACP => 10-membered enediyne core 1,0
+sgcD; 2-amino-4-deoxychorismate synthase [EC:2.6.1.86] [RN:R08956] K20159 M00826 C-1027 benzoxazolinate moiety biosynthesis, chorismate => benzoxazolinyl-CoA 0,0 C18054 2-Amino-2-deoxyisochorismate C00251 Chorismate
+sgcD1; 2-amino-4-deoxychorismate synthase, glutamine amidotransferase component [EC:2.6.1.86] [RN:R08956] K21175 M00826 C-1027 benzoxazolinate moiety biosynthesis, chorismate => benzoxazolinyl-CoA 0,0 C18054 2-Amino-2-deoxyisochorismate C00251 Chorismate
+sgcG; 2-amino-4-deoxychorismate dehydrogenase [EC:1.3.99.24] [RN:R09559] K20156 M00826 C-1027 benzoxazolinate moiety biosynthesis, chorismate => benzoxazolinyl-CoA 1,0 C19686 3-(1-Carboxyvinyloxy)anthranilate C18054 2-Amino-2-deoxyisochorismate
+sgcD5; benzoxazolinate moiety biosynthesis protein SgcD5 [RN:R11362] K21176 M00826 C-1027 benzoxazolinate moiety biosynthesis, chorismate => benzoxazolinyl-CoA 2,0 C21306 3,4-Dihydro-2-methylene-3-oxo-2H-1,4-benzoxazine-5-carboxylate C19686 3-(1-Carboxyvinyloxy)anthranilate
+sgcD3; cytochrome P450 hydroxylase [EC:1.14.-.-] [RN:R11363] K21177 M00826 C-1027 benzoxazolinate moiety biosynthesis, chorismate => benzoxazolinyl-CoA 3,0 C21307 3,4-Dihydro-7-hydroxy-2-methylene-3-oxo-2H-1,4-benzoxazine-5-carboxylate C21306 3,4-Dihydro-2-methylene-3-oxo-2H-1,4-benzoxazine-5-carboxylate
+sgcD4; O-methyltransferase [EC:2.1.1.-] [RN:R11364] K21178 M00826 C-1027 benzoxazolinate moiety biosynthesis, chorismate => benzoxazolinyl-CoA 4,0 C11468 3,4-Dihydro-7-methoxy-2-methylene-3-oxo-2H-1,4-benzoxazine-5-carboxylic acid C21307 3,4-Dihydro-7-hydroxy-2-methylene-3-oxo-2H-1,4-benzoxazine-5-carboxylate
+sgcH; CoA-ligase [RN:R11365] K21179 M00826 C-1027 benzoxazolinate moiety biosynthesis, chorismate => benzoxazolinyl-CoA 5,0 C11448 3,4-Dihydro-7-methoxy-2-methylene-3-oxo-2H-1,4-benzoxazine-5-carbonyl-CoA C11468 3,4-Dihydro-7-methoxy-2-methylene-3-oxo-2H-1,4-benzoxazine-5-carboxylic acid
+sgcC4; MIO-dependent L-tyrosine 2,3-aminomutase [EC:5.4.3.6] [RN:R11366] K21181 M00827 C-1027 beta-amino acid moiety biosynthesis, tyrosine => 3-chloro-4,5-dihydroxy-beta-phenylalanyl-PCP 0,0 C21308 (S)-beta-Tyrosine C00082 L-Tyrosine
+sgcC1; (S)-beta-tyrosine adenylation enzyme [EC:6.2.1.-] [RN:R11367] K21182 M00827 C-1027 beta-amino acid moiety biosynthesis, tyrosine => 3-chloro-4,5-dihydroxy-beta-phenylalanyl-PCP 1,0 C21309 (S)-beta-Tyrosyl-[pcp] C21308 (S)-beta-Tyrosine
+sgcC3; FAD-dependent halogenase [EC:1.14.19.-] [RN:R11368] K16431 M00827 C-1027 beta-amino acid moiety biosynthesis, tyrosine => 3-chloro-4,5-dihydroxy-beta-phenylalanyl-PCP 2,0 C20810 (S)-3-Chloro-beta-tyrosyl-[pcp] C21309 (S)-beta-Tyrosyl-[pcp]
+sgcC; two-component FAD-dependent monooxygenase [EC:1.14.14.15 1.14.14.-] [RN:R10731] K21184 M00827 C-1027 beta-amino acid moiety biosynthesis, tyrosine => 3-chloro-4,5-dihydroxy-beta-phenylalanyl-PCP 3,0 C11449 (S)-3-Chloro-4,5-dihydroxy-beta-phenylalanyl-[pcp] C20810 (S)-3-Chloro-beta-tyrosyl-[pcp]
+sgcE6; flavin reductase K21185 M00827 C-1027 beta-amino acid moiety biosynthesis, tyrosine => 3-chloro-4,5-dihydroxy-beta-phenylalanyl-PCP 4,0 C20810 (S)-3-Chloro-beta-tyrosyl-[pcp] C21309 (S)-beta-Tyrosyl-[pcp]
+mdpC4; MIO-dependent L-tyrosine 2,3-aminomutase [EC:5.4.3.6] [RN:R11366] K21181 M00828 Maduropeptin beta-hydroxy acid moiety biosynthesis, tyrosine => 3-(4-hydroxyphenyl)-3-oxopropanoyl-PCP 0,0 C21308 (S)-beta-Tyrosine C00082 L-Tyrosine
+mdpC1; (S)-beta-tyrosine adenylation enzyme [EC:6.2.1.-] [RN:R11367] K21182 M00828 Maduropeptin beta-hydroxy acid moiety biosynthesis, tyrosine => 3-(4-hydroxyphenyl)-3-oxopropanoyl-PCP 1,0 C21309 (S)-beta-Tyrosyl-[pcp] C21308 (S)-beta-Tyrosine
+mdpC7; PLP-dependent transaminase [RN:R11369] K21188 M00828 Maduropeptin beta-hydroxy acid moiety biosynthesis, tyrosine => 3-(4-hydroxyphenyl)-3-oxopropanoyl-PCP 2,0 C21311 3-(4-Hydroxyphenyl)-3-oxopropanoyl-[pcp] C21309 (S)-beta-Tyrosyl-[pcp]
+mdpB; 6-methylsalicylic acid synthase [EC:2.3.1.165] [RN:R07253] K15320 M00829 3,6-Dimethylsalicylyl-CoA biosynthesis, malonyl-CoA => 6-methylsalicylate => 3,6-dimethylsalicylyl-CoA 0,0 C02657 6-Methylsalicylate C00083 Malonyl-CoA
+mdpB2; CoA ligase [EC:6.2.1.-] [RN:R11370] K21191 M00829 3,6-Dimethylsalicylyl-CoA biosynthesis, malonyl-CoA => 6-methylsalicylate => 3,6-dimethylsalicylyl-CoA 1,0 C21312 6-Methylsalicylyl-CoA C02657 6-Methylsalicylate
+mdpB1; methyltransferase [EC:2.1.1.-] [RN:R11371] K21192 M00829 3,6-Dimethylsalicylyl-CoA biosynthesis, malonyl-CoA => 6-methylsalicylate => 3,6-dimethylsalicylyl-CoA 2,0 C21313 3,6-Dimethylsalicylyl-CoA C21312 6-Methylsalicylyl-CoA
+ncsB; neocarzinostatin naphthoate synthase [EC:2.3.1.237] [RN:R11125] K20422 M00830 Neocarzinostatin naphthoate moiety biosynthesis, malonyl-CoA => 2-hydroxy-5-methyl-1-naphthoate => 2-hydroxy-7-methoxy-5-methyl-1-naphthoyl-CoA 0,0 C20856 2-Hydroxy-5-methyl-1-naphthoate C00083 Malonyl-CoA
+ncsB3; 2-hydroxy-5-methyl-1-naphthoate 7-hydroxylase [EC:1.14.15.31] [RN:R10796] K20420 M00830 Neocarzinostatin naphthoate moiety biosynthesis, malonyl-CoA => 2-hydroxy-5-methyl-1-naphthoate => 2-hydroxy-7-methoxy-5-methyl-1-naphthoyl-CoA 1,0 C20857 2,7-Dihydroxy-5-methyl-1-naphthoate C20856 2-Hydroxy-5-methyl-1-naphthoate
+ncsB1; 2,7-dihydroxy-5-methyl-1-naphthoate 7-O-methyltransferase [EC:2.1.1.303] [RN:R10963] K20421 M00830 Neocarzinostatin naphthoate moiety biosynthesis, malonyl-CoA => 2-hydroxy-5-methyl-1-naphthoate => 2-hydroxy-7-methoxy-5-methyl-1-naphthoyl-CoA 2,0 C20841 2-Hydroxy-7-methoxy-5-methyl-1-naphthoate C20857 2,7-Dihydroxy-5-methyl-1-naphthoate
+ncsB2; 2-hydroxy-7-methoxy-5-methyl-1-naphthoate---CoA ligase [EC:6.2.1.43] [RN:R10771] K20423 M00830 Neocarzinostatin naphthoate moiety biosynthesis, malonyl-CoA => 2-hydroxy-5-methyl-1-naphthoate => 2-hydroxy-7-methoxy-5-methyl-1-naphthoyl-CoA 3,0 C20842 2-Hydroxy-7-methoxy-5-methyl-1-naphthoyl-CoA C20841 2-Hydroxy-7-methoxy-5-methyl-1-naphthoate
+kedU38 K21221 M00831 Kedarcidin 2-hydroxynaphthoate moiety biosynthesis, malonyl-CoA => 3,6,8-trihydroxy-2-naphthoate => 3-hydroxy-7,8-dimethoxy-6-isopropoxy-2-naphthoyl-CoA 0,0
+kedN3; cytochrome P450 monooxygenase [EC:1.14.-.-] [RN:R11387] K21222 M00831 Kedarcidin 2-hydroxynaphthoate moiety biosynthesis, malonyl-CoA => 3,6,8-trihydroxy-2-naphthoate => 3-hydroxy-7,8-dimethoxy-6-isopropoxy-2-naphthoyl-CoA 1,0 C21321 3,6,7,8-Tetrahydroxy-2-naphthoate C21320 3,6,8-Trihydroxy-2-naphthoate
+kedN1; O-methyltransferase [EC:2.1.1.-] [RN:R11388] K21223 M00831 Kedarcidin 2-hydroxynaphthoate moiety biosynthesis, malonyl-CoA => 3,6,8-trihydroxy-2-naphthoate => 3-hydroxy-7,8-dimethoxy-6-isopropoxy-2-naphthoyl-CoA 2,0 C21322 3-Hydroxy-6,7,8-trimethoxy-2-naphthoate C21321 3,6,7,8-Tetrahydroxy-2-naphthoate
+kedN5; radical SAM C-methyltransferase [RN:R11389] K21224 M00831 Kedarcidin 2-hydroxynaphthoate moiety biosynthesis, malonyl-CoA => 3,6,8-trihydroxy-2-naphthoate => 3-hydroxy-7,8-dimethoxy-6-isopropoxy-2-naphthoyl-CoA 3,0 C21323 3-Hydroxy-7,8-dimethoxy-6-isopropoxy-2-naphthoate C21322 3-Hydroxy-6,7,8-trimethoxy-2-naphthoate
+kedN2; acyl-CoA synthetase [RN:R11390] K21225 M00831 Kedarcidin 2-hydroxynaphthoate moiety biosynthesis, malonyl-CoA => 3,6,8-trihydroxy-2-naphthoate => 3-hydroxy-7,8-dimethoxy-6-isopropoxy-2-naphthoyl-CoA 4,0 C21324 3-Hydroxy-7,8-dimethoxy-6-isopropoxy-2-naphthoyl-CoA C21323 3-Hydroxy-7,8-dimethoxy-6-isopropoxy-2-naphthoate
+kedY4; MIO-dependent 2-aza-L-tyrosine aminomutase [EC:5.4.3.-] [RN:R11391] K21227 M00832 Kedarcidin 2-aza-3-chloro-beta-tyrosine moiety biosynthesis, azatyrosine => 2-aza-3-chloro-beta-tyrosyl-PCP 0,0 C21326 (R)-2-Aza-beta-tyrosine C21325 Azatyrosine
+kedY1; (R)-2-aza-beta-tyrosine adenylation enzyme [EC:6.2.1.-] [RN:R11392] K21228 M00832 Kedarcidin 2-aza-3-chloro-beta-tyrosine moiety biosynthesis, azatyrosine => 2-aza-3-chloro-beta-tyrosyl-PCP 1,0 C21327 (R)-2-Aza-beta-tyrosyl-[pcp] C21326 (R)-2-Aza-beta-tyrosine
+kedY3; FAD-dependent halogenase [EC:1.14.19.-] [RN:R11393] K16431 M00832 Kedarcidin 2-aza-3-chloro-beta-tyrosine moiety biosynthesis, azatyrosine => 2-aza-3-chloro-beta-tyrosyl-PCP 2,0 C21328 (R)-2-Aza-3-chloro-beta-tyrosyl-[pcp] C21327 (R)-2-Aza-beta-tyrosyl-[pcp]
+sgcE6; flavin reductase K21185 M00832 Kedarcidin 2-aza-3-chloro-beta-tyrosine moiety biosynthesis, azatyrosine => 2-aza-3-chloro-beta-tyrosyl-PCP 3,0 C21328 (R)-2-Aza-3-chloro-beta-tyrosyl-[pcp] C21327 (R)-2-Aza-beta-tyrosyl-[pcp]
+calG3; calicheamicinone 4-hydroxyamino-4,6-dideoxy-alpha-D-glucosyltransferase [EC:2.4.1.-] [RN:R11417] K21259 M00833 Calicheamicin biosynthesis, calicheamicinone => calicheamicin 0,0 C21338 Calicheamicin T0 C21337 Calicheamicinone
+calG2; calicheamicin 4-deoxy-4-thio-alpha-D-digitoxosyltransferase [EC:2.4.1.-] [RN:R11418] K21260 M00833 Calicheamicin biosynthesis, calicheamicinone => calicheamicin 1,0 C21339 4-Deoxy-4-thio-alpha-D-digitoxosyl-calicheamicin T0 C21338 Calicheamicin T0
+calO4; acyltransferase [RN:R11419] K21261 M00833 Calicheamicin biosynthesis, calicheamicinone => calicheamicin 2,0 C21340 Calicheamicin PsAg C21339,C21347 4-Deoxy-4-thio-alpha-D-digitoxosyl-calicheamicin T0,5-Iodo-2,3-dimethoxyorsellinate-[acp]
+calG4; calicheamicin aminopentosyltransferase [EC:2.4.2.-] [RN:R11420 R11421] K21262 M00833 Calicheamicin biosynthesis, calicheamicinone => calicheamicin 3,0 C11469 Calicheamicin gamma(1)I C21342 Calicheamicin alpha3(I)
+calG1; calicheamicin 3'-O-methyl-rhamnosyltransferase [EC:2.4.1.-] [RN:R11422 R11423] K21263 M00833 Calicheamicin biosynthesis, calicheamicinone => calicheamicin 4,0 C21342 Calicheamicin alpha3(I) C21340 Calicheamicin PsAg
+calO5; orsellinic acid synthase [EC:2.3.1.-] [RN:R11412] K21254 M00834 Calicheamicin orsellinate moiety biosynthesis, malonyl-CoA => orsellinate-ACP => 5-iodo-2,3-dimethoxyorsellinate-ACP 0,0 C21343 Orsellinate-[acp] C00083 Malonyl-CoA
+calO6; orsellinic acid C2-O-methyltransferase [EC:2.1.1.-] [RN:R11413] K21255 M00834 Calicheamicin orsellinate moiety biosynthesis, malonyl-CoA => orsellinate-ACP => 5-iodo-2,3-dimethoxyorsellinate-ACP 1,0 C21344 2-Methoxyorsellinate-[acp] C21343 Orsellinate-[acp]
+calO3; flavin-dependent halogenase [RN:R11414] K21256 M00834 Calicheamicin orsellinate moiety biosynthesis, malonyl-CoA => orsellinate-ACP => 5-iodo-2,3-dimethoxyorsellinate-ACP 2,0 C21345 5-Iodo-2-methoxyorsellinate-[acp] C21344 2-Methoxyorsellinate-[acp]
+calO2; orsellenic acid P450 oxidase [EC:1.14.-.-] [RN:R11415] K21257 M00834 Calicheamicin orsellinate moiety biosynthesis, malonyl-CoA => orsellinate-ACP => 5-iodo-2,3-dimethoxyorsellinate-ACP 3,0 C21346 3-Hydroxy-5-iodo-2-methoxyorsellinate-[acp] C21345 5-Iodo-2-methoxyorsellinate-[acp]
+calO1; orsellinic acid C3-O-methyltransferase [EC:2.1.1.-] [RN:R11416] K21258 M00834 Calicheamicin orsellinate moiety biosynthesis, malonyl-CoA => orsellinate-ACP => 5-iodo-2,3-dimethoxyorsellinate-ACP 4,0 C21347 5-Iodo-2,3-dimethoxyorsellinate-[acp] C21346 3-Hydroxy-5-iodo-2-methoxyorsellinate-[acp]
+phzE; 2-amino-4-deoxychorismate synthase [EC:2.6.1.86] [RN:R08956] K13063 M00835 Pyocyanine biosynthesis, chorismate => pyocyanine 0,0 C18054 2-Amino-2-deoxyisochorismate C00251 Chorismate
+phzD; trans-2,3-dihydro-3-hydroxyanthranilic acid synthase [EC:3.3.2.15][RN:R11463] K20261 M00835 Pyocyanine biosynthesis, chorismate => pyocyanine 1,0 C19830 (5S,6S)-6-Amino-5-hydroxycyclohexa-1,3-diene-1-carboxylate C18054 2-Amino-2-deoxyisochorismate
+phzF; trans-2,3-dihydro-3-hydroxyanthranilate isomerase [EC:5.3.3.17] [RN:R09707] K06998 M00835 Pyocyanine biosynthesis, chorismate => pyocyanine 2,0 C19831 (1R,6S)-6-Amino-5-oxocyclohex-2-ene-1-carboxylate C19830 (5S,6S)-6-Amino-5-hydroxycyclohexa-1,3-diene-1-carboxylate
+phzA_B; phenazine biosynthesis protein [RN:R11568 R11569] K20260 M00835 Pyocyanine biosynthesis, chorismate => pyocyanine 3,0 C21408 (1R,6R)-1,4,5,5a,6,9-Hexahydrophenazine-1,6-dicarboxylate C21473 (1R,5aS,6R)-4a-Hydroxy-1,4,4a,5,5a,6,9,10a-octahydrophenazine-1,6-dicarboxylate
+phzG; dihydrophenazinedicarboxylate synthase [EC:1.10.3.16][RN:R11491] K20262 M00835 Pyocyanine biosynthesis, chorismate => pyocyanine 4,0 C21412 (10aS)-10,10a-Dihydrophenazine-1-carboxylate C21411 (1R,10aS)-1,4,10,10a-Tetrahydrophenazine-1-carboxylate
+phzM; phenazine-1-carboxylate N-methyltransferase [EC:2.1.1.327][RN:R11533] K21103 M00835 Pyocyanine biosynthesis, chorismate => pyocyanine 5,0 C21295 5-Methylphenazine-1-carboxylate C21442 Phenazine-1-carboxylate
+phzS; 5-methylphenazine-1-carboxylate 1-monooxygenase [EC:1.14.13.218][RN:R11346] K20940 M00835 Pyocyanine biosynthesis, chorismate => pyocyanine 6,0 C01748 Pyocyanine C21295 5-Methylphenazine-1-carboxylate
+cfbA; sirohydrochlorin nickelchelatase [EC:4.99.1.11] [RN:R11626] K22011 M00836 Coenzyme F430 biosynthesis, sirohydrochlorin => coenzyme F430 0,0 C21510 Nickel-sirohydrochlorin C05778 Sirohydrochlorin
+cfbB; Ni-sirohydrochlorin a,c-diamide synthase [EC:6.3.5.12] [RN:R11627] K22012 M00836 Coenzyme F430 biosynthesis, sirohydrochlorin => coenzyme F430 1,0 C21511 Nickel-sirohydrochlorin a,c-diamide C21510 Nickel-sirohydrochlorin
+cfbCD; nickel-sirohydrochlorin a,c-diamide reductase [EC:6.3.3.7] [RN:R11628] K21610 M00836 Coenzyme F430 biosynthesis, sirohydrochlorin => coenzyme F430 2,0 C21512 15,17(3)-Seco-F430-17(3)-acid C21511 Nickel-sirohydrochlorin a,c-diamide
+cfbCD; nickel-sirohydrochlorin a,c-diamide reductase [EC:6.3.3.7] [RN:R11628] K21611 M00836 Coenzyme F430 biosynthesis, sirohydrochlorin => coenzyme F430 2,0 C21512 15,17(3)-Seco-F430-17(3)-acid C21511 Nickel-sirohydrochlorin a,c-diamide
+cfbE; coenzyme F430 synthetase [EC:6.4.1.9] [RN:R11629] K21612 M00836 Coenzyme F430 biosynthesis, sirohydrochlorin => coenzyme F430 3,0 C05777 Coenzyme F430 C21512 15,17(3)-Seco-F430-17(3)-acid
+pigC; prodigiosin/undecylprodigiosin synthetase [RN:R11662] K21787 M00837 Prodigiosin biosynthesis, L-proline => prodigiosin 0,0 C21565 Prodigiosin C21570,C21572 4-Methoxy-2,2'-bipyrrole-5-carbaldehyde,2-Methyl-3-n-amyl-pyrrole
+pigC; prodigiosin/undecylprodigiosin synthetase [RN:R11673] K21787 M00838 Undecylprodigiosin biosynthesis, L-proline => undecylprodigiosin 0,0 C12023 Undecylprodigiosin C21570,C21574 4-Methoxy-2,2'-bipyrrole-5-carbaldehyde,2-Undecylpyrrole
+GTP cyclohydrolase II [EC:3.5.4.25] [RN:R00425] K14652 M00840 Tetrahydrofolate biosynthesis, mediated by ribA and trpF, GTP => THF 0,0 C01304 2,5-Diamino-6-(5-phospho-D-ribosylamino)pyrimidin-4(3H)-one C00044 GTP
+2,5-diamino-6-(5-phospho-D-ribosylamino)pyrimidin-4(3H)-one isomerase/dehydratase [EC:4.2.1.160] [RN:R11072] K22100 M00840 Tetrahydrofolate biosynthesis, mediated by ribA and trpF, GTP => THF 1,0 C05925 Dihydroneopterin phosphate C01304 2,5-Diamino-6-(5-phospho-D-ribosylamino)pyrimidin-4(3H)-one
+7,8-dihydroneopterin aldolase [EC:4.1.2.25] [RN:R03504] K01633 M00840 Tetrahydrofolate biosynthesis, mediated by ribA and trpF, GTP => THF 3,0 C01300 6-(Hydroxymethyl)-7,8-dihydropterin C04874 7,8-Dihydroneopterin
+2-amino-4-hydroxy-6-hydroxymethyldihydropteridine diphosphokinase / dihydropteroate synthase [EC:2.7.6.3 2.5.1.15] [RN:R03503 R03066 R03067] K13941 M00840 Tetrahydrofolate biosynthesis, mediated by ribA and trpF, GTP => THF 4,0 C00921 Dihydropteroate C04807 6-Hydroxymethyl-7,8-dihydropterin diphosphate
+dihydrofolate synthase [EC:6.3.2.12] [RN:R02237] K22099 M00840 Tetrahydrofolate biosynthesis, mediated by ribA and trpF, GTP => THF 5,0 C00415 Dihydrofolate C00921 Dihydropteroate
+dihydrofolate reductase [EC:1.5.1.3] [RN:R00936 R00939] K00287 M00840 Tetrahydrofolate biosynthesis, mediated by ribA and trpF, GTP => THF 6,0 C00101 Tetrahydrofolate C00415 Dihydrofolate
+GTP cyclohydrolase IA [EC:3.5.4.16] [RN:R00428 R05046 R05048 R04639] K01495 M00841 Tetrahydrofolate biosynthesis, mediated by PTPS, GTP => THF 0,0 C04895 7,8-Dihydroneopterin 3'-triphosphate C06148 2,5-Diamino-6-(5'-triphosphoryl-3',4'-trihydroxy-2'-oxopentyl)-amino-4-oxopyrimidine
+dihydroneopterin triphosphate aldolase (PTPS-III) [EC:4.1.2.60] [RN:R11719] K22101 M00841 Tetrahydrofolate biosynthesis, mediated by PTPS, GTP => THF 1,0 C01300 6-(Hydroxymethyl)-7,8-dihydropterin C04895 7,8-Dihydroneopterin 3'-triphosphate
+2-amino-4-hydroxy-6-hydroxymethyldihydropteridine diphosphokinase [EC:2.7.6.3] [RN:R03503] K00950 M00841 Tetrahydrofolate biosynthesis, mediated by PTPS, GTP => THF 2,0 C04807 6-Hydroxymethyl-7,8-dihydropterin diphosphate C01300 6-(Hydroxymethyl)-7,8-dihydropterin
+dihydropteroate synthase [EC:2.5.1.15] [RN:R03066 R03067] K00796 M00841 Tetrahydrofolate biosynthesis, mediated by PTPS, GTP => THF 3,0 C00921 Dihydropteroate C04807 6-Hydroxymethyl-7,8-dihydropterin diphosphate
+dihydrofolate synthase [EC:6.3.2.12] [RN:R02237] K11754 M00841 Tetrahydrofolate biosynthesis, mediated by PTPS, GTP => THF 4,0 C00415 Dihydrofolate C00921 Dihydropteroate
+dihydrofolate reductase [EC:1.5.1.3] [RN:R00936 R00939] K13998 M00841 Tetrahydrofolate biosynthesis, mediated by PTPS, GTP => THF 5,0 C00101 Tetrahydrofolate C00415 Dihydrofolate
+GTP cyclohydrolase IA [EC:3.5.4.16] [RN:R00428 R05046 R05048 R04639] K01495 M00842 Tetrahydrobiopterin biosynthesis, GTP => BH4 0,0 C04895 7,8-Dihydroneopterin 3'-triphosphate C06148 2,5-Diamino-6-(5'-triphosphoryl-3',4'-trihydroxy-2'-oxopentyl)-amino-4-oxopyrimidine
+6-pyruvoyltetrahydropterin synthase [EC:4.2.3.12] [RN:R04286] K01737 M00842 Tetrahydrobiopterin biosynthesis, GTP => BH4 1,0 C03684 6-Pyruvoyltetrahydropterin C04895 7,8-Dihydroneopterin 3'-triphosphate
+sepiapterin reductase [EC:1.1.1.153] [RN:R08208] K00072 M00842 Tetrahydrobiopterin biosynthesis, GTP => BH4 2,0 C00272 Tetrahydrobiopterin C03684 6-Pyruvoyltetrahydropterin
+GTP cyclohydrolase IA [EC:3.5.4.16] [RN:R00428 R05046 R05048 R04639] K01495 M00843 L-threo-Tetrahydrobiopterin biosynthesis, GTP => L-threo-BH4 0,0 C04895 7,8-Dihydroneopterin 3'-triphosphate C06148 2,5-Diamino-6-(5'-triphosphoryl-3',4'-trihydroxy-2'-oxopentyl)-amino-4-oxopyrimidine
+6-pyruvoyltetrahydropterin [EC:4.2.3.12] [RN:R04286] K01737 M00843 L-threo-Tetrahydrobiopterin biosynthesis, GTP => L-threo-BH4 1,0 C03684 6-Pyruvoyltetrahydropterin C04895 7,8-Dihydroneopterin 3'-triphosphate
+sepiapterin reductase [EC:1.1.1.325] [RN:R09990] K17745 M00843 L-threo-Tetrahydrobiopterin biosynthesis, GTP => L-threo-BH4 2,0 C20264 L-threo-Tetrahydrobiopterin C03684 6-Pyruvoyltetrahydropterin
+ornithine carbamoyltransferase [EC:2.1.3.3] [RN:R01398] K00611 M00844 Arginine biosynthesis, ornithine => arginine 0,0 C00327 L-Citrulline C00169,C00077 Carbamoyl phosphate,L-Ornithine
+argininosuccinate synthase [EC:6.3.4.5] [RN:R01954] K01940 M00844 Arginine biosynthesis, ornithine => arginine 1,0 C03406 N-(L-Arginino)succinate C00327,C00049 L-Citrulline,L-Aspartate
+argininosuccinate lyase [EC:4.3.2.1] [RN:R01086] K01755 M00844 Arginine biosynthesis, ornithine => arginine 2,0 C00062,C00122 L-Arginine,Fumarate C03406 N-(L-Arginino)succinate
+argininosuccinate lyase [EC:4.3.2.1] [RN:R01086] K14681 M00844 Arginine biosynthesis, ornithine => arginine 2,1 C00062,C00122 L-Arginine,Fumarate C03406 N-(L-Arginino)succinate
+K22478; bifunctional N-acetylglutamate synthase/kinase [EC:2.3.1.1 2.7.2.8] [RN:R00259 R02649] K22478 M00845 Arginine biosynthesis, glutamate => acetylcitrulline => arginine 0,0 C04133 N-Acetyl-L-glutamate 5-phosphate C00624 N-Acetyl-L-glutamate
+argC; N-acetyl-gamma-glutamyl-phosphate reductase [EC:1.2.1.38] [RN:R03443] K00145 M00845 Arginine biosynthesis, glutamate => acetylcitrulline => arginine 1,0 C01250 N-Acetyl-L-glutamate 5-semialdehyde C04133 N-Acetyl-L-glutamate 5-phosphate
+argD; acetylornithine aminotransferase [EC:2.6.1.11] [RN:R02283] K00821 M00845 Arginine biosynthesis, glutamate => acetylcitrulline => arginine 2,0 C00437 N-Acetylornithine C01250 N-Acetyl-L-glutamate 5-semialdehyde
+argF; N-acetylornithine carbamoyltransferase [EC:2.1.3.9] [RN:R07245] K09065 M00845 Arginine biosynthesis, glutamate => acetylcitrulline => arginine 3,0 C15532 N-Acetyl-L-citrulline C00437,C00169 N-Acetylornithine,Carbamoyl phosphate
+argE; acetylornithine deacetylase [EC:3.5.1.16] [RN:R09107] K01438 M00845 Arginine biosynthesis, glutamate => acetylcitrulline => arginine 4,0 C00327 L-Citrulline C15532 N-Acetyl-L-citrulline
+argG; argininosuccinate synthase [EC:6.3.4.5] [RN: R01954] K01940 M00845 Arginine biosynthesis, glutamate => acetylcitrulline => arginine 5,0 C03406 N-(L-Arginino)succinate C00327,C00049 L-Citrulline,L-Aspartate
+argH; argininosuccinate lyase [EC:4.3.2.1] [RN:R01086] K01755 M00845 Arginine biosynthesis, glutamate => acetylcitrulline => arginine 6,0 C00062,C00122 L-Arginine,Fumarate C03406 N-(L-Arginino)succinate
+glutamyl-tRNA synthetase [EC:6.1.1.17] [RN:R05578] K01885 M00846 Siroheme biosynthesis, glutamate => siroheme 0,0 C02987 L-Glutamyl-tRNA(Glu) C00025 L-Glutamate
+glutamyl-tRNA synthetase [EC:6.1.1.17] [RN:R05578] K14163 M00846 Siroheme biosynthesis, glutamate => siroheme 0,1 C02987 L-Glutamyl-tRNA(Glu) C00025 L-Glutamate
+glutamyl-tRNA reductase [EC:1.2.1.70] [RN:R04109] K02492 M00846 Siroheme biosynthesis, glutamate => siroheme 1,0 C03741 (S)-4-Amino-5-oxopentanoate C02987 L-Glutamyl-tRNA(Glu)
+glutamate-1-semialdehyde 2,1-aminomutase [EC:5.4.3.8] [RN:R02272] K01845 M00846 Siroheme biosynthesis, glutamate => siroheme 2,0 C00430 5-Aminolevulinate C03741 (S)-4-Amino-5-oxopentanoate
+porphobilinogen synthase [EC:4.2.1.24] [RN:R00036] K01698 M00846 Siroheme biosynthesis, glutamate => siroheme 3,0 C00931 Porphobilinogen C00430 5-Aminolevulinate
+hydroxymethylbilane synthase [EC:2.5.1.61] [RN:R00084] K01749 M00846 Siroheme biosynthesis, glutamate => siroheme 4,0 C01024 Hydroxymethylbilane C00931 Porphobilinogen
+uroporphyrinogen-III synthase [EC:4.2.1.75] [RN:R03165] K01719 M00846 Siroheme biosynthesis, glutamate => siroheme 5,0 C01051 Uroporphyrinogen III C01024 Hydroxymethylbilane
+uroporphyrinogen-III synthase [EC:4.2.1.75] [RN:R03165] K13542 M00846 Siroheme biosynthesis, glutamate => siroheme 5,1 C01051 Uroporphyrinogen III C01024 Hydroxymethylbilane
+uroporphyrinogen-III synthase [EC:4.2.1.75] [RN:R03165] K13543 M00846 Siroheme biosynthesis, glutamate => siroheme 5,2 C01051 Uroporphyrinogen III C01024 Hydroxymethylbilane
+uroporphyrin-III C-methyltransferase [EC:2.1.1.107] [RN:R03194] K02302 M00846 Siroheme biosynthesis, glutamate => siroheme 6,0 C02463 Precorrin 2 C01051 Uroporphyrinogen III
+uroporphyrin-III C-methyltransferase [EC:2.1.1.107] [RN:R03194] K00589 M00846 Siroheme biosynthesis, glutamate => siroheme 6,1 C02463 Precorrin 2 C01051 Uroporphyrinogen III
+uroporphyrin-III C-methyltransferase [EC:2.1.1.107] [RN:R03194] K02303 M00846 Siroheme biosynthesis, glutamate => siroheme 6,1 C02463 Precorrin 2 C01051 Uroporphyrinogen III
+uroporphyrin-III C-methyltransferase [EC:2.1.1.107] [RN:R03194] K02496 M00846 Siroheme biosynthesis, glutamate => siroheme 6,1 C02463 Precorrin 2 C01051 Uroporphyrinogen III
+uroporphyrinogen-III synthase [EC:4.2.1.75] [RN:R03165] K13542 M00846 Siroheme biosynthesis, glutamate => siroheme 6,1 C01051 Uroporphyrinogen III C01024 Hydroxymethylbilane
+uroporphyrinogen-III synthase [EC:4.2.1.75] [RN:R03165] K13543 M00846 Siroheme biosynthesis, glutamate => siroheme 6,1 C01051 Uroporphyrinogen III C01024 Hydroxymethylbilane
+precorrin-2 dehydrogenase [EC:1.3.1.76] [RN:R03947] K02304 M00846 Siroheme biosynthesis, glutamate => siroheme 6,1 C05778 Sirohydrochlorin C02463 Precorrin 2
+sirohydrochlorin ferrochelatase [EC:4.99.1.4] [RN:R02864] K03794 M00846 Siroheme biosynthesis, glutamate => siroheme 6,1 C00748 Siroheme C05778 Sirohydrochlorin
+ahbAB; siroheme decarboxylase [RN:R12000] K22225 M00847 Heme biosynthesis, archaea, siroheme => heme 0,0 C21835 12,18-Didecarboxysiroheme C00748 Siroheme
+ahbC; 12,18-didecarboxysiroheme decarboxylase [RN:R12001] K22226 M00847 Heme biosynthesis, archaea, siroheme => heme 1,0 C21284 Fe-coproporphyrin III C21835 12,18-Didecarboxysiroheme
+ahbD; heme synthase [RN:R12002] K22227 M00847 Heme biosynthesis, archaea, siroheme => heme 2,0 C00032 Heme C21284 Fe-coproporphyrin III
+auaEII; anthranilate-CoA ligase [EC:6.2.1.32] [RN:R00982] K09460 M00848 Aurachin biosynthesis, anthranilate => aurachin A 0,0 C02247 Anthraniloyl-CoA C00108 Anthranilate
+auaB; acyl carrier protein [RN:R12049] K02078 M00848 Aurachin biosynthesis, anthranilate => aurachin A 1,0 C21873 2-Methylquinolin-4-ol C02247 Anthraniloyl-CoA
+auaC; PKS ketosynthase (KS/KS alpha) [EC:2.3.1.-] [RN:R12049] K14245 M00848 Aurachin biosynthesis, anthranilate => aurachin A 1,0 C21873 2-Methylquinolin-4-ol C02247 Anthraniloyl-CoA
+auaD; PKS chain-length factor (CLF/KS beta) [EC:2.3.1.-] [RN:R12049] K14246 M00848 Aurachin biosynthesis, anthranilate => aurachin A 1,0 C21873 2-Methylquinolin-4-ol C02247 Anthraniloyl-CoA
+auaE; anthranilate-CoA-ACP transferase [EC:6.2.1.-] [RN:R12049] K22798 M00848 Aurachin biosynthesis, anthranilate => aurachin A 1,0 C21873 2-Methylquinolin-4-ol C02247 Anthraniloyl-CoA
+auaA; 2-methyl-4-hydroxyquinoline prenyltransferase [EC:2.5.1.-] [RN:R12050] K22799 M00848 Aurachin biosynthesis, anthranilate => aurachin A 2,0 C10641 Aurachin D C21873 2-Methylquinolin-4-ol
+auaF; aurachin D monooxygenase [EC:1.14.13.-] [RN:R12051] K22800 M00848 Aurachin biosynthesis, anthranilate => aurachin A 3,0 C21330 Aurachin C C10641 Aurachin D
+auaG; aurachin C monooxygenase/isomerase [EC:1.14.13.222] [RN:R11382 R11383] K21272 M00848 Aurachin biosynthesis, anthranilate => aurachin A 4,0 C21141 4-Hydroxy-2-methyl-3-oxo-4-[(2E,6E)-farnesyl]-3,4-dihydroquinoline 1-oxide C21330 Aurachin C
+auaH; aurachin B dehydrogenase [EC:1.1.1.394] [RN:R11149] K21271 M00848 Aurachin biosynthesis, anthranilate => aurachin A 5,0 C21140 Aurachin B C21141 4-Hydroxy-2-methyl-3-oxo-4-[(2E,6E)-farnesyl]-3,4-dihydroquinoline 1-oxide
+auaJ; aurachin B monooxygenase [EC:1.14.13.-] [RN:R12052 R12053] K22801 M00848 Aurachin biosynthesis, anthranilate => aurachin A 6,0 C21874 Aurachin B epoxide C21140 Aurachin B
+auaI; aurichin B epoxide hydrolase [RN:R12054] K22802 M00848 Aurachin biosynthesis, anthranilate => aurachin A 7,0 C21875 Aurachin A C21874 Aurachin B epoxide
+acetyl-CoA C-acetyltransferase [EC:2.3.1.9] [RN:R00238] K00626 M00849 C5 isoprenoid biosynthesis, mevalonate pathway, archaea 0,0 C00332 Acetoacetyl-CoA C00024 Acetyl-CoA
+hydroxymethylglutaryl-CoA synthase [EC:2.3.3.10] [RN:R01978] K01641 M00849 C5 isoprenoid biosynthesis, mevalonate pathway, archaea 1,0 C00356 (S)-3-Hydroxy-3-methylglutaryl-CoA C00332,C00024 Acetoacetyl-CoA,Acetyl-CoA
+hydroxymethylglutaryl-CoA reductase (NADPH) [EC:1.1.1.34] [RN:R02082] K00021 M00849 C5 isoprenoid biosynthesis, mevalonate pathway, archaea 2,0 C00418 (R)-Mevalonate C00356 (S)-3-Hydroxy-3-methylglutaryl-CoA
+hydroxymethylglutaryl-CoA reductase [EC:1.1.1.88] [RN:R02081] K00054 M00849 C5 isoprenoid biosynthesis, mevalonate pathway, archaea 2,1 C00418 (R)-Mevalonate C00356 (S)-3-Hydroxy-3-methylglutaryl-CoA
+mevalonate kinase [EC:2.7.1.36] [RN:R02245] K00869 M00849 C5 isoprenoid biosynthesis, mevalonate pathway, archaea 3,0,0,0 C01107 (R)-5-Phosphomevalonate C00418 (R)-Mevalonate
+phosphomevalonate decarboxylase [EC:4.1.1.99] [RN:R10561] K17942 M00849 C5 isoprenoid biosynthesis, mevalonate pathway, archaea 3,0,1,0 C20345 Isopentenyl phosphate C01107 (R)-5-Phosphomevalonate
+mevalonate-3-kinase [EC:2.7.1.185] [RN:R10779] K18689 M00849 C5 isoprenoid biosynthesis, mevalonate pathway, archaea 3,1,0,0 C20847 (R)-Mevalonate 3-phosphate C00418 (R)-Mevalonate
+mevalonate-3-phosphate-5-kinase [EC:2.7.1.186] [RN:R10780] K18690 M00849 C5 isoprenoid biosynthesis, mevalonate pathway, archaea 3,1,1,0 C20848 (R)-Mevalonate 3,5-bisphosphate C20847 (R)-Mevalonate 3-phosphate
+bisphosphomevalonate decarboxylase [EC:4.1.1.110] [RN:R10781] K22813 M00849 C5 isoprenoid biosynthesis, mevalonate pathway, archaea 3,1,2,0 C20345 Isopentenyl phosphate C20848 (R)-Mevalonate 3,5-bisphosphate
+isopentenyl phosphate kinase [EC:2.7.4.26] [RN:R10093] K06981 M00849 C5 isoprenoid biosynthesis, mevalonate pathway, archaea 4,0 C00129 Isopentenyl diphosphate C20345 Isopentenyl phosphate
+isopentenyl-diphosphate Delta-isomerase [EC:5.3.3.2] [RN:R01123] K01823 M00849 C5 isoprenoid biosynthesis, mevalonate pathway, archaea 5,0 C00235 Dimethylallyl diphosphate C00129 Isopentenyl diphosphate
+ctxA; cholera enterotoxin subunit A [EC:2.4.2.36] K10928 M00850 Vibrio cholerae pathogenicity signature, cholera toxins 0,0
+ctxB; cholera enterotoxin subunit B K10929 M00850 Vibrio cholerae pathogenicity signature, cholera toxins 0,0
+zot; zona occludens toxin K10954 M00850 Vibrio cholerae pathogenicity signature, cholera toxins 1,0
+ace; accessory cholera enterotoxin K10952 M00850 Vibrio cholerae pathogenicity signature, cholera toxins 2,0
+rtxA; RTX toxin RtxA K10953 M00850 Vibrio cholerae pathogenicity signature, cholera toxins 3,0
+hlyA; hemolysin K10948 M00850 Vibrio cholerae pathogenicity signature, cholera toxins 4,0
+tlh; thermolabile hemolysin K11018 M00850 Vibrio cholerae pathogenicity signature, cholera toxins 5,0
+blaKPC; beta-lactamase class A KPC [EC:3.5.2.6] K18768 M00851 Carbapenem resistance 0,0
+blaGES; beta-lactamase class A GES [EC:3.5.2.6] K18970 M00851 Carbapenem resistance 0,1
+blaIMI; beta-lactamase class A IMI [EC:3.5.2.6] K19316 M00851 Carbapenem resistance 0,2
+blaSME; beta-lactamase class A SME [EC:3.5.2.6] K22346 M00851 Carbapenem resistance 0,3
+blaOXA-51; beta-lactamase class D OXA-51 [EC:3.5.2.6] K18794 M00851 Carbapenem resistance 0,4
+blaOXA-213; beta-lactamase class D OXA-213 [EC:3.5.2.6] K19318 M00851 Carbapenem resistance 0,5
+blaOXA-24; beta-lactamase class D OXA-24 [EC:3.5.2.6] K18971 M00851 Carbapenem resistance 0,6
+blaOXA-23; beta-lactamase class D OXA-23 [EC:3.5.2.6] K18793 M00851 Carbapenem resistance 0,7
+blaOXA-134; beta-lactamase class D OXA-134 [EC:3.5.2.6] K19319 M00851 Carbapenem resistance 0,8
+blaOXA-211; beta-lactamase class D OXA-211 [EC:3.5.2.6] K19320 M00851 Carbapenem resistance 0,9
+blaOXA-214; beta-lactamase class D OXA-214 [EC:3.5.2.6] K19321 M00851 Carbapenem resistance 0,10
+blaOXA-229; beta-lactamase class D OXA-229 [EC:3.5.2.6] K19322 M00851 Carbapenem resistance 0,11
+blaOXA-58; beta-lactamase class D OXA-58 [EC:3.5.2.6] K18972 M00851 Carbapenem resistance 0,12
+blaOXA-62; beta-lactamase class D OXA-62 [EC:3.5.2.6] K19211 M00851 Carbapenem resistance 0,13
+blaOXA-48; beta-lactamase class D OXA-48 [EC:3.5.2.6] K18976 M00851 Carbapenem resistance 0,14
+blaOXA-60; beta-lactamase class D OXA-60 [EC:3.5.2.6] K21277 M00851 Carbapenem resistance 0,15
+blaIMP; metallo-beta-lactamase class B IMP [EC:3.5.2.6] K18782 M00851 Carbapenem resistance 0,16
+blaVIM; metallo-beta-lactamase class B VIM [EC:3.5.2.6] K18781 M00851 Carbapenem resistance 0,17
+blaNDM; metallo-beta-lactamase class B NDM [EC:3.5.2.6] K18780 M00851 Carbapenem resistance 0,18
+blaGIM; metallo-beta-lactamase class B GIM [EC:3.5.2.6] K19099 M00851 Carbapenem resistance 0,19
+blaIND; metallo-beta-lactamase class B IND [EC:3.5.2.6] K19216 M00851 Carbapenem resistance 0,20
+tcpI; toxin coregulated pilus biosynthesis protein I K10961 M00852 Vibrio cholerae pathogenicity signature, toxin coregulated pilus 0,0
+tcpP; toxin coregulated pilus biosynthesis protein P K10920 M00852 Vibrio cholerae pathogenicity signature, toxin coregulated pilus 1,0
+tcpH; toxin coregulated pilus biosynthesis protein H K10919 M00852 Vibrio cholerae pathogenicity signature, toxin coregulated pilus 2,0
+tcpA; toxin coregulated pilin K10930 M00852 Vibrio cholerae pathogenicity signature, toxin coregulated pilus 3,0
+tcpB; toxin coregulated pilus biosynthesis protein B K10931 M00852 Vibrio cholerae pathogenicity signature, toxin coregulated pilus 4,0
+tcpQ; toxin coregulated pilus biosynthesis protein Q K10962 M00852 Vibrio cholerae pathogenicity signature, toxin coregulated pilus 5,0
+tcpC; toxin coregulated pilus biosynthesis outer membrane protein C K10932 M00852 Vibrio cholerae pathogenicity signature, toxin coregulated pilus 6,0
+tcpR; toxin coregulated pilus biosynthesis protein R K10963 M00852 Vibrio cholerae pathogenicity signature, toxin coregulated pilus 7,0
+tcpD; toxin coregulated pilus biosynthesis protein D K10933 M00852 Vibrio cholerae pathogenicity signature, toxin coregulated pilus 8,0
+tcpS; toxin coregulated pilus biosynthesis protein S K10964 M00852 Vibrio cholerae pathogenicity signature, toxin coregulated pilus 9,0
+tcpT; toxin coregulated pilus biosynthesis protein T K10965 M00852 Vibrio cholerae pathogenicity signature, toxin coregulated pilus 10,0
+tcpE; toxin coregulated pilus biosynthesis protein E K10934 M00852 Vibrio cholerae pathogenicity signature, toxin coregulated pilus 11,0
+tcpF; toxin coregulated pilus biosynthesis protein F K10935 M00852 Vibrio cholerae pathogenicity signature, toxin coregulated pilus 12,0
+tcpJ; toxin coregulated pilus biosynthesis protein J [EC:3.4.23.43 2.1.1.-] K10966 M00852 Vibrio cholerae pathogenicity signature, toxin coregulated pilus 13,0
+cfaA; CFA/I fimbrial subunit A K22850 M00853 ETEC pathogenicity signature, colonization factors 0,0
+cfaB; CFA/I fimbrial subunit B K22851 M00853 ETEC pathogenicity signature, colonization factors 1,0
+cfaC; CFA/I fimbrial subunit C K22852 M00853 ETEC pathogenicity signature, colonization factors 2,0
+cfaE; CFA/I fimbrial subunit E K22853 M00853 ETEC pathogenicity signature, colonization factors 3,0
+cfaD; CFA/I fimbrial subunit D K22854 M00853 ETEC pathogenicity signature, colonization factors 4,0
+UTP--glucose-1-phosphate uridylyltransferase [EC:2.7.7.9] [RN:R00289] K00963 M00854 Glycogen biosynthesis, glucose-1P => glycogen/starch 0,0,0,0 C00029 UDP-glucose C00103 D-Glucose 1-phosphate
+glycogen synthase [EC:2.4.1.11] [RN:R00292] K00693 M00854 Glycogen biosynthesis, glucose-1P => glycogen/starch 0,0,1,0 C00718 Amylose C00029 UDP-glucose
+glycogen synthase [EC:2.4.1.11] [RN:R00292] K00750 M00854 Glycogen biosynthesis, glucose-1P => glycogen/starch 0,0,1,0 C00718 Amylose C00029 UDP-glucose
+glycogen synthase [EC:2.4.1.11] [RN:R00292] K16150 M00854 Glycogen biosynthesis, glucose-1P => glycogen/starch 0,0,1,1 C00718 Amylose C00029 UDP-glucose
+glycogen synthase [EC:2.4.1.11] [RN:R00292] K16153 M00854 Glycogen biosynthesis, glucose-1P => glycogen/starch 0,0,1,2 C00718 Amylose C00029 UDP-glucose
+granule-bound starch synthase [EC:2.4.1.242] [RN:R02421] K13679 M00854 Glycogen biosynthesis, glucose-1P => glycogen/starch 0,0,1,3 C00718 Amylose C00498 ADP-glucose
+granule-bound starch synthase [EC:2.4.1.242] [RN:R02421] K20812 M00854 Glycogen biosynthesis, glucose-1P => glycogen/starch 0,0,1,4 C00718 Amylose C00498 ADP-glucose
+glucose-1-phosphate adenylyltransferase [EC:2.7.7.27] [RN:R00948] K00975 M00854 Glycogen biosynthesis, glucose-1P => glycogen/starch 0,1,0,0 C00498 ADP-glucose C00103 D-Glucose 1-phosphate
+starch synthase [EC:2.4.1.21] [RN:R02421] K00703 M00854 Glycogen biosynthesis, glucose-1P => glycogen/starch 0,1,1,0 C00718 Amylose C00498 ADP-glucose
+granule-bound starch synthase [EC:2.4.1.242] [RN:R02421] K13679 M00854 Glycogen biosynthesis, glucose-1P => glycogen/starch 0,1,1,1 C00718 Amylose C00498 ADP-glucose
+granule-bound starch synthase [EC:2.4.1.242] [RN:R02421] K20812 M00854 Glycogen biosynthesis, glucose-1P => glycogen/starch 0,1,1,2 C00718 Amylose C00498 ADP-glucose
+1,4-alpha-glucan branching enzyme [EC:2.4.1.18] [RN:R02110] K00700 M00854 Glycogen biosynthesis, glucose-1P => glycogen/starch 1,0 C00369 Starch C00718 Amylose
+1,4-alpha-glucan branching enzyme [EC:2.4.1.18] [RN:R02110] K16149 M00854 Glycogen biosynthesis, glucose-1P => glycogen/starch 1,1 C00369 Starch C00718 Amylose
+glycogen phosphorylase [EC:2.4.1.1] [RN:R02111] K00688 M00855 Glycogen degradation, glycogen => glucose-6P 0,0 C00103 D-Glucose 1-phosphate C00369 Starch
+glycogen phosphorylase [EC:2.4.1.1] [RN:R02111] K16153 M00855 Glycogen degradation, glycogen => glucose-6P 0,1 C00103 D-Glucose 1-phosphate C00369 Starch
+glycogen debranching enzyme [EC:2.4.1.25 3.2.1.33] [RN:R02111] K01196 M00855 Glycogen degradation, glycogen => glucose-6P 1,0 C00103 D-Glucose 1-phosphate C00369 Starch
+4-alpha-glucanotransferase [EC:2.4.1.25] [RN:R02111] K00705 M00855 Glycogen degradation, glycogen => glucose-6P 1,1,0,0 C00103 D-Glucose 1-phosphate C00369 Starch
+4-alpha-glucanotransferase [EC:2.4.1.25] [RN:R02111] K22451 M00855 Glycogen degradation, glycogen => glucose-6P 1,1,0,1 C00103 D-Glucose 1-phosphate C00369 Starch
+glycogen debranching enzyme [EC:3.2.1.196] [RN:R02111] K02438 M00855 Glycogen degradation, glycogen => glucose-6P 1,1,1,0 C00103 D-Glucose 1-phosphate C00369 Starch
+pullulanase [EC:3.2.1.41] [COG:COG1523] [RN:R02111] K01200 M00855 Glycogen degradation, glycogen => glucose-6P 1,1,1,1 C00103 D-Glucose 1-phosphate C00369 Starch
+phosphoglucomutase [EC:5.4.2.2] [RN:R08639] K15779 M00855 Glycogen degradation, glycogen => glucose-6P 2,0 C00092 D-Glucose 6-phosphate C00103 D-Glucose 1-phosphate
+phosphoglucomutase [EC:5.4.2.2] [RN:R08639] K01835 M00855 Glycogen degradation, glycogen => glucose-6P 2,1 C00092 D-Glucose 6-phosphate C00103 D-Glucose 1-phosphate
+phosphoglucomutase [EC:5.4.2.2] [RN:R08639] K15778 M00855 Glycogen degradation, glycogen => glucose-6P 2,2 C00092 D-Glucose 6-phosphate C00103 D-Glucose 1-phosphate
+cdtB; cytolethal distending toxin subunit B K11014 M00856 Salmonella enterica pathogenicity signature, typhoid toxin 0,0
+ptxA; pertussis toxin subunit 1 [EC:2.4.2.-] K11023 M00856 Salmonella enterica pathogenicity signature, typhoid toxin 1,0
+subB; subtilase cytotoxin, subunit B K19298 M00856 Salmonella enterica pathogenicity signature, typhoid toxin 2,0
+ttsA; typhoid toxin secretion A K22918 M00856 Salmonella enterica pathogenicity signature, typhoid toxin 3,0
+tviA; Vi polysaccharide biosynthesis protein TviA K22914 M00857 Salmonella enterica pathogenicity signature, Vi antigen 0,0
+tviB; UDP-N-acetylglucosamine 6-dehydrogenase [EC:1.1.1.136] K22926 M00857 Salmonella enterica pathogenicity signature, Vi antigen 1,0
+tviC; UDP-N-acetylglucosaminuronic acid 4-epimerase [EC:5.1.3.-] K22925 M00857 Salmonella enterica pathogenicity signature, Vi antigen 2,0
+tviD; Vi polysaccharide biosynthesis protein TviD K22915 M00857 Salmonella enterica pathogenicity signature, Vi antigen 3,0
+tviE; Vi polysaccharide biosynthesis protein TviE K22916 M00857 Salmonella enterica pathogenicity signature, Vi antigen 4,0
+vexE; Vi polysaccharide export protein VexE K22917 M00857 Salmonella enterica pathogenicity signature, Vi antigen 5,0
+vexA; Vi polysaccharide export protein VexA K22924 M00857 Salmonella enterica pathogenicity signature, Vi antigen 6,0
+vexB; Vi polysaccharide transport system permease protein K22921 M00857 Salmonella enterica pathogenicity signature, Vi antigen 6,0
+vexC; Vi polysaccharide transport system ATP-binding protein [EC:3.6.3.38] K22923 M00857 Salmonella enterica pathogenicity signature, Vi antigen 6,0
+vexD; Vi polysaccharide transport system permease protein K22922 M00857 Salmonella enterica pathogenicity signature, Vi antigen 6,0
+pagA; protective antigen K11030 M00859 Bacillus anthracis pathogenicity signature, anthrax toxin 0,0
+lef; anthrax lethal toxin endopeptidase [EC:3.4.24.83] K08645 M00859 Bacillus anthracis pathogenicity signature, anthrax toxin 1,0
+cyaA; anthrax edema toxin adenylate cyclase [EC:4.6.1.1] K11029 M00859 Bacillus anthracis pathogenicity signature, anthrax toxin 2,0
+atxA; anthrax toxin expression trans-acting positive regulator K22976 M00860 Bacillus anthracis pathogenicity signature, polyglutamic acid capsule biosynthesis 0,0
+acpA; capsule synthesis positive regulator AcpA K22977 M00860 Bacillus anthracis pathogenicity signature, polyglutamic acid capsule biosynthesis 1,0
+acpB; capsule synthesis positive regulator AcpB K22980 M00860 Bacillus anthracis pathogenicity signature, polyglutamic acid capsule biosynthesis 2,0
+capA; gamma-polyglutamate biosynthesis protein CapA K07282 M00860 Bacillus anthracis pathogenicity signature, polyglutamic acid capsule biosynthesis 3,0
+capC; gamma-polyglutamate biosynthesis protein CapC K22116 M00860 Bacillus anthracis pathogenicity signature, polyglutamic acid capsule biosynthesis 4,0
+capB; gamma-polyglutamate synthase [EC:6.3.2.-] K01932 M00860 Bacillus anthracis pathogenicity signature, polyglutamic acid capsule biosynthesis 5,0
+capE; gamma-polyglutamate biosynthesis protein CapE K22981 M00860 Bacillus anthracis pathogenicity signature, polyglutamic acid capsule biosynthesis 6,0
+acyl-CoA oxidase [EC:1.3.3.6] [RN:R07934 R07950] K00232 M00861 beta-Oxidation, peroxisome, VLCFA 0,0 C16387 (2E,6Z,9Z,12Z,15Z,18Z)-Tetracosahexaenoyl-CoA C16172 (6Z,9Z,12Z,15Z,18Z)-Tetracosapentaenoyl-CoA
+(3R)-3-hydroxyacyl-CoA dehydrogenase / enoyl-CoA hydratase 2 [EC:1.1.1.- 4.2.1.119] [RN:R07935 R07936 R07951 R07952] K12405 M00861 beta-Oxidation, peroxisome, VLCFA 1,0 C16389 (6Z,9Z,12Z,15Z,18Z)-3-Oxotetracosapentaenoyl-CoA C16388 (3R,6Z,9Z,12Z,15Z,18Z)-3-Hydroxytetracosapentaenoyl-CoA
+acetyl-CoA acyltransferase 1 [EC:2.3.1.16] [RN:R07937 R07953] K07513 M00861 beta-Oxidation, peroxisome, VLCFA 2,0 C16173 (4Z,7Z,10Z,13Z,16Z)-Docosapentaenoyl-CoA C16389 (6Z,9Z,12Z,15Z,18Z)-3-Oxotetracosapentaenoyl-CoA
+sterol carrier protein 2 [EC:2.3.1.176] [RN:R07937 R07953] K08764 M00861 beta-Oxidation, peroxisome, VLCFA 2,1 C16173 (4Z,7Z,10Z,13Z,16Z)-Docosapentaenoyl-CoA C16389 (6Z,9Z,12Z,15Z,18Z)-3-Oxotetracosapentaenoyl-CoA
+3alpha,7alpha,12alpha-trihydroxy-5beta-cholestanoyl-CoA 24-hydroxylase [EC:1.17.99.3] [RN:R08735 R08740] K10214 M00862 beta-Oxidation, peroxisome, tri/dihydroxycholestanoyl-CoA => choloyl/chenodeoxycholoyl-CoA 0,0 C05447 (24E)-3alpha,7alpha-Dihydroxy-5beta-cholest-24-enoyl-CoA C17346 (25S)-3alpha,7alpha-Dihydroxy-5beta-cholestanoyl-CoA
+(3R)-3-hydroxyacyl-CoA dehydrogenase / 3a,7a,12a-trihydroxy-5b-cholest-24-enoyl-CoA hydratase [EC:1.1.1.- 4.2.1.107] [RN:R04813 R04812 R04809 R04810] K12405 M00862 beta-Oxidation, peroxisome, tri/dihydroxycholestanoyl-CoA => choloyl/chenodeoxycholoyl-CoA 1,0 C05449 3alpha,7alpha-Dihydroxy-5beta-24-oxocholestanoyl-CoA C05448 (24R,25R)-3alpha,7alpha,24-Trihydroxy-5beta-cholestanoyl-CoA
+sterol carrier protein 2 [EC:2.3.1.176] [RN:R03719 R04811] K08764 M00862 beta-Oxidation, peroxisome, tri/dihydroxycholestanoyl-CoA => choloyl/chenodeoxycholoyl-CoA 2,0 C05337 Chenodeoxycholoyl-CoA C05449 3alpha,7alpha-Dihydroxy-5beta-24-oxocholestanoyl-CoA
+lpxA; UDP-N-acetylglucosamine acyltransferase [EC:2.3.1.129] K00677 M00866 KDO2-lipid A biosynthesis, Raetz pathway, non-LpxL-LpxM type 0,0
+lpxC; UDP-3-O-[3-hydroxymyristoyl] N-acetylglucosamine deacetylase [EC:3.5.1.108] K02535 M00866 KDO2-lipid A biosynthesis, Raetz pathway, non-LpxL-LpxM type 1,0
+lpxC-fabZ; UDP-3-O-[3-hydroxymyristoyl] N-acetylglucosamine deacetylase / 3-hydroxyacyl-[acyl-carrier-protein] dehydratase [EC:3.5.1.108 4.2.1.59] K16363 M00866 KDO2-lipid A biosynthesis, Raetz pathway, non-LpxL-LpxM type 1,1
+lpxD; UDP-3-O-[3-hydroxymyristoyl] glucosamine N-acyltransferase [EC:2.3.1.191] K02536 M00866 KDO2-lipid A biosynthesis, Raetz pathway, non-LpxL-LpxM type 2,0
+lpxH; UDP-2,3-diacylglucosamine hydrolase [EC:3.6.1.54] K03269 M00866 KDO2-lipid A biosynthesis, Raetz pathway, non-LpxL-LpxM type 3,0
+lpxB; lipid-A-disaccharide synthase [EC:2.4.1.182] K00748 M00866 KDO2-lipid A biosynthesis, Raetz pathway, non-LpxL-LpxM type 4,0
+lpxK; tetraacyldisaccharide 4'-kinase [EC:2.7.1.130] K00912 M00866 KDO2-lipid A biosynthesis, Raetz pathway, non-LpxL-LpxM type 5,0
+kdtA; 3-deoxy-D-manno-octulosonic-acid transferase [EC:2.4.99.12 2.4.99.13 2.4.99.14 2.4.99.15] K02527 M00866 KDO2-lipid A biosynthesis, Raetz pathway, non-LpxL-LpxM type 6,0
+lpxL, htrB; Kdo2-lipid IVA lauroyltransferase/acyltransferase [EC:2.3.1.241 2.3.1.-] K02517 M00866 KDO2-lipid A biosynthesis, Raetz pathway, non-LpxL-LpxM type 7,0
+lpxJ; Kdo2-lipid IVA 3' secondary acyltransferase [EC:2.3.1.-] K09778 M00866 KDO2-lipid A biosynthesis, Raetz pathway, non-LpxL-LpxM type 8,0
+lpxE; lipid A 1-phosphatase [EC:3.1.3.-] [RN:R12201] K12977 M00867 KDO2-lipid A modification pathway 0,0 C21994 1-Dephospho-KDO2-lipid A C21988 H. pylori KDO2-lipid A
+eptA; lipid A ethanolaminephosphotransferase [EC:2.7.8.43] [RN:R12202] K03760 M00867 KDO2-lipid A modification pathway 1,0 C21995 1-PEtN-KDO2-lipid A C21994 1-Dephospho-KDO2-lipid A
+kdoH1; 3-deoxy-D-manno-octulosonic acid-hydrolase [EC:3.2.1.144] [RN:R12219] K23082 M00867 KDO2-lipid A modification pathway 2,0 C21996,C01187 1-PEtN-KDO-lipid A,3-Deoxy-D-manno-octulosonate C21995 1-PEtN-KDO2-lipid A
+kdoH2; 3-deoxy-D-manno-octulosonic acid-hydrolase [RN:R12219] K23083 M00867 KDO2-lipid A modification pathway 2,0 C21996,C01187 1-PEtN-KDO-lipid A,3-Deoxy-D-manno-octulosonate C21995 1-PEtN-KDO2-lipid A
+lpxF; lipid A 4'-phosphatase [EC:3.1.3.-] [RN:R12203] K23159 M00867 KDO2-lipid A modification pathway 3,0 C21997 4'-Dephosphorylated 1-PEtN-KDO-lipid A C21996 1-PEtN-KDO-lipid A
+lpxR; lipid A 3-O-deacylase [EC:3.1.1.-] [RN:R12204] K09953 M00867 KDO2-lipid A modification pathway 4,0 C21998 H. pylori KDO-lipid A C21997 4'-Dephosphorylated 1-PEtN-KDO-lipid A
+5-aminolevulinate synthase [EC:2.3.1.37] [RN:R00830] K00643 M00868 Heme biosynthesis, animals and fungi, glycine => heme 0,0 C00430 5-Aminolevulinate C00037 Glycine
+porphobilinogen synthase [EC:4.2.1.24] [RN:R00036] K01698 M00868 Heme biosynthesis, animals and fungi, glycine => heme 1,0 C00931 Porphobilinogen C00430 5-Aminolevulinate
+hydroxymethylbilane synthase [EC:2.5.1.61] [RN:R00084] K01749 M00868 Heme biosynthesis, animals and fungi, glycine => heme 2,0 C01024 Hydroxymethylbilane C00931 Porphobilinogen
+uroporphyrinogen-III synthase [EC:4.2.1.75] [RN:R03165] K01719 M00868 Heme biosynthesis, animals and fungi, glycine => heme 3,0 C01051 Uroporphyrinogen III C01024 Hydroxymethylbilane
+uroporphyrinogen decarboxylase [EC:4.1.1.37] [RN:R03197] K01599 M00868 Heme biosynthesis, animals and fungi, glycine => heme 4,0 C03263 Coproporphyrinogen III C01051 Uroporphyrinogen III
+coproporphyrinogen III oxidase [EC:1.3.3.3] [RN:R03220] K00228 M00868 Heme biosynthesis, animals and fungi, glycine => heme 5,0 C01079 Protoporphyrinogen IX C03263 Coproporphyrinogen III
+protoporphyrinogen/coproporphyrinogen III oxidase [EC:1.3.3.4] [RN:R03222] K00231 M00868 Heme biosynthesis, animals and fungi, glycine => heme 6,0 C02191 Protoporphyrin C01079 Protoporphyrinogen IX
+protoporphyrin/coproporphyrin ferrochelatase [EC:4.99.1.1] [RN:R00310] K01772 M00868 Heme biosynthesis, animals and fungi, glycine => heme 7,0 C00032 Heme C02191 Protoporphyrin
+FKTN; fukutin [EC:2.7.8.-] [RN:R12294] K19872 M00872 O-glycan biosynthesis, mannose type (core M3) 0,0 G13093 C00789,G13092 CDP-ribitol,Phospho-core M3
+FKRP; fukutin-related protein [EC:2.7.8.-] [RN:R12295] K19873 M00872 O-glycan biosynthesis, mannose type (core M3) 1,0 G13094 G13093
+TMEM5; alpha-dystroglycan beta1,4-xylosyltransferase [EC:2.4.2.61] [RN:R12244] K21052 M00872 O-glycan biosynthesis, mannose type (core M3) 2,0 G13095 G13094
+B4GAT1; beta-1,4-glucuronyltransferase 1 [EC:2.4.1.-] [RN:R12296] K21032 M00872 O-glycan biosynthesis, mannose type (core M3) 3,0 G13096 G13095
+LARGE; glycosyltransferase-like protein LARGE [EC:2.4.2.- 2.4.1.-] [RN:R12297 R12298] K09668 M00872 O-glycan biosynthesis, mannose type (core M3) 4,0 G13098 G13097
+malonyl-CoA/methylmalonyl-CoA synthetase [EC:6.2.1.-] K18660 M00873 Fatty acid biosynthesis in mitochondria, animals 0,0
+NADH dehydrogenase (ubiquinone) 1 alpha/beta subcomplex 1, acyl-carrier protein K03955 M00873 Fatty acid biosynthesis in mitochondria, animals 1,0
+[acyl-carrier-protein] S-malonyltransferase [EC:2.3.1.39] K00645 M00873 Fatty acid biosynthesis in mitochondria, animals 1,0
+3-oxoacyl-[acyl-carrier-protein] synthase II [EC:2.3.1.179] K09458 M00873 Fatty acid biosynthesis in mitochondria, animals 2,0
+3-oxoacyl-[acyl-carrier protein] reductase [EC:1.1.1.-] K11539 M00873 Fatty acid biosynthesis in mitochondria, animals 3,0
+3-oxoacyl-[acyl-carrier protein] reductase [EC:1.1.1.-] K13370 M00873 Fatty acid biosynthesis in mitochondria, animals 3,0
+3-hydroxyacyl-thioester dehydratase, animal type [EC:4.2.1.-] K22540 M00873 Fatty acid biosynthesis in mitochondria, animals 4,0
+mitochondrial enoyl-[acyl-carrier protein] reductase [EC:1.3.1.-] K07512 M00873 Fatty acid biosynthesis in mitochondria, animals 5,0
+acetyl-CoA carboxylase / biotin carboxylase 1 [EC:6.4.1.2] K11262 M00874 Fatty acid biosynthesis in mitochondria, fungi 0,0
+NADH dehydrogenase (ubiquinone) 1 alpha/beta subcomplex 1, acyl-carrier protein K03955 M00874 Fatty acid biosynthesis in mitochondria, fungi 1,0
+[acyl-carrier-protein] S-malonyltransferase [EC:2.3.1.39] K00645 M00874 Fatty acid biosynthesis in mitochondria, fungi 1,0
+3-oxoacyl-[acyl-carrier-protein] synthase II [EC:2.3.1.179] K09458 M00874 Fatty acid biosynthesis in mitochondria, fungi 2,0
+3-oxoacyl-[acyl-carrier protein] reductase [EC:1.1.1.100] K00059 M00874 Fatty acid biosynthesis in mitochondria, fungi 3,0
+3-hydroxyacyl-thioester dehydratase, fungi type [EC:4.2.1.-] K22541 M00874 Fatty acid biosynthesis in mitochondria, fungi 4,0
+mitochondrial enoyl-[acyl-carrier protein] reductase [EC:1.3.1.-] K07512 M00874 Fatty acid biosynthesis in mitochondria, fungi 5,0
+sbnI; L-serine kinase (ATP) / ParB family transcriptional regulator, heme-responsive regulator [EC:2.7.1.225] [RN:R12344] K23371 M00875 Staphyloferrin B biosynthesis, L-serine => staphyloferrin B 0,0 C01005 O-Phospho-L-serine C00065 L-Serine
+sbnA; N-(2-amino-2-carboxyethyl)-L-glutamate synthase [EC:2.5.1.140] [RN:R11705] K21949 M00875 Staphyloferrin B biosynthesis, L-serine => staphyloferrin B 1,0 C21559 N-[(2S)-2-Amino-2-carboxyethyl]-L-glutamate C01005 O-Phospho-L-serine
+sbnB; N-[(2S)-2-amino-2-carboxyethyl]-L-glutamate dehydrogenase [EC:1.5.1.51] [RN:11655] K21721 M00875 Staphyloferrin B biosynthesis, L-serine => staphyloferrin B 2,0 C03401 L-2,3-Diaminopropanoate C21559 N-[(2S)-2-Amino-2-carboxyethyl]-L-glutamate
+sbnE; L-2,3-diaminopropanoate---citrate ligase [EC:6.3.2.54] [RN:R12308] K23372 M00875 Staphyloferrin B biosynthesis, L-serine => staphyloferrin B 3,0 C22072 2-[(L-Alanin-3-ylcarbamoyl)methyl]-2-hydroxybutanedioate C03401 L-2,3-Diaminopropanoate
+sbnH; 2-[(L-alanin-3-ylcarbamoyl)methyl]-2-hydroxybutanedioate decarboxylase [EC:4.1.1.117] [RN:R12309] K23373 M00875 Staphyloferrin B biosynthesis, L-serine => staphyloferrin B 4,0 C22073 2-[(2-Aminoethylcarbamoyl)methyl]-2-hydroxybutanedioate C22072 2-[(L-Alanin-3-ylcarbamoyl)methyl]-2-hydroxybutanedioate
+sbnF; 2-[(L-alanin-3-ylcarbamoyl)methyl]-3-(2-aminoethylcarbamoyl)-2-hydroxypropanoate synthase [EC:6.3.2.55] [RN:R12311] K23374 M00875 Staphyloferrin B biosynthesis, L-serine => staphyloferrin B 5,0 C22074 2-[(L-Alanin-3-ylcarbamoyl)methyl]-3-(2-aminoethylcarbamoyl)-2-hydroxypropanoate C22073 2-[(2-Aminoethylcarbamoyl)methyl]-2-hydroxybutanedioate
+sbnC; staphyloferrin B synthase [EC:6.3.2.56] [RN:R12312] K23375 M00875 Staphyloferrin B biosynthesis, L-serine => staphyloferrin B 6,0 C22075 Staphyloferrin B C22074 2-[(L-Alanin-3-ylcarbamoyl)methyl]-3-(2-aminoethylcarbamoyl)-2-hydroxypropanoate
+orr; ornithine racemase [EC:5.1.1.12] [RN:R00672] K21898 M00876 Staphyloferrin A biosynthesis, L-ornithine => staphyloferrin A 0,0 C00515 D-Ornithine C00077 L-Ornithine
+sfnaD; D-ornithine--citrate ligase [EC:6.3.2.-] [RN:R12353] K23446 M00876 Staphyloferrin A biosynthesis, L-ornithine => staphyloferrin A 1,0 C22101 N5-citryl-D-ornithine C00515 D-Ornithine
+sfnaB; staphyloferrin A synthetase [EC:6.3.2.-] [RN:R12354] K23447 M00876 Staphyloferrin A biosynthesis, L-ornithine => staphyloferrin A 2,0 C22102 Staphyloferrin A C22101 N5-citryl-D-ornithine
+ntdC; glucose-6-phosphate 3-dehydrogenase [EC:1.1.1.361] [RN:R10519] K18652 M00877 Kanosamine biosynthesis glucose 6-phosphate => kanosamine 0,0 C20668 3-Dehydro-D-glucose 6-phosphate C00092 D-Glucose 6-phosphate
+ntdA; 3-dehydro-glucose-6-phosphate---glutamate transaminase [EC:2.6.1.104] [RN:R10698] K18653 M00877 Kanosamine biosynthesis glucose 6-phosphate => kanosamine 1,0 C12213 Kanosamine 6-phosphate C20668 3-Dehydro-D-glucose 6-phosphate
+ntdB; kanosamine-6-phosphate phosphatase [EC:3.1.3.92] [RN:R10547] K18654 M00877 Kanosamine biosynthesis glucose 6-phosphate => kanosamine 2,0 C12212 Kanosamine C12213 Kanosamine 6-phosphate
diff --git a/tests/reference_dbs/human-vaginal-v1.0/functional_profiles_DB/MGYG000303700_clstr.tsv b/tests/reference_dbs/human-vaginal-v1.0/functional_profiles_DB/MGYG000303700_clstr.tsv
new file mode 100644
index 0000000..e57d9bf
--- /dev/null
+++ b/tests/reference_dbs/human-vaginal-v1.0/functional_profiles_DB/MGYG000303700_clstr.tsv
@@ -0,0 +1,1265 @@
+#cluster size = 2
+#contig gene_id start end strand kegg cazy pfam core
+MGYG000303700_1 MGYG000303700_00001 33 719 1 - - - true
+MGYG000303700_1 MGYG000303700_00002 1035 3509 1 - - PF04203 true
+MGYG000303700_1 MGYG000303700_00003 3509 4228 1 K09812 - PF00005 true
+MGYG000303700_1 MGYG000303700_00004 4221 5216 1 K09811 - PF02687 true
+MGYG000303700_1 MGYG000303700_00005 5387 6118 1 K02967 - PF00318 true
+MGYG000303700_1 MGYG000303700_00006 6148 6759 1 K02357 - PF00889 true
+MGYG000303700_1 MGYG000303700_00007 6923 7762 -1 - - - true
+MGYG000303700_1 MGYG000303700_00008 7893 8465 -1 - - - true
+MGYG000303700_1 MGYG000303700_00009 8591 9403 -1 - - - true
+MGYG000303700_1 MGYG000303700_00010 9460 10620 -1 - - - false
+MGYG000303700_1 MGYG000303700_00011 11087 12031 1 - - - false
+MGYG000303700_1 MGYG000303700_00012 12128 12781 1 K07100 - PF00156 true
+MGYG000303700_1 MGYG000303700_00013 12868 13158 1 - - - true
+MGYG000303700_1 MGYG000303700_00014 13155 14981 1 K07462 - PF02272,PF10141,PF01368 true
+MGYG000303700_1 MGYG000303700_00015 15103 17079 1 - - - true
+MGYG000303700_1 MGYG000303700_00016 17565 18527 1 - - - false
+MGYG000303700_1 MGYG000303700_00017 18651 18875 1 - - - true
+MGYG000303700_1 MGYG000303700_00018 19011 20891 1 - - - true
+MGYG000303700_1 MGYG000303700_00019 20966 21415 1 K09117 - PF09424 true
+MGYG000303700_1 MGYG000303700_00020 21412 21993 1 K00939 - PF00406 true
+MGYG000303700_1 MGYG000303700_00021 21980 22765 1 K01265 - PF00557 true
+MGYG000303700_1 MGYG000303700_00022 22865 23569 -1 - - - true
+MGYG000303700_1 MGYG000303700_00023 23733 24326 -1 - - - true
+MGYG000303700_1 MGYG000303700_00024 24326 25132 -1 - - - true
+MGYG000303700_1 MGYG000303700_00025 25317 25955 -1 - - - true
+MGYG000303700_1 MGYG000303700_00026 26069 27571 1 K04567 - PF01588,PF00152,PF01336 true
+MGYG000303700_1 MGYG000303700_00027 27780 29921 1 - - - true
+MGYG000303700_1 MGYG000303700_00029 30332 30772 -1 - - - true
+MGYG000303700_1 MGYG000303700_00030 30874 31299 1 - - PF13811 true
+MGYG000303700_1 MGYG000303700_00031 31433 32074 1 - - PF03551,PF10400 true
+MGYG000303700_1 MGYG000303700_00032 32062 32745 1 K02003 - PF00005 true
+MGYG000303700_1 MGYG000303700_00033 32748 35012 1 - - PF02687 true
+MGYG000303700_1 MGYG000303700_00034 35015 35278 -1 - - - false
+MGYG000303700_1 MGYG000303700_00035 35285 35653 -1 - - - false
+MGYG000303700_1 MGYG000303700_00036 35684 36196 1 - - - false
+MGYG000303700_1 MGYG000303700_00037 36247 37140 -1 K00604 - PF02911,PF00551 true
+MGYG000303700_1 MGYG000303700_00038 37161 37799 -1 K01462 - PF01327 true
+MGYG000303700_1 MGYG000303700_00039 37880 38185 1 K02888 - PF00829 true
+MGYG000303700_1 MGYG000303700_00040 38408 40624 1 - - - true
+MGYG000303700_1 MGYG000303700_00041 40621 42594 -1 K04066 - PF04851,PF00271,PF00270 true
+MGYG000303700_1 MGYG000303700_00042 42662 43132 1 - - - false
+MGYG000303700_1 MGYG000303700_00043 43123 43557 1 - - - false
+MGYG000303700_1 MGYG000303700_00044 43589 44140 1 K02838 - PF01765 true
+MGYG000303700_1 MGYG000303700_00045 44149 44847 1 K00806 - PF01255 true
+MGYG000303700_1 MGYG000303700_00046 44893 46047 1 K04771,K11749,K16922 - PF00595,PF13180,PF02163 true
+MGYG000303700_1 MGYG000303700_00047 46025 46840 1 - - - true
+MGYG000303700_1 MGYG000303700_00048 46875 48134 1 K01881 - PF00587,PF03129,PF04073 true
+MGYG000303700_1 MGYG000303700_00049 48146 48601 1 K03624 - PF03449,PF01272 true
+MGYG000303700_1 MGYG000303700_00050 48660 49223 -1 - - - true
+MGYG000303700_1 MGYG000303700_00051 49615 49740 -1 - - - true
+MGYG000303700_1 MGYG000303700_00052 49852 50034 1 - - - true
+MGYG000303700_1 MGYG000303700_00053 50825 51079 1 - - - false
+MGYG000303700_1 MGYG000303700_00054 51371 51736 1 K03925 - PF02381 true
+MGYG000303700_1 MGYG000303700_00055 52015 52920 1 K03438 - PF01795 true
+MGYG000303700_1 MGYG000303700_00056 53193 53573 1 - - - true
+MGYG000303700_1 MGYG000303700_00057 53600 55363 1 K03587,K08384 - PF03793,PF00905,PF03717 true
+MGYG000303700_1 MGYG000303700_00058 55360 56403 1 K01000 - PF00953 true
+MGYG000303700_1 MGYG000303700_00059 56426 57763 1 K03588 - PF01098 true
+MGYG000303700_1 MGYG000303700_00060 57714 58865 1 K02563 GT28 PF04101,PF03033 true
+MGYG000303700_1 MGYG000303700_00061 58898 59776 1 - - - true
+MGYG000303700_1 MGYG000303700_00062 61239 61979 -1 - - PF07510,PF05901 true
+MGYG000303700_1 MGYG000303700_00063 62116 62421 1 - - PF04221 true
+MGYG000303700_1 MGYG000303700_00064 62418 62732 1 - - PF05016 false
+MGYG000303700_1 MGYG000303700_00065 62738 63577 -1 - - PF07510 true
+MGYG000303700_1 MGYG000303700_00066 63616 65478 1 - - - true
+MGYG000303700_1 MGYG000303700_00067 65592 65726 -1 - - - true
+MGYG000303700_1 MGYG000303700_00068 65882 66361 1 - - - true
+MGYG000303700_1 MGYG000303700_00069 66468 66875 1 - - - true
+MGYG000303700_1 MGYG000303700_00070 67084 68064 1 - - - true
+MGYG000303700_1 MGYG000303700_00071 68226 68729 1 - - - true
+MGYG000303700_1 MGYG000303700_00072 68843 69307 1 - - - true
+MGYG000303700_1 MGYG000303700_00073 69428 69886 1 - - - true
+MGYG000303700_1 MGYG000303700_00074 70001 70885 1 - - - true
+MGYG000303700_1 MGYG000303700_00075 71005 71901 1 - - - true
+MGYG000303700_1 MGYG000303700_00076 72038 72955 1 - - - true
+MGYG000303700_1 MGYG000303700_00077 73083 73964 1 - - - true
+MGYG000303700_1 MGYG000303700_00078 74081 75010 1 - - - true
+MGYG000303700_1 MGYG000303700_00079 75048 75971 1 - - - true
+MGYG000303700_1 MGYG000303700_00080 76109 76981 1 - - - true
+MGYG000303700_1 MGYG000303700_00081 77114 77944 1 - - - true
+MGYG000303700_1 MGYG000303700_00082 78071 79006 1 - - - true
+MGYG000303700_1 MGYG000303700_00083 79176 80000 1 - - - true
+MGYG000303700_1 MGYG000303700_00084 80174 81052 1 - - - true
+MGYG000303700_1 MGYG000303700_00085 81198 82088 1 - - - true
+MGYG000303700_1 MGYG000303700_00086 82469 83437 1 - - - true
+MGYG000303700_1 MGYG000303700_00087 83506 86427 -1 K03070 - PF01043,PF02810,PF07516,PF07517 true
+MGYG000303700_1 MGYG000303700_00088 86587 87036 1 - - - true
+MGYG000303700_1 MGYG000303700_00089 87139 87519 -1 - - - true
+MGYG000303700_1 MGYG000303700_00090 87571 88821 -1 K01875 - PF02403,PF00587 true
+MGYG000303700_1 MGYG000303700_00091 88885 89220 1 - - PF00293,PF04266 false
+MGYG000303700_1 MGYG000303700_00092 89229 89780 -1 K01104 - PF01451 true
+MGYG000303700_1 MGYG000303700_00093 89790 91742 -1 - - - true
+MGYG000303700_1 MGYG000303700_00094 91763 93658 -1 - - - true
+MGYG000303700_1 MGYG000303700_00095 93651 94331 -1 K02003,K02004 - PF00005,PF02687 true
+MGYG000303700_1 MGYG000303700_00096 94372 94992 -1 K01515,K03574,K12944 - PF13419,PF00293 false
+MGYG000303700_1 MGYG000303700_00097 95074 95532 -1 - - - true
+MGYG000303700_1 MGYG000303700_00098 95674 98529 -1 - - - true
+MGYG000303700_1 MGYG000303700_00099 98629 99915 -1 - - - true
+MGYG000303700_1 MGYG000303700_00100 99918 101213 -1 - - - true
+MGYG000303700_1 MGYG000303700_00101 101313 102356 -1 - - - true
+MGYG000303700_1 MGYG000303700_00102 102495 104933 -1 K03168 - PF01131,PF01751,PF13368 true
+MGYG000303700_1 MGYG000303700_00103 105076 105495 1 - - - true
+MGYG000303700_1 MGYG000303700_00104 105617 106144 1 - - - true
+MGYG000303700_1 MGYG000303700_00106 106422 106733 -1 - - - true
+MGYG000303700_1 MGYG000303700_00107 106733 107998 -1 K00925 - PF00871 true
+MGYG000303700_1 MGYG000303700_00108 108071 109309 1 K00773 - PF01702 true
+MGYG000303700_1 MGYG000303700_00109 109652 110791 -1 - - PF07724 false
+MGYG000303700_1 MGYG000303700_00110 110788 111603 -1 - - - false
+MGYG000303700_1 MGYG000303700_00111 111640 112452 -1 - - PF09553 false
+MGYG000303700_1 MGYG000303700_00112 112452 113675 -1 K00558 - PF13443,PF00145 false
+MGYG000303700_1 MGYG000303700_00113 113994 115451 1 - - - true
+MGYG000303700_1 MGYG000303700_00114 115699 116931 -1 - - - true
+MGYG000303700_1 MGYG000303700_00115 117024 117377 -1 - - - true
+MGYG000303700_1 MGYG000303700_00116 117523 117840 -1 K02946 - PF00338 true
+MGYG000303700_1 MGYG000303700_00117 118020 119201 -1 K02358 - PF03143,PF03144,PF00009 true
+MGYG000303700_1 MGYG000303700_00118 119383 119757 -1 K02935 - PF00542,PF16320 true
+MGYG000303700_1 MGYG000303700_00119 119814 120335 -1 K02864 - PF00466 true
+MGYG000303700_1 MGYG000303700_00120 120544 121746 1 - - PF01594 true
+MGYG000303700_1 MGYG000303700_00121 121703 123130 -1 K01883 - PF09190,PF01406 true
+MGYG000303700_1 MGYG000303700_00122 123174 123617 -1 - - - false
+MGYG000303700_1 MGYG000303700_00123 123592 124074 -1 - - - false
+MGYG000303700_1 MGYG000303700_00124 124141 124485 -1 - - - true
+MGYG000303700_1 MGYG000303700_00125 125041 126141 -1 K06881 - PF02272,PF01368 true
+MGYG000303700_1 MGYG000303700_00126 126263 126892 1 - - - true
+MGYG000303700_1 MGYG000303700_00127 126935 127564 -1 K06187 - PF13662 true
+MGYG000303700_1 MGYG000303700_00128 127564 127863 -1 K09747 - PF02575 true
+MGYG000303700_1 MGYG000303700_00129 127919 129439 1 - - - true
+MGYG000303700_1 MGYG000303700_00130 129496 130881 -1 K02314 - PF03796,PF00772 true
+MGYG000303700_1 MGYG000303700_00131 130868 132457 -1 K02343 - PF12169,PF13177 true
+MGYG000303700_1 MGYG000303700_00132 132611 133402 -1 - - - true
+MGYG000303700_1 MGYG000303700_00133 133471 134718 -1 - - - true
+MGYG000303700_1 MGYG000303700_00134 134722 134925 -1 - - - true
+MGYG000303700_1 MGYG000303700_00135 134997 136202 -1 - - - true
+MGYG000303700_1 MGYG000303700_00136 136235 137131 -1 - - - true
+MGYG000303700_1 MGYG000303700_00137 137131 140415 -1 K03657 - PF13361,PF12705,PF00580 true
+MGYG000303700_1 MGYG000303700_00138 140415 140666 -1 - - - true
+MGYG000303700_1 MGYG000303700_00139 140684 142033 -1 - - PF13426,PF00512,PF08447,PF02518,PF00989 true
+MGYG000303700_1 MGYG000303700_00140 142055 142549 -1 K07043 - - true
+MGYG000303700_1 MGYG000303700_00141 142533 143153 -1 - - - true
+MGYG000303700_1 MGYG000303700_00143 143562 144842 1 - - PF08323,PF00534,PF13439 true
+MGYG000303700_1 MGYG000303700_00144 144835 146037 1 K07405 GH57 PF03065 true
+MGYG000303700_1 MGYG000303700_00145 146039 147733 1 - - PF00723 true
+MGYG000303700_1 MGYG000303700_00146 147714 148367 1 - - - true
+MGYG000303700_1 MGYG000303700_00147 148402 148623 -1 - - - true
+MGYG000303700_1 MGYG000303700_00148 148708 149292 -1 - - - true
+MGYG000303700_1 MGYG000303700_00149 149438 150019 -1 - - - true
+MGYG000303700_1 MGYG000303700_00150 150119 150382 -1 - - - true
+MGYG000303700_1 MGYG000303700_00151 150379 150843 -1 K07738 - PF03477 true
+MGYG000303700_1 MGYG000303700_00152 150849 152237 -1 K03531 - PF00091,PF12327 true
+MGYG000303700_1 MGYG000303700_00153 152312 153586 -1 K03590 - PF14450,PF02491 true
+MGYG000303700_1 MGYG000303700_00154 153668 154537 1 - - - true
+MGYG000303700_1 MGYG000303700_00155 154583 155521 1 - - - true
+MGYG000303700_1 MGYG000303700_00159 156056 156703 -1 - - - true
+MGYG000303700_1 MGYG000303700_00160 156722 157555 -1 - - - true
+MGYG000303700_1 MGYG000303700_00161 157548 158426 -1 K06180 - PF00849,PF01479 true
+MGYG000303700_1 MGYG000303700_00162 158427 159446 -1 K01867 - PF00579 true
+MGYG000303700_1 MGYG000303700_00163 159510 159908 -1 K02996 - PF00380 true
+MGYG000303700_1 MGYG000303700_00164 159908 160333 -1 K02871 - PF00572 true
+MGYG000303700_1 MGYG000303700_00165 160333 160749 -1 K02879 - PF01196 true
+MGYG000303700_1 MGYG000303700_00166 160753 161676 -1 K03040 - PF01000,PF03118,PF01193 true
+MGYG000303700_1 MGYG000303700_00167 161691 162308 -1 K02986 - PF01479,PF00163 true
+MGYG000303700_1 MGYG000303700_00168 162312 162731 -1 K02948 - PF00411 true
+MGYG000303700_1 MGYG000303700_00169 162770 163156 -1 K02952 - PF00416 true
+MGYG000303700_1 MGYG000303700_00170 163165 163281 -1 K02919 - PF00444 true
+MGYG000303700_1 MGYG000303700_00171 163278 163556 -1 K02518 - PF01176 true
+MGYG000303700_1 MGYG000303700_00172 163662 166868 -1 - - - true
+MGYG000303700_1 MGYG000303700_00173 166882 167403 -1 - - - false
+MGYG000303700_1 MGYG000303700_00174 167437 167991 -1 - - - true
+MGYG000303700_1 MGYG000303700_00175 168055 168792 -1 - - - true
+MGYG000303700_1 MGYG000303700_00176 168776 170137 -1 K03076 - PF00344 true
+MGYG000303700_1 MGYG000303700_00177 170227 171714 1 K01885 - PF00749 true
+MGYG000303700_1 MGYG000303700_00178 171748 173301 1 K07652 - PF13426,PF00512,PF00672,PF02518,PF00989 true
+MGYG000303700_1 MGYG000303700_00180 173448 174671 1 K07636 - PF16736,PF00512,PF00672,PF13188,PF02518,PF08448,PF00989 true
+MGYG000303700_1 MGYG000303700_00181 174732 175850 1 - - PF00072 true
+MGYG000303700_1 MGYG000303700_00182 175869 176561 1 K06178 - PF00849,PF01479 true
+MGYG000303700_1 MGYG000303700_00183 176646 177116 -1 K02876 - PF00828 true
+MGYG000303700_1 MGYG000303700_00184 177116 177757 -1 K02988 - PF03719,PF00333 true
+MGYG000303700_1 MGYG000303700_00185 177757 178098 -1 K02881 - PF00861 true
+MGYG000303700_1 MGYG000303700_00186 178098 178634 -1 K02933 - PF00347 true
+MGYG000303700_1 MGYG000303700_00187 178651 179052 -1 K02994 - PF00410 true
+MGYG000303700_1 MGYG000303700_00188 179068 179337 -1 K02954 - PF00253 true
+MGYG000303700_1 MGYG000303700_00189 179337 179921 -1 K02931 - PF00281,PF00673 true
+MGYG000303700_1 MGYG000303700_00190 179921 180220 -1 K02895 - PF17136,PF00467 true
+MGYG000303700_1 MGYG000303700_00191 180220 180588 -1 K02874 - PF00238 true
+MGYG000303700_1 MGYG000303700_00192 180588 180923 -1 K02961 - PF00366 true
+MGYG000303700_1 MGYG000303700_00193 180920 181231 -1 - - - true
+MGYG000303700_1 MGYG000303700_00194 181231 181647 -1 K02878 - PF00252 true
+MGYG000303700_1 MGYG000303700_00195 181648 182280 -1 K02982 - PF00189,PF07650 true
+MGYG000303700_1 MGYG000303700_00196 182280 182702 -1 K02890 - PF00237 true
+MGYG000303700_1 MGYG000303700_00197 182702 182962 -1 K02965 - PF00203 true
+MGYG000303700_1 MGYG000303700_00198 182962 183810 -1 K02886 - PF03947,PF00181 true
+MGYG000303700_1 MGYG000303700_00199 183812 184117 -1 K02892 - PF00276 true
+MGYG000303700_1 MGYG000303700_00200 184117 184716 -1 K02926 - PF00573 true
+MGYG000303700_1 MGYG000303700_00201 184716 185357 -1 K02906 - PF00297 true
+MGYG000303700_1 MGYG000303700_00202 185536 186018 -1 - - - true
+MGYG000303700_1 MGYG000303700_00203 186030 186479 -1 - - - true
+MGYG000303700_1 MGYG000303700_00204 186582 187010 -1 - - - true
+MGYG000303700_1 MGYG000303700_00205 187091 188788 -1 - - - true
+MGYG000303700_1 MGYG000303700_00206 188781 189785 -1 - - PF00877 true
+MGYG000303700_1 MGYG000303700_00207 189851 190765 -1 K02863 - PF00687 true
+MGYG000303700_1 MGYG000303700_00208 190814 191242 -1 K02867 - PF03946,PF00298 true
+MGYG000303700_1 MGYG000303700_00209 191323 191871 -1 K02601 - PF02357,PF00467 true
+MGYG000303700_1 MGYG000303700_00210 191871 192122 -1 - - - true
+MGYG000303700_1 MGYG000303700_00211 192198 193487 -1 - - PF00675,PF05193 true
+MGYG000303700_1 MGYG000303700_00212 193598 194023 -1 - - - true
+MGYG000303700_1 MGYG000303700_00213 194099 195100 -1 - - - true
+MGYG000303700_1 MGYG000303700_00214 195103 196242 -1 - - - true
+MGYG000303700_1 MGYG000303700_00215 196265 196732 -1 K03469 - PF00075,PF14534 true
+MGYG000303700_1 MGYG000303700_00216 196734 197555 -1 - - PF06965,PF13462 true
+MGYG000303700_1 MGYG000303700_00217 197555 198082 -1 - - - true
+MGYG000303700_1 MGYG000303700_00218 198109 198273 -1 - - - true
+MGYG000303700_1 MGYG000303700_00219 198345 198632 1 - - - true
+MGYG000303700_1 MGYG000303700_00220 198677 200101 -1 K03977 - PF14714,PF01926 true
+MGYG000303700_1 MGYG000303700_00221 200593 200901 -1 - - - true
+MGYG000303700_1 MGYG000303700_00222 201089 202645 -1 - - - true
+MGYG000303700_1 MGYG000303700_00223 202716 204395 -1 - - - true
+MGYG000303700_1 MGYG000303700_00224 204535 206037 1 - - - true
+MGYG000303700_1 MGYG000303700_00225 206034 207038 -1 K07284 - PF04203 true
+MGYG000303700_1 MGYG000303700_00227 207246 208208 -1 - - PF01207 true
+MGYG000303700_1 MGYG000303700_00228 208227 209297 -1 K03805,K03981 - PF01323 true
+MGYG000303700_1 MGYG000303700_00229 209294 210478 -1 - - PF00266 true
+MGYG000303700_1 MGYG000303700_00230 210562 212646 -1 K02355 - PF00679,PF03764,PF03144,PF00009 true
+MGYG000303700_1 MGYG000303700_00231 212666 213145 -1 K02992 - PF00177 true
+MGYG000303700_1 MGYG000303700_00232 213148 213561 -1 K02950 - PF00164 true
+MGYG000303700_1 MGYG000303700_00233 213672 214538 -1 K04096 - PF02481 true
+MGYG000303700_1 MGYG000303700_00234 214907 215491 -1 - - PF01195 true
+MGYG000303700_1 MGYG000303700_00235 215582 215977 -1 - - PF05154 true
+MGYG000303700_1 MGYG000303700_00236 216075 216563 1 - - - true
+MGYG000303700_1 MGYG000303700_00237 216629 217210 -1 - - - true
+MGYG000303700_1 MGYG000303700_00238 217266 217700 -1 - - - true
+MGYG000303700_1 MGYG000303700_00239 217693 218382 -1 - - PF11070 true
+MGYG000303700_1 MGYG000303700_00240 218382 218990 -1 - - PF00440 true
+MGYG000303700_1 MGYG000303700_00241 219278 219739 -1 - - - true
+MGYG000303700_1 MGYG000303700_00242 219858 220025 -1 - - - true
+MGYG000303700_1 MGYG000303700_00243 220143 221090 -1 K07258 - PF00768 true
+MGYG000303700_1 MGYG000303700_00244 221310 221954 -1 - - PF01381,PF02302 true
+MGYG000303700_1 MGYG000303700_00245 222336 223511 -1 K03215 - PF05958,PF01938 true
+MGYG000303700_1 MGYG000303700_00246 223495 225435 -1 K01200 CBM48,GH13 PF00128,PF02922 true
+MGYG000303700_1 MGYG000303700_00247 225441 227204 -1 K00688 GT35 PF00343,PF11897 true
+MGYG000303700_1 MGYG000303700_00248 227241 229685 -1 K01531 - PF00702,PF00690,PF00689,PF00122 true
+MGYG000303700_1 MGYG000303700_00249 229728 230693 -1 K03284 - PF01544 true
+MGYG000303700_1 MGYG000303700_00250 230725 234567 -1 K03046 - PF00623,PF04983,PF04998,PF05000,PF04997 true
+MGYG000303700_1 MGYG000303700_00251 234567 237998 -1 K03043 - PF04565,PF04563,PF04560,PF04561,PF00562,PF10385 true
+MGYG000303700_1 MGYG000303700_00252 238209 238895 -1 - - PF02163 true
+MGYG000303700_1 MGYG000303700_00253 238974 239186 -1 K02902 - PF00830 true
+MGYG000303700_1 MGYG000303700_00254 239310 239870 -1 K08316 - PF03602 true
+MGYG000303700_1 MGYG000303700_00255 239857 240684 -1 - - - true
+MGYG000303700_1 MGYG000303700_00256 240684 242732 -1 K03655 - PF17191,PF00271,PF00270 true
+MGYG000303700_1 MGYG000303700_00257 242734 243372 -1 - - - true
+MGYG000303700_1 MGYG000303700_00258 243387 244607 -1 K01866 - PF00579,PF01479 true
+MGYG000303700_1 MGYG000303700_00259 244695 247412 1 - - PF00912,PF00905 true
+MGYG000303700_1 MGYG000303700_00260 247434 248528 1 - - - true
+MGYG000303700_1 MGYG000303700_00261 248482 249465 -1 - - PF01938 true
+MGYG000303700_1 MGYG000303700_00262 249521 250867 -1 K04485 - PF13481,PF06745,PF13541,PF05362 true
+MGYG000303700_1 MGYG000303700_00263 250886 253759 -1 K03696 - PF02861,PF07724,PF00004,PF02151,PF10431 true
+MGYG000303700_1 MGYG000303700_00264 253824 254867 -1 K02600 - PF13184,PF14520,PF08529,PF00575 true
+MGYG000303700_1 MGYG000303700_00265 254972 257449 1 K01256 - PF11838,PF01433 true
+MGYG000303700_1 MGYG000303700_00266 257441 258406 -1 K03470 - PF01351 true
+MGYG000303700_1 MGYG000303700_00267 258396 258851 -1 K02884 - PF01245 true
+MGYG000303700_1 MGYG000303700_00268 258920 260623 -1 K02454 - PF00437 true
+MGYG000303700_1 MGYG000303700_00269 260678 261235 1 - - PF00588 true
+MGYG000303700_1 MGYG000303700_00270 261236 265060 -1 K02337,K14162 - PF01336,PF02811,PF07733,PF14579 true
+MGYG000303700_1 MGYG000303700_00271 265076 265399 -1 - - - true
+MGYG000303700_1 MGYG000303700_00272 265383 265673 -1 - - - true
+MGYG000303700_1 MGYG000303700_00273 265742 266623 -1 K00963 - PF00483 true
+MGYG000303700_1 MGYG000303700_00274 266706 268196 -1 K02434 - PF02637,PF02934 true
+MGYG000303700_1 MGYG000303700_00275 268205 268633 -1 - - - true
+MGYG000303700_1 MGYG000303700_00276 268633 270042 -1 K02433 - PF01425 true
+MGYG000303700_1 MGYG000303700_00277 270051 270335 -1 K02435 - - true
+MGYG000303700_1 MGYG000303700_00278 270387 271043 -1 - - - true
+MGYG000303700_1 MGYG000303700_00279 271073 273046 -1 K03702 - PF02151,PF04851,PF12344,PF00271 true
+MGYG000303700_1 MGYG000303700_00280 273097 274080 -1 K00852 - PF00294 true
+MGYG000303700_1 MGYG000303700_00281 274080 274985 -1 K01624 - PF01116 true
+MGYG000303700_1 MGYG000303700_00282 275039 276019 -1 K00615 - PF02779,PF02780 true
+MGYG000303700_1 MGYG000303700_00283 276012 276842 -1 K00615 - PF00456 true
+MGYG000303700_1 MGYG000303700_00284 276852 277508 -1 K01783 - PF00834 true
+MGYG000303700_1 MGYG000303700_00285 277505 277957 -1 K01808 - PF02502 true
+MGYG000303700_1 MGYG000303700_00286 278043 279050 -1 K00134 - PF00044,PF02800 true
+MGYG000303700_1 MGYG000303700_00287 279105 281042 -1 - - - true
+MGYG000303700_1 MGYG000303700_00288 281141 282625 1 K00951 - PF02824,PF04607,PF13291,PF13328 true
+MGYG000303700_1 MGYG000303700_00289 282679 283206 -1 K01507 - PF00719 true
+MGYG000303700_1 MGYG000303700_00290 283228 283944 -1 - - - true
+MGYG000303700_1 MGYG000303700_00291 284025 285026 1 K06131 - PF13469,PF13091 true
+MGYG000303700_1 MGYG000303700_00292 285069 285689 -1 K03772,K03773 - PF00254,PF01346 true
+MGYG000303700_1 MGYG000303700_00293 285704 288205 -1 K01890 - PF03484,PF01588,PF03147,PF03483 true
+MGYG000303700_1 MGYG000303700_00294 288215 289237 -1 K01889 - PF01409,PF02912 true
+MGYG000303700_1 MGYG000303700_00295 289256 289885 -1 - - - true
+MGYG000303700_1 MGYG000303700_00296 289885 290148 -1 - - - true
+MGYG000303700_1 MGYG000303700_00297 290207 291358 1 - - - true
+MGYG000303700_1 MGYG000303700_00298 291421 292485 -1 K09760 - PF02646 true
+MGYG000303700_1 MGYG000303700_00299 292510 293310 -1 - - - true
+MGYG000303700_1 MGYG000303700_00300 293310 294113 -1 K01142 - PF03372 true
+MGYG000303700_1 MGYG000303700_00301 294113 294619 -1 K03664 - PF01668 true
+MGYG000303700_1 MGYG000303700_00302 294656 295672 1 K13678 GT4 PF00534,PF13439 true
+MGYG000303700_1 MGYG000303700_00303 295695 296972 1 - - PF00534,PF13439 true
+MGYG000303700_1 MGYG000303700_00304 297012 297281 -1 - - PF00462 true
+MGYG000303700_1 MGYG000303700_00305 297349 297543 -1 - - - true
+MGYG000303700_1 MGYG000303700_00306 297533 298486 -1 K00384 - PF07992 true
+MGYG000303700_1 MGYG000303700_00307 298504 300237 -1 K01236 CBM48,GH13 PF11941,PF00128,PF02922 true
+MGYG000303700_1 MGYG000303700_00308 300284 300925 1 - - PF13472 true
+MGYG000303700_1 MGYG000303700_00310 301103 302740 -1 K06158 - PF12848,PF16326,PF00005 true
+MGYG000303700_1 MGYG000303700_00311 302808 303449 1 - - PF03729 true
+MGYG000303700_1 MGYG000303700_00312 303449 304258 1 K06153 - PF02673 true
+MGYG000303700_1 MGYG000303700_00313 304319 306409 1 K01533,K17686 - PF00702,PF00403,PF00122 true
+MGYG000303700_1 MGYG000303700_00314 306641 307354 -1 K00554 - PF01746 true
+MGYG000303700_1 MGYG000303700_00315 307408 307770 -1 K06960 - - true
+MGYG000303700_1 MGYG000303700_00316 307857 308198 -1 K02959 - PF00886 true
+MGYG000303700_1 MGYG000303700_00317 308699 310048 -1 K01880 - PF00587,PF03129 true
+MGYG000303700_1 MGYG000303700_00318 310064 310756 -1 K03584 - PF02565,PF11967 true
+MGYG000303700_1 MGYG000303700_00319 310753 311115 -1 - - - true
+MGYG000303700_1 MGYG000303700_00320 311112 311807 -1 - - - true
+MGYG000303700_1 MGYG000303700_00321 311861 312547 -1 - - - true
+MGYG000303700_1 MGYG000303700_00322 312600 312836 -1 - - - true
+MGYG000303700_1 MGYG000303700_00323 312820 314070 -1 K03601,K03797 - PF13742,PF02601 true
+MGYG000303700_1 MGYG000303700_00324 314021 315100 -1 K07027,K14205 - PF03706 true
+MGYG000303700_1 MGYG000303700_00325 315182 316441 1 - - - true
+MGYG000303700_1 MGYG000303700_00326 316494 316766 1 K02899 - PF01016 true
+MGYG000303700_1 MGYG000303700_00327 316863 317261 -1 K02488 - PF00072 true
+MGYG000303700_1 MGYG000303700_00328 317297 318112 -1 K03685 - PF14622,PF00035 true
+MGYG000303700_1 MGYG000303700_00329 318113 318760 -1 - - PF00293 true
+MGYG000303700_1 MGYG000303700_00330 318711 319199 -1 K03625 - PF01029 true
+MGYG000303700_1 MGYG000303700_00331 319250 319393 -1 - - - true
+MGYG000303700_1 MGYG000303700_00332 319504 319983 1 - - - true
+MGYG000303700_1 MGYG000303700_00333 320056 322497 -1 K01869 - PF00133,PF13603,PF08264 true
+MGYG000303700_1 MGYG000303700_00334 322522 323820 -1 K01929 - PF08245,PF02875,PF01225 true
+MGYG000303700_1 MGYG000303700_00335 323828 326197 -1 K12952 - PF00702,PF00122 true
+MGYG000303700_1 MGYG000303700_00337 326356 326502 -1 - - - true
+MGYG000303700_1 MGYG000303700_00338 326537 328582 -1 K01972 - PF03120,PF03119,PF01653,PF00533,PF14520,PF12826 true
+MGYG000303700_1 MGYG000303700_00339 328593 328880 -1 - - - true
+MGYG000303700_1 MGYG000303700_00340 328880 330301 -1 - - - true
+MGYG000303700_1 MGYG000303700_00341 330303 331133 -1 K03799 - PF01435 true
+MGYG000303700_1 MGYG000303700_00342 331189 331782 -1 K03744 - PF04011 true
+MGYG000303700_1 MGYG000303700_00343 331860 332795 -1 - - PF01522 true
+MGYG000303700_1 MGYG000303700_00348 333559 334182 -1 K01358 - PF00574 true
+MGYG000303700_1 MGYG000303700_00349 334182 335474 -1 K03545 - PF00254,PF05697,PF05698 true
+MGYG000303700_1 MGYG000303700_00350 335504 336763 -1 K01892 - PF13393,PF03129 true
+MGYG000303700_1 MGYG000303700_00351 336798 338756 -1 K00700 CBM48,GH13 PF00128,PF02922,PF02806 true
+MGYG000303700_1 MGYG000303700_00353 338928 340553 -1 K00113 - PF02754,PF13183 true
+MGYG000303700_1 MGYG000303700_00355 341968 342666 -1 - - - true
+MGYG000303700_1 MGYG000303700_00356 342659 343792 -1 - - - true
+MGYG000303700_1 MGYG000303700_00357 343839 344495 1 K00655 - PF01553 true
+MGYG000303700_1 MGYG000303700_00358 344498 346219 1 K01897 - PF13193,PF00501 true
+MGYG000303700_1 MGYG000303700_00363 346758 348596 1 K06207 - PF00679,PF03144,PF00009 true
+MGYG000303700_1 MGYG000303700_00364 348644 351472 -1 K03701 - PF00005 true
+MGYG000303700_1 MGYG000303700_00365 351501 352505 -1 K01784 - PF16363 true
+MGYG000303700_1 MGYG000303700_00366 352515 353945 -1 K01141 - PF08411,PF00929 true
+MGYG000303700_1 MGYG000303700_00367 353974 355143 -1 - - PF01476,PF05257 true
+MGYG000303700_1 MGYG000303700_00368 355202 356386 -1 K07082 - PF02618 true
+MGYG000303700_1 MGYG000303700_00369 356379 356819 -1 K07447 - PF03652 true
+MGYG000303700_1 MGYG000303700_00370 356819 358765 -1 - - - true
+MGYG000303700_1 MGYG000303700_00371 358775 360037 -1 - - PF14450 true
+MGYG000303700_1 MGYG000303700_00372 360061 360627 -1 - - PF03167 true
+MGYG000303700_1 MGYG000303700_00373 360628 361764 -1 - - - true
+MGYG000303700_1 MGYG000303700_00374 361857 362528 -1 K00655 - PF01553 true
+MGYG000303700_1 MGYG000303700_00375 362521 363303 -1 K07124 - PF00106 true
+MGYG000303700_1 MGYG000303700_00376 363308 365431 -1 K00962 - PF03725,PF00013,PF01138,PF00575,PF03726 true
+MGYG000303700_1 MGYG000303700_00377 365586 365861 -1 K02956 - PF00312 true
+MGYG000303700_1 MGYG000303700_00378 365893 369018 -1 K01870 - PF00133,PF08264 true
+MGYG000303700_1 MGYG000303700_00379 369058 370146 -1 K03686,K05516 - PF01556,PF00226,PF00684 true
+MGYG000303700_1 MGYG000303700_00380 370206 372077 -1 K04043 - PF00012 true
+MGYG000303700_1 MGYG000303700_00381 372196 372672 -1 K03687 - PF01025 true
+MGYG000303700_1 MGYG000303700_00382 372659 373402 -1 K03705 - PF03444,PF01628 true
+MGYG000303700_1 MGYG000303700_00383 373448 373834 -1 - - - true
+MGYG000303700_1 MGYG000303700_00384 373824 374351 -1 - - - true
+MGYG000303700_1 MGYG000303700_00385 374381 375082 1 - - PF07510,PF05901 true
+MGYG000303700_1 MGYG000303700_00386 375093 376355 -1 K01992 - PF12698 true
+MGYG000303700_1 MGYG000303700_00387 376348 377103 -1 K01990 - PF13732,PF00005 true
+MGYG000303700_1 MGYG000303700_00388 377154 377981 -1 - - PF13462 true
+MGYG000303700_1 MGYG000303700_00389 378036 378920 1 - - - true
+MGYG000303700_1 MGYG000303700_00390 378948 380756 1 K01876 - PF01336,PF00152,PF02938 true
+MGYG000303700_1 MGYG000303700_00391 380794 381432 -1 - - PF05711 true
+MGYG000303700_1 MGYG000303700_00392 381432 382067 -1 K01834 - PF00300 true
+MGYG000303700_1 MGYG000303700_00393 382116 383426 -1 K03979 - PF01018,PF09269,PF01926 true
+MGYG000303700_1 MGYG000303700_00394 383491 385029 1 K03703 - PF01541,PF14520,PF12826,PF02151 true
+MGYG000303700_1 MGYG000303700_00395 385038 385430 1 - - - true
+MGYG000303700_1 MGYG000303700_00396 385417 385641 1 - - - true
+MGYG000303700_1 MGYG000303700_00397 385641 387446 1 K02035 - PF00496 true
+MGYG000303700_1 MGYG000303700_00398 387451 388740 -1 K01689 - PF00113,PF03952 true
+MGYG000303700_1 MGYG000303700_00399 388838 389779 1 K00016 - PF02866,PF00056 true
+MGYG000303700_1 MGYG000303700_00400 389828 390502 -1 K03975 - PF09335 true
+MGYG000303700_1 MGYG000303700_00401 390585 392132 -1 - - PF01345 true
+MGYG000303700_1 MGYG000303700_00402 392184 394622 -1 - - - true
+MGYG000303700_1 MGYG000303700_00403 394732 396138 -1 - - PF01411 true
+MGYG000303700_1 MGYG000303700_00404 396166 397209 -1 K00566 - PF03054 true
+MGYG000303700_1 MGYG000303700_00405 397206 397823 -1 - - PF02698 true
+MGYG000303700_1 MGYG000303700_00406 397814 398965 -1 K04487 - PF00266 true
+MGYG000303700_1 MGYG000303700_00407 398983 399786 -1 K03424 - PF01026 true
+MGYG000303700_1 MGYG000303700_00408 399773 401308 -1 K01874 - PF09334,PF01588,PF08264 true
+MGYG000303700_1 MGYG000303700_00409 401445 401774 -1 - - - false
+MGYG000303700_1 MGYG000303700_00410 402096 402506 1 - - - false
+MGYG000303700_1 MGYG000303700_00411 402594 403454 -1 K02528 - PF00398 true
+MGYG000303700_1 MGYG000303700_00412 403402 404574 -1 K21688 - PF07501,PF06737,PF03990 true
+MGYG000303700_1 MGYG000303700_00413 404619 406808 -1 K03657 - PF13361,PF00580 true
+MGYG000303700_1 MGYG000303700_00414 406821 408254 -1 - - - true
+MGYG000303700_1 MGYG000303700_00415 408247 409029 -1 K01803 - PF00121 true
+MGYG000303700_1 MGYG000303700_00416 409085 410317 -1 K00927,K01803 - PF00162 true
+MGYG000303700_1 MGYG000303700_00417 410328 411743 -1 K00873 - PF00224,PF02887 true
+MGYG000303700_1 MGYG000303700_00418 411793 412185 -1 K18144 - PF00486,PF00072 true
+MGYG000303700_1 MGYG000303700_00419 412203 412406 -1 - - - true
+MGYG000303700_1 MGYG000303700_00421 412584 413408 -1 K01491 - PF02882,PF00763 true
+MGYG000303700_1 MGYG000303700_00423 413541 415640 -1 - - PF00535,PF04464 true
+MGYG000303700_1 MGYG000303700_00424 415683 416894 1 - - PF01757 true
+MGYG000303700_1 MGYG000303700_00425 416955 418844 1 - - PF01501 true
+MGYG000303700_1 MGYG000303700_00426 418848 420032 1 - - PF01757 true
+MGYG000303700_1 MGYG000303700_00428 420161 420679 -1 K04068 - PF13353,PF04055 true
+MGYG000303700_1 MGYG000303700_00429 420687 422867 -1 K21636 - PF13597,PF03477 true
+MGYG000303700_1 MGYG000303700_00430 423050 423724 1 K09013 - PF00005 true
+MGYG000303700_1 MGYG000303700_00431 423711 425039 1 K09014 - - true
+MGYG000303700_1 MGYG000303700_00432 425036 425482 1 - - - true
+MGYG000303700_1 MGYG000303700_00433 425472 426629 1 K11717 - PF00266 true
+MGYG000303700_1 MGYG000303700_00434 426599 428803 -1 - - - true
+MGYG000303700_1 MGYG000303700_00436 429070 429492 1 - - - true
+MGYG000303700_1 MGYG000303700_00437 429511 430089 1 K00790 - PF01381,PF00275 true
+MGYG000303700_1 MGYG000303700_00439 430235 430939 -1 K01174 - PF00565 true
+MGYG000303700_1 MGYG000303700_00442 431145 433565 -1 K03696 - PF02861,PF07724,PF00004,PF02151,PF10431 true
+MGYG000303700_1 MGYG000303700_00443 433550 433936 -1 - - - true
+MGYG000303700_1 MGYG000303700_00444 434011 434730 1 - - PF01709 true
+MGYG000303700_1 MGYG000303700_00446 434896 436341 1 - - PF12229,PF03734 true
+MGYG000303700_1 MGYG000303700_00447 436342 437808 -1 K02238 - PF13567,PF03772,PF00753 true
+MGYG000303700_1 MGYG000303700_00449 437957 438631 1 K00939 - PF00156,PF00406 true
+MGYG000303700_1 MGYG000303700_00450 438647 440455 -1 K03596 - PF00679,PF06421,PF03144,PF00009 true
+MGYG000303700_1 MGYG000303700_00451 440455 442143 -1 K03980 - - true
+MGYG000303700_1 MGYG000303700_00452 442154 444061 -1 K03798 - PF00004,PF01434,PF06480 true
+MGYG000303700_1 MGYG000303700_00453 444088 444966 -1 K04075 - PF01171,PF11734 true
+MGYG000303700_1 MGYG000303700_00454 445064 445264 1 - - - true
+MGYG000303700_1 MGYG000303700_00457 445620 447047 -1 - - - true
+MGYG000303700_1 MGYG000303700_00458 447047 447937 -1 - - - true
+MGYG000303700_1 MGYG000303700_00459 447938 448672 -1 - - - true
+MGYG000303700_1 MGYG000303700_00460 448647 449567 -1 - - - true
+MGYG000303700_1 MGYG000303700_00461 449634 450500 -1 K02236,K02654 - PF01478 true
+MGYG000303700_1 MGYG000303700_00462 450567 451070 -1 - - - true
+MGYG000303700_1 MGYG000303700_00463 451143 452351 -1 K02653 - PF00482 true
+MGYG000303700_1 MGYG000303700_00464 452352 453416 -1 K02669 - PF00437 true
+MGYG000303700_1 MGYG000303700_00465 453453 455216 -1 K02652 - PF00437 true
+MGYG000303700_1 MGYG000303700_00466 455216 455473 -1 - - - true
+MGYG000303700_1 MGYG000303700_00467 455470 456183 -1 - - - true
+MGYG000303700_1 MGYG000303700_00468 456183 457136 -1 - - - true
+MGYG000303700_1 MGYG000303700_00469 457137 458180 -1 K02662 - PF11104 true
+MGYG000303700_1 MGYG000303700_00470 458246 459367 1 K06942 - PF06071,PF01926 true
+MGYG000303700_1 MGYG000303700_00471 459418 460164 -1 K06442 - PF01728,PF01479 true
+MGYG000303700_1 MGYG000303700_00472 460166 460729 -1 K02356 - PF09285,PF01132,PF08207 true
+MGYG000303700_1 MGYG000303700_00473 460777 460971 -1 K02963 - PF01084 true
+MGYG000303700_1 MGYG000303700_00474 460987 461418 -1 K03111 - PF00436 true
+MGYG000303700_1 MGYG000303700_00475 461450 461821 -1 K02990 - PF01250 true
+MGYG000303700_1 MGYG000303700_00476 462005 462268 1 - - - true
+MGYG000303700_1 MGYG000303700_00477 462310 463260 -1 - - - true
+MGYG000303700_1 MGYG000303700_00478 463312 463572 1 - - - false
+MGYG000303700_1 MGYG000303700_00479 463611 464804 -1 - - PF00078 true
+MGYG000303700_1 MGYG000303700_00480 464821 465483 -1 - - - false
+MGYG000303700_1 MGYG000303700_00481 465629 466300 -1 - - - false
+MGYG000303700_2 MGYG000303700_00482 549 998 -1 - - - true
+MGYG000303700_2 MGYG000303700_00486 1455 3734 -1 K03466 - PF13491,PF01580 true
+MGYG000303700_2 MGYG000303700_00487 3803 6184 -1 K12574 - PF07521,PF00753 true
+MGYG000303700_2 MGYG000303700_00488 6346 7836 -1 K18682 - PF00013,PF01966 true
+MGYG000303700_2 MGYG000303700_00489 7878 8261 -1 K14742 - PF00583 true
+MGYG000303700_2 MGYG000303700_00490 8333 9382 1 K03553 - PF00154 true
+MGYG000303700_2 MGYG000303700_00491 9363 9968 1 K03565 - PF02631 true
+MGYG000303700_2 MGYG000303700_00492 9975 10553 -1 - - - true
+MGYG000303700_2 MGYG000303700_00493 10569 11246 -1 K03177 - PF01509,PF09142,PF16198 true
+MGYG000303700_2 MGYG000303700_00494 11248 12900 -1 - - - true
+MGYG000303700_2 MGYG000303700_00495 12983 13402 -1 K06925 - PF02367 true
+MGYG000303700_2 MGYG000303700_00496 13482 15170 1 - - - true
+MGYG000303700_2 MGYG000303700_00497 15183 15695 1 K01159 - PF02075 true
+MGYG000303700_2 MGYG000303700_00498 15700 16266 1 K03550 - PF14520,PF01330,PF07499 true
+MGYG000303700_2 MGYG000303700_00499 16282 17304 1 K03551 - PF05491,PF05496 true
+MGYG000303700_2 MGYG000303700_00500 17317 17910 1 - - - true
+MGYG000303700_2 MGYG000303700_00501 17966 18439 -1 - - - true
+MGYG000303700_2 MGYG000303700_00502 18451 18852 -1 - - - true
+MGYG000303700_2 MGYG000303700_00504 18972 19256 -1 - - - true
+MGYG000303700_2 MGYG000303700_00505 19298 19519 -1 - - - true
+MGYG000303700_2 MGYG000303700_00506 19561 20241 -1 - - - true
+MGYG000303700_2 MGYG000303700_00507 20263 20940 -1 K03439 - PF02390 true
+MGYG000303700_2 MGYG000303700_00508 21001 21849 1 K22044 - - true
+MGYG000303700_2 MGYG000303700_00509 21860 22324 1 - - - true
+MGYG000303700_2 MGYG000303700_00511 22466 24196 -1 - - PF03816,PF13399 true
+MGYG000303700_2 MGYG000303700_00512 24272 25681 1 - - PF02397,PF13727 true
+MGYG000303700_2 MGYG000303700_00513 25625 27040 -1 - - - true
+MGYG000303700_2 MGYG000303700_00514 27027 28142 -1 - - PF00534,PF13439 true
+MGYG000303700_2 MGYG000303700_00515 28144 31122 -1 - - - true
+MGYG000303700_2 MGYG000303700_00516 31172 32389 1 K01854 - PF13450,PF03275 true
+MGYG000303700_2 MGYG000303700_00517 32438 34036 -1 - - PF08310,PF04122 true
+MGYG000303700_2 MGYG000303700_00518 34017 34667 -1 - - - true
+MGYG000303700_2 MGYG000303700_00519 34701 35888 -1 K01990 - PF00005,PF14524 true
+MGYG000303700_2 MGYG000303700_00520 35888 36718 -1 K01992 - PF01061 true
+MGYG000303700_2 MGYG000303700_00521 36785 38761 -1 - - - false
+MGYG000303700_2 MGYG000303700_00522 38775 39887 1 - - PF00535 true
+MGYG000303700_2 MGYG000303700_00523 39900 40364 -1 K06346 - PF01424,PF14804 true
+MGYG000303700_2 MGYG000303700_00524 40374 41291 -1 K03217 - PF02096 true
+MGYG000303700_2 MGYG000303700_00525 41312 41659 -1 - - - true
+MGYG000303700_2 MGYG000303700_00526 41722 41859 -1 - - - true
+MGYG000303700_2 MGYG000303700_00527 42055 43446 1 K02313 - PF08299,PF00308,PF11638 true
+MGYG000303700_2 MGYG000303700_00528 43439 43717 1 - - - true
+MGYG000303700_2 MGYG000303700_00529 43714 44796 1 K02338 - PF02767,PF00712,PF02768 true
+MGYG000303700_2 MGYG000303700_00530 44796 45803 1 K03629 - PF02463 true
+MGYG000303700_2 MGYG000303700_00531 45795 46982 -1 K02004 - PF12704,PF02687 true
+MGYG000303700_2 MGYG000303700_00532 46982 47791 -1 K02003 - PF00005 true
+MGYG000303700_2 MGYG000303700_00533 47853 48908 1 - - - true
+MGYG000303700_2 MGYG000303700_00534 48917 49684 1 - - - true
+MGYG000303700_2 MGYG000303700_00535 49677 51518 1 - - PF12666,PF01935,PF12846 true
+MGYG000303700_2 MGYG000303700_00536 51521 52444 1 - - - true
+MGYG000303700_2 MGYG000303700_00537 52433 53482 -1 K15916 - PF10432,PF01380 true
+MGYG000303700_2 MGYG000303700_00538 53567 55189 -1 K04077 - PF00118 true
+MGYG000303700_2 MGYG000303700_00539 55198 55467 -1 K04078 - PF00166 true
+MGYG000303700_2 MGYG000303700_00540 55546 56118 -1 - - - false
+MGYG000303700_2 MGYG000303700_00541 56115 58016 -1 - - - true
+MGYG000303700_2 MGYG000303700_00542 58016 58540 -1 - - - true
+MGYG000303700_2 MGYG000303700_00543 58524 61928 -1 - - - false
+MGYG000303700_2 MGYG000303700_00544 61996 64428 -1 K03201 - PF04610 false
+MGYG000303700_2 MGYG000303700_00545 64451 67369 -1 - - - false
+MGYG000303700_2 MGYG000303700_00546 67320 69380 -1 K03201 - PF04610 false
+MGYG000303700_2 MGYG000303700_00547 69355 72099 -1 K03201 - PF04610 false
+MGYG000303700_2 MGYG000303700_00548 72166 72534 1 - - - false
+MGYG000303700_2 MGYG000303700_00549 72531 73505 1 - - - true
+MGYG000303700_2 MGYG000303700_00550 73507 73851 1 - - - true
+MGYG000303700_2 MGYG000303700_00551 73844 74257 1 - - - true
+MGYG000303700_2 MGYG000303700_00552 74274 74768 1 - - - true
+MGYG000303700_2 MGYG000303700_00553 74847 75293 1 - - - true
+MGYG000303700_2 MGYG000303700_00554 75303 75641 1 - - - true
+MGYG000303700_2 MGYG000303700_00556 75814 76590 -1 - - PF03332 true
+MGYG000303700_2 MGYG000303700_00557 76618 76869 -1 - - - true
+MGYG000303700_2 MGYG000303700_00558 77004 78797 -1 K02316 - PF10410,PF13155,PF13662,PF00772,PF01807 true
+MGYG000303700_2 MGYG000303700_00559 78852 80372 1 - - - true
+MGYG000303700_2 MGYG000303700_00560 80411 80737 -1 - - - true
+MGYG000303700_2 MGYG000303700_00561 80737 81273 -1 K13288 - PF00929 true
+MGYG000303700_2 MGYG000303700_00562 81286 82989 -1 K01887 - PF05746,PF00750,PF03485 false
+MGYG000303700_2 MGYG000303700_00563 83048 83380 -1 - - - true
+MGYG000303700_2 MGYG000303700_00564 83482 83574 1 - - - true
+MGYG000303700_2 MGYG000303700_00565 83564 84052 -1 - - - true
+MGYG000303700_2 MGYG000303700_00566 84045 85637 -1 K01937 - PF06418,PF00117 true
+MGYG000303700_2 MGYG000303700_00567 85785 86282 -1 K13993 - PF00011 true
+MGYG000303700_2 MGYG000303700_00568 86362 87123 1 - - PF00156 true
+MGYG000303700_2 MGYG000303700_00570 87264 87881 -1 - - - true
+MGYG000303700_2 MGYG000303700_00573 88245 89396 -1 K07258 - PF00768 true
+MGYG000303700_2 MGYG000303700_00574 89431 89826 1 K02503 - PF01230 true
+MGYG000303700_2 MGYG000303700_00575 89819 90259 1 K00783 - PF02590 true
+MGYG000303700_2 MGYG000303700_00576 90357 91664 -1 K01928 - PF08245,PF02875,PF01225 true
+MGYG000303700_2 MGYG000303700_00577 91710 92759 1 K01409 - - true
+MGYG000303700_2 MGYG000303700_00578 92795 93733 1 - - PF02388 true
+MGYG000303700_2 MGYG000303700_00579 93793 96354 1 K01873 - PF00133,PF10458,PF08264 true
+MGYG000303700_2 MGYG000303700_00580 96573 97673 1 K03086 - PF03979,PF00140,PF04539,PF04545,PF04542 true
+MGYG000303700_2 MGYG000303700_00581 97676 100210 1 K02335 - PF02739,PF01367,PF00476,PF01612 true
+MGYG000303700_2 MGYG000303700_00582 100376 102475 1 - - - true
+MGYG000303700_2 MGYG000303700_00583 102749 103384 1 - - - true
+MGYG000303700_2 MGYG000303700_00584 103393 103623 1 - - - true
+MGYG000303700_2 MGYG000303700_00585 103623 104504 1 K10563 - PF01149,PF06831,PF06827 true
+MGYG000303700_2 MGYG000303700_00586 104552 105022 -1 - - - true
+MGYG000303700_2 MGYG000303700_00587 105198 106157 -1 K04763 - PF00589,PF02899 true
+MGYG000303700_2 MGYG000303700_00589 106279 106788 1 - - - true
+MGYG000303700_2 MGYG000303700_00590 106778 107857 1 - - - true
+MGYG000303700_2 MGYG000303700_00591 107887 108489 1 - - - true
+MGYG000303700_2 MGYG000303700_00592 108551 110656 1 - - - true
+MGYG000303700_2 MGYG000303700_00593 110796 111920 1 - - - false
+MGYG000303700_2 MGYG000303700_00595 113122 115296 1 - - - false
+MGYG000303700_2 MGYG000303700_00596 115576 117402 1 K01868 - PF00587,PF07973,PF03129 true
+MGYG000303700_2 MGYG000303700_00597 117402 118334 1 K00791 - PF01715 true
+MGYG000303700_2 MGYG000303700_00598 118446 119093 1 - - - true
+MGYG000303700_2 MGYG000303700_00599 119093 119740 1 - - PF13483 true
+MGYG000303700_2 MGYG000303700_00600 120097 121977 1 - - - true
+MGYG000303700_2 MGYG000303700_00601 122112 124124 1 - - - true
+MGYG000303700_2 MGYG000303700_00602 124392 126389 1 - - - false
+MGYG000303700_2 MGYG000303700_00603 126753 127643 1 K03469,K06864 - PF13456 true
+MGYG000303700_2 MGYG000303700_00604 128491 128838 -1 K02887 - PF00453 true
+MGYG000303700_2 MGYG000303700_00605 128860 129054 -1 - - - true
+MGYG000303700_2 MGYG000303700_00606 129042 129512 -1 K02520 - PF05198,PF00707 true
+MGYG000303700_2 MGYG000303700_00608 129789 131282 -1 K07391 - PF13541,PF01078,PF13335 true
+MGYG000303700_2 MGYG000303700_00610 133386 133790 1 - - - true
+MGYG000303700_2 MGYG000303700_00611 133874 134347 1 - - - true
+MGYG000303700_2 MGYG000303700_00612 134350 137424 1 - - - true
+MGYG000303700_2 MGYG000303700_00613 137621 139630 1 K02470 - PF00986,PF02518,PF00204,PF01751 true
+MGYG000303700_2 MGYG000303700_00614 139643 142210 1 K02469 - PF03989,PF00521 true
+MGYG000303700_2 MGYG000303700_00615 142223 142729 1 K09775 - PF02681 true
+MGYG000303700_2 MGYG000303700_00617 144838 146571 1 - - - true
+MGYG000303700_2 MGYG000303700_00618 146779 148797 1 - - - false
+MGYG000303700_2 MGYG000303700_00619 148981 150228 1 - - - true
+MGYG000303700_2 MGYG000303700_00620 150295 151845 1 - - - true
+MGYG000303700_2 MGYG000303700_00621 152265 153296 1 - - - false
+MGYG000303700_2 MGYG000303700_00622 153456 155495 1 - - - false
+MGYG000303700_2 MGYG000303700_00625 156073 157053 1 - - - false
+MGYG000303700_2 MGYG000303700_00626 157226 157618 1 - - - true
+MGYG000303700_2 MGYG000303700_00627 157737 159746 1 - - - true
+MGYG000303700_2 MGYG000303700_00630 164050 164598 1 - - - true
+MGYG000303700_2 MGYG000303700_00631 164909 165469 1 - - - true
+MGYG000303700_2 MGYG000303700_00632 165675 166235 1 - - - true
+MGYG000303700_2 MGYG000303700_00633 166473 167129 1 - - - true
+MGYG000303700_2 MGYG000303700_00634 167270 168271 1 - - - true
+MGYG000303700_2 MGYG000303700_00635 168272 169165 1 - - - true
+MGYG000303700_2 MGYG000303700_00636 169459 170232 1 - - - true
+MGYG000303700_2 MGYG000303700_00637 170480 171754 1 - - - true
+MGYG000303700_2 MGYG000303700_00638 172048 172296 1 - - - true
+MGYG000303700_2 MGYG000303700_00639 172405 172845 -1 - - - true
+MGYG000303700_2 MGYG000303700_00640 172938 173258 1 - - - true
+MGYG000303700_2 MGYG000303700_00641 173255 175567 1 - - - true
+MGYG000303700_2 MGYG000303700_00642 175870 177918 1 - - - true
+MGYG000303700_2 MGYG000303700_00643 178009 179208 1 - - - true
+MGYG000303700_2 MGYG000303700_00644 179547 179819 -1 - - PF02604 true
+MGYG000303700_2 MGYG000303700_00645 179888 181174 1 K03797 - PF00595,PF03572,PF13180 true
+MGYG000303700_2 MGYG000303700_00646 181486 182124 -1 K03100 - PF00717 true
+MGYG000303700_2 MGYG000303700_00647 182252 183106 1 - - - true
+MGYG000303700_2 MGYG000303700_00648 183331 184497 -1 - - PF01844,PF03235 true
+MGYG000303700_2 MGYG000303700_00649 184689 185771 -1 - - PF13651 true
+MGYG000303700_2 MGYG000303700_00650 185963 186745 -1 K02493 - PF05175,PF13847 true
+MGYG000303700_2 MGYG000303700_00651 186805 187875 -1 K02835,K15034 - PF03462,PF00472 true
+MGYG000303700_2 MGYG000303700_00652 187951 188304 -1 K02909 - PF01197 true
+MGYG000303700_2 MGYG000303700_00653 188393 189370 -1 - - - true
+MGYG000303700_2 MGYG000303700_00654 189513 189728 1 - - - true
+MGYG000303700_2 MGYG000303700_00655 189922 191466 1 - - - true
+MGYG000303700_2 MGYG000303700_00656 191766 192809 1 K02945 - PF00575 true
+MGYG000303700_2 MGYG000303700_00657 192861 194642 1 K02519 - PF04760,PF00009,PF11987 true
+MGYG000303700_2 MGYG000303700_00658 194696 194977 -1 K19157 - PF15738 true
+MGYG000303700_2 MGYG000303700_00659 194952 195248 -1 K07473 - PF04221 true
+MGYG000303700_2 MGYG000303700_00660 195402 195704 -1 - - - true
+MGYG000303700_2 MGYG000303700_00661 195828 198314 1 - - - true
+MGYG000303700_2 MGYG000303700_00662 198335 200056 1 - - PF01345 true
+MGYG000303700_2 MGYG000303700_00663 200438 202354 1 - - - false
+MGYG000303700_2 MGYG000303700_00664 202743 204707 1 - - - true
+MGYG000303700_2 MGYG000303700_00665 204944 206464 1 - - - true
+MGYG000303700_2 MGYG000303700_00666 206573 207373 1 K03496 - PF13614 true
+MGYG000303700_2 MGYG000303700_00667 207392 208297 1 K03497 - PF02195 true
+MGYG000303700_2 MGYG000303700_00668 208306 209100 1 K06966 - PF03641 true
+MGYG000303700_2 MGYG000303700_00669 209387 210475 1 K02836 - PF03462,PF00472 true
+MGYG000303700_2 MGYG000303700_00670 210941 211438 -1 - - - false
+MGYG000303700_2 MGYG000303700_00671 211490 211708 -1 - - - false
+MGYG000304142_1 MGYG000304142_00001 361 726 1 - - - true
+MGYG000304142_1 MGYG000304142_00002 1005 1910 1 - - - true
+MGYG000304142_1 MGYG000304142_00003 2183 2563 1 - - - true
+MGYG000304142_1 MGYG000304142_00004 2590 4353 1 - - - true
+MGYG000304142_1 MGYG000304142_00005 4350 5393 1 - - - true
+MGYG000304142_1 MGYG000304142_00006 5416 6753 1 - - - true
+MGYG000304142_1 MGYG000304142_00007 6704 7876 1 - - - true
+MGYG000304142_1 MGYG000304142_00008 8034 8363 1 - - - false
+MGYG000304142_1 MGYG000304142_00009 8430 9308 1 - - - true
+MGYG000304142_1 MGYG000304142_00010 10753 11493 -1 - - - true
+MGYG000304142_1 MGYG000304142_00011 11630 11959 1 - - - true
+MGYG000304142_1 MGYG000304142_00012 11965 12804 -1 - - - true
+MGYG000304142_1 MGYG000304142_00013 12843 14705 1 - - - true
+MGYG000304142_1 MGYG000304142_00014 14836 14970 -1 - - - true
+MGYG000304142_1 MGYG000304142_00015 15129 15608 1 - - - true
+MGYG000304142_1 MGYG000304142_00016 15716 16123 1 - - - true
+MGYG000304142_1 MGYG000304142_00017 16221 17309 1 - - - true
+MGYG000304142_1 MGYG000304142_00018 17470 17973 1 - - - true
+MGYG000304142_1 MGYG000304142_00019 18087 18551 1 - - - true
+MGYG000304142_1 MGYG000304142_00020 18672 19130 1 - - - true
+MGYG000304142_1 MGYG000304142_00021 19245 20129 1 - - - true
+MGYG000304142_1 MGYG000304142_00022 20249 21145 1 - - - true
+MGYG000304142_1 MGYG000304142_00023 21282 22199 1 - - - true
+MGYG000304142_1 MGYG000304142_00024 22326 23207 1 - - - true
+MGYG000304142_1 MGYG000304142_00027 24290 25213 1 - - - true
+MGYG000304142_1 MGYG000304142_00028 25351 26223 1 - - - true
+MGYG000304142_1 MGYG000304142_00029 26186 26362 1 - - - false
+MGYG000304142_1 MGYG000304142_00030 26355 27275 1 - - - false
+MGYG000304142_1 MGYG000304142_00031 27412 28275 1 - - - false
+MGYG000304142_1 MGYG000304142_00032 28407 29237 1 - - - true
+MGYG000304142_1 MGYG000304142_00033 29360 30295 1 - - - true
+MGYG000304142_1 MGYG000304142_00034 30463 31284 1 - - - true
+MGYG000304142_1 MGYG000304142_00035 31461 32339 1 - - - true
+MGYG000304142_1 MGYG000304142_00036 32485 33375 1 - - - true
+MGYG000304142_1 MGYG000304142_00037 33754 34716 1 - - - true
+MGYG000304142_1 MGYG000304142_00038 34785 37706 -1 - - - true
+MGYG000304142_1 MGYG000304142_00039 37866 38315 1 - - - true
+MGYG000304142_1 MGYG000304142_00040 38394 38774 -1 - - - true
+MGYG000304142_1 MGYG000304142_00041 38826 40076 -1 - - - true
+MGYG000304142_1 MGYG000304142_00042 40236 40538 1 - - - false
+MGYG000304142_1 MGYG000304142_00043 40626 41177 -1 - - - true
+MGYG000304142_1 MGYG000304142_00044 41187 43139 -1 - - - true
+MGYG000304142_1 MGYG000304142_00045 43163 45058 -1 - - - true
+MGYG000304142_1 MGYG000304142_00046 45051 45731 -1 - - - true
+MGYG000304142_1 MGYG000304142_00047 46373 46804 -1 - - - true
+MGYG000304142_1 MGYG000304142_00048 46947 49793 -1 - - - true
+MGYG000304142_1 MGYG000304142_00049 49915 51201 -1 - - - true
+MGYG000304142_1 MGYG000304142_00050 51204 52499 -1 - - - true
+MGYG000304142_1 MGYG000304142_00051 52617 52718 -1 - - - false
+MGYG000304142_1 MGYG000304142_00052 52763 52855 -1 - - - false
+MGYG000304142_1 MGYG000304142_00053 53250 54293 -1 - - - true
+MGYG000304142_1 MGYG000304142_00054 54432 56849 -1 - - - true
+MGYG000304142_1 MGYG000304142_00055 56992 57411 1 - - - true
+MGYG000304142_1 MGYG000304142_00056 57533 58060 1 - - - false
+MGYG000304142_1 MGYG000304142_00057 58198 58725 1 - - - true
+MGYG000304142_1 MGYG000304142_00059 58995 60167 -1 K00694,K00786 GT2 PF13632,PF13641 false
+MGYG000304142_1 MGYG000304142_00060 60176 60508 -1 - - - false
+MGYG000304142_1 MGYG000304142_00061 60548 60859 -1 - - - true
+MGYG000304142_1 MGYG000304142_00062 60859 62124 -1 - - - true
+MGYG000304142_1 MGYG000304142_00063 62196 63434 1 - - - true
+MGYG000304142_1 MGYG000304142_00064 63409 64509 -1 - - - false
+MGYG000304142_1 MGYG000304142_00065 65178 67037 -1 - - PF13175 false
+MGYG000304142_1 MGYG000304142_00066 67049 69262 -1 - - PF04851,PF00271 false
+MGYG000304142_1 MGYG000304142_00067 69256 70836 -1 K07316 - PF01555,PF12564 false
+MGYG000304142_1 MGYG000304142_00068 70836 71048 -1 - - PF13443,PF14326,PF01381 false
+MGYG000304142_1 MGYG000304142_00069 71136 72077 -1 - - PF14088 false
+MGYG000304142_1 MGYG000304142_00070 72134 73585 1 - - - true
+MGYG000304142_1 MGYG000304142_00071 73833 75065 -1 - - - true
+MGYG000304142_1 MGYG000304142_00072 75158 75433 -1 - - - true
+MGYG000304142_1 MGYG000304142_00073 75657 75974 -1 - - - true
+MGYG000304142_1 MGYG000304142_00074 76154 77335 -1 - - - true
+MGYG000304142_1 MGYG000304142_00075 77517 77891 -1 - - - true
+MGYG000304142_1 MGYG000304142_00076 77948 78469 -1 - - - true
+MGYG000304142_1 MGYG000304142_00077 78678 79880 1 - - - true
+MGYG000304142_1 MGYG000304142_00078 79858 81264 -1 - - - true
+MGYG000304142_1 MGYG000304142_00079 81329 81658 -1 - - - false
+MGYG000304142_1 MGYG000304142_00080 81751 82404 -1 - - - false
+MGYG000304142_1 MGYG000304142_00081 82405 82752 -1 - - - false
+MGYG000304142_1 MGYG000304142_00082 82887 83210 -1 - - - true
+MGYG000304142_1 MGYG000304142_00083 83788 84900 -1 - - - true
+MGYG000304142_1 MGYG000304142_00084 85022 85651 1 - - - true
+MGYG000304142_1 MGYG000304142_00085 85694 86323 -1 - - - true
+MGYG000304142_1 MGYG000304142_00086 86323 86622 -1 - - - true
+MGYG000304142_1 MGYG000304142_00087 86666 88195 1 - - - true
+MGYG000304142_1 MGYG000304142_00088 88243 89628 -1 - - - true
+MGYG000304142_1 MGYG000304142_00089 89615 91195 -1 - - - true
+MGYG000304142_1 MGYG000304142_00090 91349 92140 -1 - - - true
+MGYG000304142_1 MGYG000304142_00091 92209 93456 -1 - - - true
+MGYG000304142_1 MGYG000304142_00092 93460 93663 -1 - - - true
+MGYG000304142_1 MGYG000304142_00093 93735 94937 -1 - - - true
+MGYG000304142_1 MGYG000304142_00094 94970 95866 -1 - - - true
+MGYG000304142_1 MGYG000304142_00095 95866 99150 -1 - - - true
+MGYG000304142_1 MGYG000304142_00096 99150 99401 -1 - - - true
+MGYG000304142_1 MGYG000304142_00097 99419 100768 -1 - - - true
+MGYG000304142_1 MGYG000304142_00098 100790 101284 -1 - - - true
+MGYG000304142_1 MGYG000304142_00099 101268 101888 -1 - - - true
+MGYG000304142_1 MGYG000304142_00101 102297 103577 1 - - - true
+MGYG000304142_1 MGYG000304142_00102 103570 104772 1 - - - true
+MGYG000304142_1 MGYG000304142_00103 104774 106468 1 - - - true
+MGYG000304142_1 MGYG000304142_00104 106449 107102 1 - - - true
+MGYG000304142_1 MGYG000304142_00105 107137 107358 -1 - - - true
+MGYG000304142_1 MGYG000304142_00106 107443 108027 -1 - - - true
+MGYG000304142_1 MGYG000304142_00107 108173 108754 -1 - - - true
+MGYG000304142_1 MGYG000304142_00108 108854 109117 -1 - - - true
+MGYG000304142_1 MGYG000304142_00109 109114 109578 -1 - - - true
+MGYG000304142_1 MGYG000304142_00110 109584 110972 -1 - - - true
+MGYG000304142_1 MGYG000304142_00111 111047 112312 -1 - - - true
+MGYG000304142_1 MGYG000304142_00112 112403 113272 1 - - - true
+MGYG000304142_1 MGYG000304142_00113 113318 114256 1 - - - true
+MGYG000304142_1 MGYG000304142_00117 114792 115439 -1 - - - true
+MGYG000304142_1 MGYG000304142_00118 115458 116291 -1 - - - true
+MGYG000304142_1 MGYG000304142_00119 116284 117162 -1 - - - true
+MGYG000304142_1 MGYG000304142_00120 117163 118182 -1 - - - true
+MGYG000304142_1 MGYG000304142_00121 118246 118644 -1 - - - true
+MGYG000304142_1 MGYG000304142_00122 118644 119069 -1 - - - true
+MGYG000304142_1 MGYG000304142_00123 119069 119485 -1 - - - true
+MGYG000304142_1 MGYG000304142_00124 119489 120412 -1 - - - true
+MGYG000304142_1 MGYG000304142_00125 120427 121044 -1 - - - true
+MGYG000304142_1 MGYG000304142_00126 121048 121467 -1 - - - true
+MGYG000304142_1 MGYG000304142_00127 121506 121892 -1 - - - true
+MGYG000304142_1 MGYG000304142_00128 121901 122017 -1 - - - true
+MGYG000304142_1 MGYG000304142_00129 122014 122292 -1 - - - true
+MGYG000304142_1 MGYG000304142_00130 122403 125747 -1 - - - true
+MGYG000304142_1 MGYG000304142_00131 125939 126490 -1 - - - false
+MGYG000304142_1 MGYG000304142_00132 126540 127100 -1 - - - true
+MGYG000304142_1 MGYG000304142_00133 127164 127901 -1 - - - true
+MGYG000304142_1 MGYG000304142_00134 127885 129246 -1 - - - true
+MGYG000304142_1 MGYG000304142_00135 129336 130826 1 - - - true
+MGYG000304142_1 MGYG000304142_00136 130861 132408 1 - - - true
+MGYG000304142_1 MGYG000304142_00138 132555 133778 1 - - - true
+MGYG000304142_1 MGYG000304142_00139 133839 134957 1 - - - true
+MGYG000304142_1 MGYG000304142_00140 134976 135668 1 - - - true
+MGYG000304142_1 MGYG000304142_00141 135754 136224 -1 - - - true
+MGYG000304142_1 MGYG000304142_00142 136224 136865 -1 - - - true
+MGYG000304142_1 MGYG000304142_00143 136865 137206 -1 - - - true
+MGYG000304142_1 MGYG000304142_00144 137206 137742 -1 - - - true
+MGYG000304142_1 MGYG000304142_00145 137759 138160 -1 - - - true
+MGYG000304142_1 MGYG000304142_00146 138176 138445 -1 - - - true
+MGYG000304142_1 MGYG000304142_00147 138445 139029 -1 - - - true
+MGYG000304142_1 MGYG000304142_00148 139029 139328 -1 - - - true
+MGYG000304142_1 MGYG000304142_00149 139328 139696 -1 - - - true
+MGYG000304142_1 MGYG000304142_00150 139696 140031 -1 - - - true
+MGYG000304142_1 MGYG000304142_00151 140028 140339 -1 - - - true
+MGYG000304142_1 MGYG000304142_00152 140339 140755 -1 - - - true
+MGYG000304142_1 MGYG000304142_00153 140756 141388 -1 - - - true
+MGYG000304142_1 MGYG000304142_00154 141388 141810 -1 - - - true
+MGYG000304142_1 MGYG000304142_00155 141810 142070 -1 - - - true
+MGYG000304142_1 MGYG000304142_00156 142070 142918 -1 - - - true
+MGYG000304142_1 MGYG000304142_00157 142920 143225 -1 - - - true
+MGYG000304142_1 MGYG000304142_00158 143225 143824 -1 - - - true
+MGYG000304142_1 MGYG000304142_00159 143824 144465 -1 - - - true
+MGYG000304142_1 MGYG000304142_00160 144644 145126 -1 - - - true
+MGYG000304142_1 MGYG000304142_00161 145138 145587 -1 - - - true
+MGYG000304142_1 MGYG000304142_00162 145690 146118 -1 - - - true
+MGYG000304142_1 MGYG000304142_00163 146199 147896 -1 - - - true
+MGYG000304142_1 MGYG000304142_00164 147889 148893 -1 - - - true
+MGYG000304142_1 MGYG000304142_00165 148959 149873 -1 - - - true
+MGYG000304142_1 MGYG000304142_00166 149922 150350 -1 - - - true
+MGYG000304142_1 MGYG000304142_00167 150431 150979 -1 - - - true
+MGYG000304142_1 MGYG000304142_00168 150979 151230 -1 - - - true
+MGYG000304142_1 MGYG000304142_00169 151306 152595 -1 - - - true
+MGYG000304142_1 MGYG000304142_00170 152707 153132 -1 - - - true
+MGYG000304142_1 MGYG000304142_00171 153211 154212 -1 - - - true
+MGYG000304142_1 MGYG000304142_00172 154215 155354 -1 - - - true
+MGYG000304142_1 MGYG000304142_00173 155377 155844 -1 - - - true
+MGYG000304142_1 MGYG000304142_00174 155846 156667 -1 - - - true
+MGYG000304142_1 MGYG000304142_00175 156667 157194 -1 - - - true
+MGYG000304142_1 MGYG000304142_00176 157221 157385 -1 - - - true
+MGYG000304142_1 MGYG000304142_00177 157457 157744 1 - - - true
+MGYG000304142_1 MGYG000304142_00178 157789 159213 -1 - - - true
+MGYG000304142_1 MGYG000304142_00179 159708 160016 -1 - - - true
+MGYG000304142_1 MGYG000304142_00180 160204 161760 -1 - - - true
+MGYG000304142_1 MGYG000304142_00181 161831 163507 -1 - - - true
+MGYG000304142_1 MGYG000304142_00182 163647 165149 1 - - - true
+MGYG000304142_1 MGYG000304142_00183 165146 166150 -1 - - - true
+MGYG000304142_1 MGYG000304142_00185 166357 167319 -1 - - - true
+MGYG000304142_1 MGYG000304142_00186 167338 168408 -1 - - - true
+MGYG000304142_1 MGYG000304142_00187 168405 169589 -1 - - - true
+MGYG000304142_1 MGYG000304142_00188 169673 171757 -1 - - - true
+MGYG000304142_1 MGYG000304142_00189 171777 172256 -1 - - - true
+MGYG000304142_1 MGYG000304142_00190 172259 172672 -1 - - - true
+MGYG000304142_1 MGYG000304142_00191 172783 173649 -1 - - - true
+MGYG000304142_1 MGYG000304142_00192 174018 174602 -1 - - - true
+MGYG000304142_1 MGYG000304142_00193 174693 175088 -1 - - - true
+MGYG000304142_1 MGYG000304142_00194 175186 175674 1 - - - true
+MGYG000304142_1 MGYG000304142_00195 175742 176323 -1 - - - true
+MGYG000304142_1 MGYG000304142_00196 176379 176813 -1 - - - true
+MGYG000304142_1 MGYG000304142_00197 176806 177495 -1 - - - true
+MGYG000304142_1 MGYG000304142_00198 177495 178103 -1 - - - true
+MGYG000304142_1 MGYG000304142_00199 178391 178852 -1 - - - true
+MGYG000304142_1 MGYG000304142_00200 179254 180201 -1 - - - true
+MGYG000304142_1 MGYG000304142_00201 180422 181078 -1 - - - true
+MGYG000304142_1 MGYG000304142_00202 181458 182633 -1 - - - true
+MGYG000304142_1 MGYG000304142_00203 182617 184557 -1 - - - true
+MGYG000304142_1 MGYG000304142_00204 184563 186326 -1 - - - true
+MGYG000304142_1 MGYG000304142_00205 186363 188807 -1 - - - true
+MGYG000304142_1 MGYG000304142_00206 188850 189776 -1 - - - true
+MGYG000304142_1 MGYG000304142_00207 189846 193688 -1 - - - true
+MGYG000304142_1 MGYG000304142_00208 193688 197119 -1 - - - true
+MGYG000304142_1 MGYG000304142_00209 197330 198016 -1 - - - true
+MGYG000304142_1 MGYG000304142_00210 198096 198308 -1 - - - true
+MGYG000304142_1 MGYG000304142_00211 198432 198992 -1 - - - true
+MGYG000304142_1 MGYG000304142_00212 198979 199806 -1 - - - true
+MGYG000304142_1 MGYG000304142_00213 199806 201854 -1 - - - true
+MGYG000304142_1 MGYG000304142_00214 201856 202494 -1 - - - true
+MGYG000304142_1 MGYG000304142_00215 202509 203729 -1 - - - true
+MGYG000304142_1 MGYG000304142_00216 203817 206534 1 - - - true
+MGYG000304142_1 MGYG000304142_00217 206556 207650 1 - - - true
+MGYG000304142_1 MGYG000304142_00218 207604 208587 -1 - - - true
+MGYG000304142_1 MGYG000304142_00219 208643 209989 -1 - - - true
+MGYG000304142_1 MGYG000304142_00220 210008 212827 -1 - - - true
+MGYG000304142_1 MGYG000304142_00221 212943 213986 -1 - - - true
+MGYG000304142_1 MGYG000304142_00222 214091 216568 1 - - - true
+MGYG000304142_1 MGYG000304142_00223 216560 217525 -1 - - - true
+MGYG000304142_1 MGYG000304142_00224 217515 217970 -1 - - - true
+MGYG000304142_1 MGYG000304142_00225 218039 219742 -1 - - - true
+MGYG000304142_1 MGYG000304142_00226 219797 220354 1 - - - true
+MGYG000304142_1 MGYG000304142_00227 220355 224179 -1 - - - true
+MGYG000304142_1 MGYG000304142_00228 224195 224518 -1 - - - true
+MGYG000304142_1 MGYG000304142_00229 224502 224792 -1 - - - true
+MGYG000304142_1 MGYG000304142_00230 224861 225742 -1 - - - true
+MGYG000304142_1 MGYG000304142_00231 225825 227315 -1 - - - true
+MGYG000304142_1 MGYG000304142_00232 227324 227752 -1 - - - true
+MGYG000304142_1 MGYG000304142_00233 227752 229161 -1 - - - true
+MGYG000304142_1 MGYG000304142_00234 229170 229454 -1 - - - true
+MGYG000304142_1 MGYG000304142_00235 229506 230168 -1 - - - true
+MGYG000304142_1 MGYG000304142_00236 230198 232171 -1 - - - true
+MGYG000304142_1 MGYG000304142_00237 232221 233204 -1 - - - true
+MGYG000304142_1 MGYG000304142_00238 233204 234109 -1 - - - true
+MGYG000304142_1 MGYG000304142_00239 234163 235143 -1 - - - true
+MGYG000304142_1 MGYG000304142_00240 235136 235966 -1 - - - true
+MGYG000304142_1 MGYG000304142_00241 235976 236632 -1 - - - true
+MGYG000304142_1 MGYG000304142_00242 236629 237081 -1 - - - true
+MGYG000304142_1 MGYG000304142_00243 237169 238176 -1 - - - true
+MGYG000304142_1 MGYG000304142_00244 238237 240168 -1 - - - true
+MGYG000304142_1 MGYG000304142_00245 240266 241750 1 - - - true
+MGYG000304142_1 MGYG000304142_00246 241803 242330 -1 - - - true
+MGYG000304142_1 MGYG000304142_00247 242352 243074 -1 - - - true
+MGYG000304142_1 MGYG000304142_00248 243155 244156 1 - - - true
+MGYG000304142_1 MGYG000304142_00249 244199 244819 -1 - - - true
+MGYG000304142_1 MGYG000304142_00250 244834 247335 -1 - - - true
+MGYG000304142_1 MGYG000304142_00251 247345 248367 -1 - - - true
+MGYG000304142_1 MGYG000304142_00252 248386 249015 -1 - - - true
+MGYG000304142_1 MGYG000304142_00253 249015 249278 -1 - - - true
+MGYG000304142_1 MGYG000304142_00254 249337 250488 1 - - - true
+MGYG000304142_1 MGYG000304142_00255 250551 251615 -1 - - - true
+MGYG000304142_1 MGYG000304142_00256 251640 252440 -1 - - - true
+MGYG000304142_1 MGYG000304142_00257 252440 253243 -1 - - - true
+MGYG000304142_1 MGYG000304142_00258 253243 253749 -1 - - - true
+MGYG000304142_1 MGYG000304142_00259 253786 254802 1 - - - true
+MGYG000304142_1 MGYG000304142_00260 254825 256102 1 - - - true
+MGYG000304142_1 MGYG000304142_00261 256142 256411 -1 - - - true
+MGYG000304142_1 MGYG000304142_00262 256479 256673 -1 - - - true
+MGYG000304142_1 MGYG000304142_00263 256663 257616 -1 - - - true
+MGYG000304142_1 MGYG000304142_00264 257634 259367 -1 - - - true
+MGYG000304142_1 MGYG000304142_00265 259414 260055 1 - - - true
+MGYG000304142_1 MGYG000304142_00267 260233 261870 -1 - - - true
+MGYG000304142_1 MGYG000304142_00268 261938 262579 1 - - - true
+MGYG000304142_1 MGYG000304142_00269 262579 263388 1 - - - true
+MGYG000304142_1 MGYG000304142_00270 263448 265538 1 - - - true
+MGYG000304142_1 MGYG000304142_00271 265769 266482 -1 - - - true
+MGYG000304142_1 MGYG000304142_00272 266536 266898 -1 - - - true
+MGYG000304142_1 MGYG000304142_00273 266986 267327 -1 - - - true
+MGYG000304142_1 MGYG000304142_00274 267888 268151 1 - - - false
+MGYG000304142_1 MGYG000304142_00275 268179 268370 1 - - - false
+MGYG000304142_1 MGYG000304142_00276 268457 268705 1 - - - false
+MGYG000304142_1 MGYG000304142_00277 268702 269262 1 - - - false
+MGYG000304142_1 MGYG000304142_00278 269263 270048 1 - - - false
+MGYG000304142_1 MGYG000304142_00279 270269 270526 1 - - - false
+MGYG000304142_1 MGYG000304142_00280 270526 270966 1 - - - false
+MGYG000304142_1 MGYG000304142_00281 270959 271654 1 - - - false
+MGYG000304142_1 MGYG000304142_00282 271651 272148 1 - - - false
+MGYG000304142_1 MGYG000304142_00283 272223 272570 1 - - - false
+MGYG000304142_1 MGYG000304142_00284 272598 272930 1 - - - false
+MGYG000304142_1 MGYG000304142_00285 272921 273397 1 K01494 - PF06559 false
+MGYG000304142_1 MGYG000304142_00286 273462 273713 -1 - - - false
+MGYG000304142_1 MGYG000304142_00287 273732 274700 -1 K01447 - PF01476,PF01510 false
+MGYG000304142_1 MGYG000304142_00288 274697 274981 -1 - - - false
+MGYG000304142_1 MGYG000304142_00289 275239 277047 -1 - - PF05895 false
+MGYG000304142_1 MGYG000304142_00290 277048 280806 -1 - - PF01345 false
+MGYG000304142_1 MGYG000304142_00291 280807 281574 -1 - - - false
+MGYG000304142_1 MGYG000304142_00292 281575 281940 -1 - - - false
+MGYG000304142_1 MGYG000304142_00293 282064 282708 -1 - - PF04103 false
+MGYG000304142_1 MGYG000304142_00294 282839 285559 -1 - - - false
+MGYG000304142_1 MGYG000304142_00295 285848 286186 -1 - - - false
+MGYG000304142_1 MGYG000304142_00296 286246 286680 -1 - - - false
+MGYG000304142_1 MGYG000304142_00297 286694 287032 -1 - - - false
+MGYG000304142_1 MGYG000304142_00298 287034 287498 -1 - - PF04883 false
+MGYG000304142_1 MGYG000304142_00299 287495 287827 -1 - - - false
+MGYG000304142_1 MGYG000304142_00300 287811 288194 -1 - - - false
+MGYG000304142_1 MGYG000304142_00301 288212 289072 -1 - - - false
+MGYG000304142_1 MGYG000304142_00302 289091 289651 -1 - - PF14265 false
+MGYG000304142_1 MGYG000304142_00303 289788 290117 -1 - - - false
+MGYG000304142_1 MGYG000304142_00304 290104 292491 -1 - - PF04233 false
+MGYG000304142_1 MGYG000304142_00305 292492 293853 -1 - - PF05133 false
+MGYG000304142_1 MGYG000304142_00306 293868 295289 -1 - - - false
+MGYG000304142_1 MGYG000304142_00307 295289 295720 -1 - - - false
+MGYG000304142_1 MGYG000304142_00308 295713 296153 -1 - - - false
+MGYG000304142_1 MGYG000304142_00309 296347 296748 1 - - - false
+MGYG000304142_1 MGYG000304142_00310 297028 297924 1 K03733 - PF00589,PF02899 false
+MGYG000304142_1 MGYG000304142_00311 298179 299528 -1 - - - true
+MGYG000304142_1 MGYG000304142_00312 299544 300236 -1 - - - true
+MGYG000304142_1 MGYG000304142_00313 300233 300595 -1 - - - true
+MGYG000304142_1 MGYG000304142_00314 300592 301287 -1 - - - true
+MGYG000304142_1 MGYG000304142_00315 301340 302026 -1 - - - true
+MGYG000304142_1 MGYG000304142_00316 302079 302315 -1 - - - true
+MGYG000304142_1 MGYG000304142_00317 302299 303507 -1 - - - true
+MGYG000304142_1 MGYG000304142_00318 303500 304579 -1 - - - true
+MGYG000304142_1 MGYG000304142_00319 304682 305920 1 - - - true
+MGYG000304142_1 MGYG000304142_00320 305973 306245 1 - - - true
+MGYG000304142_1 MGYG000304142_00321 306342 306740 -1 - - - true
+MGYG000304142_1 MGYG000304142_00322 306776 307591 -1 - - - true
+MGYG000304142_1 MGYG000304142_00323 307592 308239 -1 - - - true
+MGYG000304142_1 MGYG000304142_00324 308190 308678 -1 - - - true
+MGYG000304142_1 MGYG000304142_00325 308729 308872 -1 - - - true
+MGYG000304142_1 MGYG000304142_00326 308983 309462 1 - - - true
+MGYG000304142_1 MGYG000304142_00327 309535 311976 -1 - - - true
+MGYG000304142_1 MGYG000304142_00328 312001 313299 -1 - - - true
+MGYG000304142_1 MGYG000304142_00329 313307 315676 -1 - - - true
+MGYG000304142_1 MGYG000304142_00331 315835 315981 -1 - - - true
+MGYG000304142_1 MGYG000304142_00332 316016 318061 -1 - - - true
+MGYG000304142_1 MGYG000304142_00333 318072 318359 -1 - - - true
+MGYG000304142_1 MGYG000304142_00334 318359 319780 -1 - - - true
+MGYG000304142_1 MGYG000304142_00335 319782 320612 -1 - - - true
+MGYG000304142_1 MGYG000304142_00336 320668 321261 -1 - - - true
+MGYG000304142_1 MGYG000304142_00337 321339 322274 -1 - - - true
+MGYG000304142_1 MGYG000304142_00342 323038 323661 -1 - - - true
+MGYG000304142_1 MGYG000304142_00343 323661 324953 -1 - - - true
+MGYG000304142_1 MGYG000304142_00344 324983 326242 -1 - - - true
+MGYG000304142_1 MGYG000304142_00345 326277 328235 -1 - - - true
+MGYG000304142_1 MGYG000304142_00347 328407 330032 -1 - - - true
+MGYG000304142_1 MGYG000304142_00349 331447 332145 -1 - - - true
+MGYG000304142_1 MGYG000304142_00350 332138 333271 -1 - - - true
+MGYG000304142_1 MGYG000304142_00351 333318 333974 1 - - - true
+MGYG000304142_1 MGYG000304142_00352 333977 335698 1 - - - true
+MGYG000304142_1 MGYG000304142_00357 336237 338075 1 - - - true
+MGYG000304142_1 MGYG000304142_00358 338123 340951 -1 - - - true
+MGYG000304142_1 MGYG000304142_00359 340980 341984 -1 - - - true
+MGYG000304142_1 MGYG000304142_00360 341994 343424 -1 - - - true
+MGYG000304142_1 MGYG000304142_00361 343453 344622 -1 - - - true
+MGYG000304142_1 MGYG000304142_00362 344681 345865 -1 - - - true
+MGYG000304142_1 MGYG000304142_00363 345858 346298 -1 - - - true
+MGYG000304142_1 MGYG000304142_00364 346298 348244 -1 - - - true
+MGYG000304142_1 MGYG000304142_00365 348254 349516 -1 - - - true
+MGYG000304142_1 MGYG000304142_00366 349540 350106 -1 - - - true
+MGYG000304142_1 MGYG000304142_00367 350107 351243 -1 - - - true
+MGYG000304142_1 MGYG000304142_00368 351336 352007 -1 - - - true
+MGYG000304142_1 MGYG000304142_00369 352000 352782 -1 - - - true
+MGYG000304142_1 MGYG000304142_00370 352787 354910 -1 - - - true
+MGYG000304142_1 MGYG000304142_00371 355065 355340 -1 - - - true
+MGYG000304142_1 MGYG000304142_00372 355372 358497 -1 - - - true
+MGYG000304142_1 MGYG000304142_00373 358537 359625 -1 - - - true
+MGYG000304142_1 MGYG000304142_00374 359685 361556 -1 - - - true
+MGYG000304142_1 MGYG000304142_00375 361675 362151 -1 - - - true
+MGYG000304142_1 MGYG000304142_00376 362138 362881 -1 - - - true
+MGYG000304142_1 MGYG000304142_00377 362927 363313 -1 - - - true
+MGYG000304142_1 MGYG000304142_00378 363303 363830 -1 - - - true
+MGYG000304142_1 MGYG000304142_00379 363860 364561 1 - - - true
+MGYG000304142_1 MGYG000304142_00380 364572 365834 -1 - - - true
+MGYG000304142_1 MGYG000304142_00381 365827 366582 -1 - - - true
+MGYG000304142_1 MGYG000304142_00382 366633 367460 -1 - - - true
+MGYG000304142_1 MGYG000304142_00383 367515 368399 1 - - - true
+MGYG000304142_1 MGYG000304142_00384 368427 370235 1 - - - true
+MGYG000304142_1 MGYG000304142_00385 370273 370911 -1 - - - true
+MGYG000304142_1 MGYG000304142_00386 370911 371546 -1 - - - true
+MGYG000304142_1 MGYG000304142_00387 371595 372905 -1 - - - true
+MGYG000304142_1 MGYG000304142_00388 372970 374508 1 - - - true
+MGYG000304142_1 MGYG000304142_00389 374517 374909 1 - - - true
+MGYG000304142_1 MGYG000304142_00390 374896 375120 1 - - - true
+MGYG000304142_1 MGYG000304142_00391 375120 376925 1 - - - true
+MGYG000304142_1 MGYG000304142_00392 376930 378219 -1 - - - true
+MGYG000304142_1 MGYG000304142_00393 378317 379258 1 - - - true
+MGYG000304142_1 MGYG000304142_00394 379307 379981 -1 - - - true
+MGYG000304142_1 MGYG000304142_00395 380064 381596 -1 - - - true
+MGYG000304142_1 MGYG000304142_00396 381647 384085 -1 - - - true
+MGYG000304142_1 MGYG000304142_00397 384195 385601 -1 - - - true
+MGYG000304142_1 MGYG000304142_00398 385629 386672 -1 - - - true
+MGYG000304142_1 MGYG000304142_00399 386669 387286 -1 - - - true
+MGYG000304142_1 MGYG000304142_00400 387277 388428 -1 - - - true
+MGYG000304142_1 MGYG000304142_00401 388446 389249 -1 - - - true
+MGYG000304142_1 MGYG000304142_00402 389236 390771 -1 - - - true
+MGYG000304142_1 MGYG000304142_00403 391541 392401 -1 - - - true
+MGYG000304142_1 MGYG000304142_00404 392349 393521 -1 - - - true
+MGYG000304142_1 MGYG000304142_00405 393566 395755 -1 - - - true
+MGYG000304142_1 MGYG000304142_00406 395768 397171 -1 - - - true
+MGYG000304142_1 MGYG000304142_00407 397164 397946 -1 - - - true
+MGYG000304142_1 MGYG000304142_00408 398002 399234 -1 - - - true
+MGYG000304142_1 MGYG000304142_00409 399244 400659 -1 - - - true
+MGYG000304142_1 MGYG000304142_00410 400709 401101 -1 - - - true
+MGYG000304142_1 MGYG000304142_00411 401119 401322 -1 - - - true
+MGYG000304142_1 MGYG000304142_00413 401500 402324 -1 - - - true
+MGYG000304142_1 MGYG000304142_00415 402457 404556 -1 - - - true
+MGYG000304142_1 MGYG000304142_00416 404599 405810 1 - - - true
+MGYG000304142_1 MGYG000304142_00417 405871 407760 1 - - - true
+MGYG000304142_1 MGYG000304142_00418 407764 408948 1 - - - true
+MGYG000304142_1 MGYG000304142_00420 409077 409595 -1 - - - true
+MGYG000304142_1 MGYG000304142_00421 409603 411783 -1 - - - true
+MGYG000304142_1 MGYG000304142_00422 411966 412640 1 - - - true
+MGYG000304142_1 MGYG000304142_00423 412627 413955 1 - - - true
+MGYG000304142_1 MGYG000304142_00424 413952 414398 1 - - - true
+MGYG000304142_1 MGYG000304142_00425 414388 415545 1 - - - true
+MGYG000304142_1 MGYG000304142_00426 415515 417728 -1 - - - true
+MGYG000304142_1 MGYG000304142_00428 417996 418418 1 - - - true
+MGYG000304142_1 MGYG000304142_00429 418437 419015 1 - - - true
+MGYG000304142_1 MGYG000304142_00431 419161 419865 -1 - - - true
+MGYG000304142_1 MGYG000304142_00434 420071 422491 -1 - - - true
+MGYG000304142_1 MGYG000304142_00435 422476 422862 -1 - - - true
+MGYG000304142_1 MGYG000304142_00436 422937 423656 1 - - - true
+MGYG000304142_1 MGYG000304142_00438 423822 425267 1 - - - true
+MGYG000304142_1 MGYG000304142_00439 425268 426734 -1 - - - true
+MGYG000304142_1 MGYG000304142_00441 426928 427557 1 - - - true
+MGYG000304142_1 MGYG000304142_00442 427573 429381 -1 - - - true
+MGYG000304142_1 MGYG000304142_00443 429381 431069 -1 - - - true
+MGYG000304142_1 MGYG000304142_00444 431080 432987 -1 - - - true
+MGYG000304142_1 MGYG000304142_00445 433014 433892 -1 - - - true
+MGYG000304142_1 MGYG000304142_00446 433989 434189 1 - - - true
+MGYG000304142_1 MGYG000304142_00449 434549 435976 -1 - - - true
+MGYG000304142_1 MGYG000304142_00450 435976 436863 -1 - - - true
+MGYG000304142_1 MGYG000304142_00451 436857 437600 -1 - - - true
+MGYG000304142_1 MGYG000304142_00452 437575 438495 -1 - - - true
+MGYG000304142_1 MGYG000304142_00453 438562 439428 -1 - - - true
+MGYG000304142_1 MGYG000304142_00454 439495 440007 -1 - - - true
+MGYG000304142_1 MGYG000304142_00455 440080 441288 -1 - - - true
+MGYG000304142_1 MGYG000304142_00456 441289 442353 -1 - - - true
+MGYG000304142_1 MGYG000304142_00457 442390 444153 -1 - - - true
+MGYG000304142_1 MGYG000304142_00458 444153 444410 -1 - - - true
+MGYG000304142_1 MGYG000304142_00459 444407 445120 -1 - - - true
+MGYG000304142_1 MGYG000304142_00460 445120 446073 -1 - - - true
+MGYG000304142_1 MGYG000304142_00461 446074 447117 -1 - - - true
+MGYG000304142_1 MGYG000304142_00462 447183 448304 1 - - - true
+MGYG000304142_1 MGYG000304142_00463 448355 449101 -1 - - - true
+MGYG000304142_1 MGYG000304142_00464 449103 449666 -1 - - - true
+MGYG000304142_1 MGYG000304142_00465 449714 449908 -1 - - - true
+MGYG000304142_1 MGYG000304142_00466 449924 450355 -1 - - - true
+MGYG000304142_1 MGYG000304142_00467 450387 450758 -1 - - - true
+MGYG000304142_1 MGYG000304142_00468 450942 451205 1 - - - true
+MGYG000304142_1 MGYG000304142_00469 451247 452197 -1 - - - true
+MGYG000304142_1 MGYG000304142_00470 452249 452542 1 - - - false
+MGYG000304142_1 MGYG000304142_00471 452599 453678 -1 - - - true
+MGYG000304142_2 MGYG000304142_00473 456 1004 1 - - - true
+MGYG000304142_2 MGYG000304142_00474 1314 1874 1 - - - true
+MGYG000304142_2 MGYG000304142_00475 2080 2640 1 - - - true
+MGYG000304142_2 MGYG000304142_00476 2874 3542 1 - - - true
+MGYG000304142_2 MGYG000304142_00477 3683 4684 1 - - - true
+MGYG000304142_2 MGYG000304142_00478 4685 5557 1 - - - true
+MGYG000304142_2 MGYG000304142_00479 5851 6615 1 - - - true
+MGYG000304142_2 MGYG000304142_00482 8425 8673 1 - - - true
+MGYG000304142_2 MGYG000304142_00483 8782 9231 -1 - - - true
+MGYG000304142_2 MGYG000304142_00484 9315 9635 1 - - - true
+MGYG000304142_2 MGYG000304142_00485 9632 11872 1 - - - true
+MGYG000304142_2 MGYG000304142_00486 12175 14244 1 - - - true
+MGYG000304142_2 MGYG000304142_00487 14348 15547 1 - - - true
+MGYG000304142_2 MGYG000304142_00488 15882 16154 -1 - - - true
+MGYG000304142_2 MGYG000304142_00489 16307 17524 1 - - - true
+MGYG000304142_2 MGYG000304142_00490 17874 18569 -1 - - - true
+MGYG000304142_2 MGYG000304142_00491 18640 19494 1 - - - true
+MGYG000304142_2 MGYG000304142_00492 19719 20885 -1 - - - true
+MGYG000304142_2 MGYG000304142_00493 21077 22162 -1 - - - true
+MGYG000304142_2 MGYG000304142_00494 22354 23187 -1 - - - true
+MGYG000304142_2 MGYG000304142_00495 23196 24266 -1 - - - true
+MGYG000304142_2 MGYG000304142_00496 24342 24695 -1 - - - true
+MGYG000304142_2 MGYG000304142_00497 24784 25767 -1 - - - true
+MGYG000304142_2 MGYG000304142_00498 25910 26125 1 - - - true
+MGYG000304142_2 MGYG000304142_00499 26318 27847 1 - - - true
+MGYG000304142_2 MGYG000304142_00500 28147 29190 1 - - - true
+MGYG000304142_2 MGYG000304142_00501 29242 31023 1 - - - true
+MGYG000304142_2 MGYG000304142_00502 31077 31358 -1 - - - true
+MGYG000304142_2 MGYG000304142_00503 31333 31629 -1 - - - true
+MGYG000304142_2 MGYG000304142_00504 31783 32085 -1 - - - true
+MGYG000304142_2 MGYG000304142_00505 32209 34749 1 - - - true
+MGYG000304142_2 MGYG000304142_00506 34770 36515 1 - - - true
+MGYG000304142_2 MGYG000304142_00507 36851 38749 1 - - - true
+MGYG000304142_2 MGYG000304142_00508 38936 40456 1 - - - true
+MGYG000304142_2 MGYG000304142_00509 40565 41365 1 - - - true
+MGYG000304142_2 MGYG000304142_00510 41384 42289 1 - - - true
+MGYG000304142_2 MGYG000304142_00511 42298 43092 1 - - - true
+MGYG000304142_2 MGYG000304142_00512 43390 44478 1 - - - true
+MGYG000304142_2 MGYG000304142_00513 44831 46900 1 - - - true
+MGYG000304142_2 MGYG000304142_00514 47138 49573 1 - - - true
+MGYG000304142_2 MGYG000304142_00515 49573 50292 1 - - - true
+MGYG000304142_2 MGYG000304142_00516 50285 51280 1 - - - true
+MGYG000304142_2 MGYG000304142_00517 51479 52048 -1 - - - false
+MGYG000304142_2 MGYG000304142_00518 52282 53337 1 - - - false
+MGYG000304142_2 MGYG000304142_00519 53512 54243 1 - - - true
+MGYG000304142_2 MGYG000304142_00520 54273 54884 1 - - - true
+MGYG000304142_2 MGYG000304142_00521 55048 55887 -1 - - - true
+MGYG000304142_2 MGYG000304142_00522 56018 56590 -1 - - - true
+MGYG000304142_2 MGYG000304142_00523 56716 57537 -1 - - - true
+MGYG000304142_2 MGYG000304142_00524 57665 58837 1 - - - false
+MGYG000304142_2 MGYG000304142_00525 58995 59648 1 - - - true
+MGYG000304142_2 MGYG000304142_00526 59735 60025 1 - - - true
+MGYG000304142_2 MGYG000304142_00527 60022 61848 1 - - - true
+MGYG000304142_3 MGYG000304142_00528 123 2504 -1 - - - true
+MGYG000304142_3 MGYG000304142_00529 2666 4156 -1 - - - true
+MGYG000304142_3 MGYG000304142_00530 4198 4581 -1 - - - true
+MGYG000304142_3 MGYG000304142_00531 4653 5702 1 - - - true
+MGYG000304142_3 MGYG000304142_00532 5683 6288 1 - - - true
+MGYG000304142_3 MGYG000304142_00533 6295 6873 -1 - - - true
+MGYG000304142_3 MGYG000304142_00534 6889 7566 -1 - - - true
+MGYG000304142_3 MGYG000304142_00535 7568 9208 -1 - - - true
+MGYG000304142_3 MGYG000304142_00536 9291 9710 -1 - - - true
+MGYG000304142_3 MGYG000304142_00537 9790 11472 1 - - - true
+MGYG000304142_3 MGYG000304142_00538 11485 11997 1 - - - true
+MGYG000304142_3 MGYG000304142_00539 12002 12568 1 - - - true
+MGYG000304142_3 MGYG000304142_00540 12584 13606 1 - - - true
+MGYG000304142_3 MGYG000304142_00541 13619 14212 1 - - - true
+MGYG000304142_3 MGYG000304142_00542 14271 14744 -1 - - - true
+MGYG000304142_3 MGYG000304142_00543 14756 15157 -1 - - - true
+MGYG000304142_3 MGYG000304142_00545 15277 15561 -1 - - - true
+MGYG000304142_3 MGYG000304142_00546 15603 15824 -1 - - - true
+MGYG000304142_3 MGYG000304142_00547 15866 16546 -1 - - - true
+MGYG000304142_3 MGYG000304142_00548 16568 17245 -1 - - - true
+MGYG000304142_3 MGYG000304142_00549 17306 18154 1 - - - true
+MGYG000304142_3 MGYG000304142_00550 18163 18627 1 - - - true
+MGYG000304142_3 MGYG000304142_00552 18769 20502 -1 - - - true
+MGYG000304142_3 MGYG000304142_00553 20566 21975 1 - - - true
+MGYG000304142_3 MGYG000304142_00554 21919 23328 -1 - - - true
+MGYG000304142_3 MGYG000304142_00555 23315 24430 -1 - - - true
+MGYG000304142_3 MGYG000304142_00556 24432 27461 -1 - - - true
+MGYG000304142_3 MGYG000304142_00557 27511 28728 1 - - - true
+MGYG000304142_3 MGYG000304142_00558 28777 30375 -1 - - - true
+MGYG000304142_3 MGYG000304142_00559 30356 31006 -1 - - - true
+MGYG000304142_3 MGYG000304142_00560 31040 32227 -1 - - - true
+MGYG000304142_3 MGYG000304142_00561 32227 33072 -1 - - - true
+MGYG000304142_3 MGYG000304142_00562 33159 34211 1 - - - true
+MGYG000304142_3 MGYG000304142_00563 34224 34688 -1 - - - true
+MGYG000304142_3 MGYG000304142_00564 34698 35615 -1 - - - true
+MGYG000304142_3 MGYG000304142_00565 35636 35983 -1 - - - true
+MGYG000304142_3 MGYG000304142_00566 36380 37771 1 - - - true
+MGYG000304142_3 MGYG000304142_00567 37764 38042 1 - - - true
+MGYG000304142_3 MGYG000304142_00568 38039 39121 1 - - - true
+MGYG000304142_3 MGYG000304142_00569 39121 40128 1 - - - true
+MGYG000304142_3 MGYG000304142_00570 40120 41307 -1 - - - true
+MGYG000304142_3 MGYG000304142_00571 41307 42116 -1 - - - true
+MGYG000304142_3 MGYG000304142_00572 42178 43203 1 - - - true
+MGYG000304142_3 MGYG000304142_00573 43212 43979 1 - - - true
+MGYG000304142_3 MGYG000304142_00574 43972 45813 1 - - - true
+MGYG000304142_3 MGYG000304142_00575 45816 46739 1 - - - true
+MGYG000304142_3 MGYG000304142_00576 46728 47777 -1 - - - true
+MGYG000304142_3 MGYG000304142_00577 47861 49483 -1 - - - true
+MGYG000304142_3 MGYG000304142_00578 49492 49761 -1 - - - true
+MGYG000304142_3 MGYG000304142_00579 49840 50430 -1 - - - false
+MGYG000304142_3 MGYG000304142_00580 50399 52255 -1 - - - true
+MGYG000304142_3 MGYG000304142_00581 52255 52773 -1 - - - true
+MGYG000304142_4 MGYG000304142_00583 200 2023 1 - - - true
+MGYG000304142_4 MGYG000304142_00584 2145 2678 1 - - - false
+MGYG000304142_4 MGYG000304142_00585 2641 3750 1 - - - false
+MGYG000304142_4 MGYG000304142_00587 4414 4854 -1 - - - true
+MGYG000304142_4 MGYG000304142_00588 4956 5381 1 - - - true
+MGYG000304142_4 MGYG000304142_00589 5513 6154 1 - - - true
+MGYG000304142_4 MGYG000304142_00590 6142 6825 1 - - - true
+MGYG000304142_4 MGYG000304142_00591 6828 9092 1 - - - true
+MGYG000304142_4 MGYG000304142_00592 9222 10115 -1 - - - true
+MGYG000304142_4 MGYG000304142_00593 10136 10774 -1 - - - true
+MGYG000304142_4 MGYG000304142_00594 10855 11160 1 - - - true
+MGYG000304142_4 MGYG000304142_00595 11413 13614 1 - - - true
+MGYG000304142_4 MGYG000304142_00596 13679 15634 -1 - - - true
+MGYG000304142_4 MGYG000304142_00597 15690 16241 1 - - - true
+MGYG000304142_4 MGYG000304142_00598 16250 16948 1 - - - true
+MGYG000304142_4 MGYG000304142_00599 16994 18148 1 - - - true
+MGYG000304142_4 MGYG000304142_00600 18126 18941 1 - - - true
+MGYG000304142_4 MGYG000304142_00601 18976 20235 1 - - - true
+MGYG000304142_4 MGYG000304142_00602 20247 20702 1 - - - true
+MGYG000304142_4 MGYG000304142_00603 20763 21326 -1 - - - true
+MGYG000304142_4 MGYG000304142_00604 21624 21791 -1 - - - true
+MGYG000304142_4 MGYG000304142_00605 21957 22139 1 - - - true
+MGYG000304142_5 MGYG000304142_00606 480 986 -1 - - - true
+MGYG000304142_5 MGYG000304142_00607 999 3566 -1 - - - true
+MGYG000304142_5 MGYG000304142_00608 3579 5588 -1 - - - true
+MGYG000304142_5 MGYG000304142_00609 5786 8863 -1 - - - true
+MGYG000304142_5 MGYG000304142_00610 8866 9339 -1 - - - true
+MGYG000304142_5 MGYG000304142_00611 9423 9827 -1 - - - true
+MGYG000304142_5 MGYG000304142_00612 11929 13422 1 - - - true
+MGYG000304142_5 MGYG000304142_00614 13690 14160 1 - - - true
+MGYG000304142_5 MGYG000304142_00615 14148 14342 1 - - - true
+MGYG000304142_5 MGYG000304142_00616 14364 14711 1 - - - true
+MGYG000304142_5 MGYG000304142_00617 15205 15468 1 - - - true
+MGYG000304142_5 MGYG000304142_00618 15562 16452 -1 - - - true
+MGYG000304142_5 MGYG000304142_00619 16677 18782 -1 - - - true
+MGYG000304142_5 MGYG000304142_00620 18917 20761 -1 - - - true
+MGYG000304142_6 MGYG000304142_00621 208 2295 -1 - - - true
+MGYG000304142_6 MGYG000304142_00622 2392 2994 -1 - - - true
+MGYG000304142_6 MGYG000304142_00623 3026 4105 -1 - - - true
+MGYG000304142_6 MGYG000304142_00624 4095 4604 -1 - - - true
+MGYG000304142_6 MGYG000304142_00626 4726 5685 1 - - - true
+MGYG000304142_6 MGYG000304142_00627 5718 6038 1 - - - false
+MGYG000304142_6 MGYG000304142_00628 6236 6706 1 - - - true
+MGYG000304142_6 MGYG000304142_00629 6754 7635 -1 - - - true
+MGYG000304142_6 MGYG000304142_00630 7635 7865 -1 - - - true
+MGYG000304142_6 MGYG000304142_00631 7874 8509 -1 - - - true
+MGYG000304142_6 MGYG000304142_00632 8579 10756 -1 - - - true
+MGYG000304142_6 MGYG000304142_00633 10911 13445 -1 - - - true
+MGYG000304142_6 MGYG000304142_00634 13448 14548 -1 - - - true
+MGYG000304142_6 MGYG000304142_00635 14767 15219 -1 - - - true
+MGYG000304142_7 MGYG000304142_00636 67 399 -1 - - - true
+MGYG000304142_7 MGYG000304142_00637 583 1080 -1 - - - true
+MGYG000304142_7 MGYG000304142_00638 1064 2656 -1 - - - true
+MGYG000304142_7 MGYG000304142_00639 2804 3301 -1 - - - true
+MGYG000304142_7 MGYG000304142_00640 3381 4142 1 - - - true
+MGYG000304142_7 MGYG000304142_00642 4283 4888 -1 - - - true
+MGYG000304142_7 MGYG000304142_00645 5252 6403 -1 - - - true
+MGYG000304142_7 MGYG000304142_00646 6438 6833 1 - - - true
+MGYG000304142_7 MGYG000304142_00647 6826 7266 1 - - - true
+MGYG000304142_7 MGYG000304142_00648 7364 8671 -1 - - - true
+MGYG000304142_7 MGYG000304142_00649 8717 9766 1 - - - true
+MGYG000304142_7 MGYG000304142_00650 9802 10740 1 - - - true
+MGYG000304142_8 MGYG000304142_00653 200 2005 1 - - - true
+MGYG000304142_8 MGYG000304142_00654 2239 2463 1 - - - true
+MGYG000304142_8 MGYG000304142_00655 2598 4481 1 - - - true
+MGYG000304142_8 MGYG000304142_00656 4555 5004 1 - - - true
+MGYG000304142_8 MGYG000304142_00657 5001 5582 1 - - - true
+MGYG000304142_8 MGYG000304142_00658 5569 6354 1 - - - true
+MGYG000304142_8 MGYG000304142_00659 6454 7158 -1 - - - true
+MGYG000304142_8 MGYG000304142_00660 7323 7916 -1 - - - true
+MGYG000304142_8 MGYG000304142_00661 7916 8722 -1 - - - true
+MGYG000304142_8 MGYG000304142_00662 8898 9536 -1 - - - true
+MGYG000304142_8 MGYG000304142_00663 9650 11152 1 - - - true
+MGYG000304142_9 MGYG000304142_00664 257 1999 1 - - - true
+MGYG000304142_9 MGYG000304142_00665 2301 4220 1 - - - false
+MGYG000304142_9 MGYG000304142_00666 4449 5696 1 - - - true
+MGYG000304142_9 MGYG000304142_00667 5764 7221 1 - - - true
+MGYG000304142_10 MGYG000304142_00671 3842 4291 -1 - - - true
+MGYG000304142_10 MGYG000304142_00675 4746 7025 -1 - - - true
+MGYG000304142_12 MGYG000304142_00679 234 881 -1 - - - true
+MGYG000304142_12 MGYG000304142_00680 881 1528 -1 - - - true
+MGYG000304142_12 MGYG000304142_00681 1649 2572 -1 - - - true
+MGYG000304142_12 MGYG000304142_00682 2572 4398 -1 - - - true
+MGYG000304142_14 MGYG000304142_00686 1016 3010 -1 - - - true
+MGYG000304142_14 MGYG000304142_00687 3149 3541 -1 - - - true
+MGYG000304142_15 MGYG000304142_00689 45 581 1 - - - true
+MGYG000304142_15 MGYG000304142_00690 581 907 1 - - - true
+MGYG000304142_15 MGYG000304142_00691 946 2475 -1 - - - true
+MGYG000304142_16 MGYG000304142_00692 27 1328 1 - - - true
+MGYG000304142_16 MGYG000304142_00693 1463 1714 1 - - - true
+MGYG000304142_16 MGYG000304142_00694 1742 2518 1 - - - true
+MGYG000304142_17 MGYG000304142_00696 167 505 -1 - - - true
+MGYG000304142_17 MGYG000304142_00697 515 961 -1 - - - true
+MGYG000304142_17 MGYG000304142_00698 1040 1534 -1 - - - true
+MGYG000304142_17 MGYG000304142_00699 1551 1964 -1 - - - true
+MGYG000304142_17 MGYG000304142_00700 1957 2301 -1 - - - true
+MGYG000304142_17 MGYG000304142_00701 2303 2533 -1 - - - true
diff --git a/tests/reference_dbs/human-vaginal-v1.0/genomes-all_metadata.tsv b/tests/reference_dbs/human-vaginal-v1.0/genomes-all_metadata.tsv
new file mode 100644
index 0000000..cdeb433
--- /dev/null
+++ b/tests/reference_dbs/human-vaginal-v1.0/genomes-all_metadata.tsv
@@ -0,0 +1,2 @@
+Genome Genome_type Length N_contigs N50 GC_content Completeness Contamination rRNA_5S rRNA_16S rRNA_23S tRNAs Genome_accession Species_rep Lineage Sample_accession Study_accession Country Continent FTP_download
+MGYG000303700 MAG 678213 2 466332 47.78 63.68 0.0 0.00 99.74 99.56 20 CAMPLK01 MGYG000303700 d__Bacteria;p__Patescibacteria;c__Saccharimonadia;o__Saccharimonadales;f__Nanoperiomorbaceae;g__Nanoperiomorbus;s__Nanoperiomorbus sp004136275 SAMEA111346158 ERP138373 not provided not provided ftp://ftp.ebi.ac.uk/pub/databases/metagenomics/mgnify_genomes/human-vaginal/v1.0/all_genomes/MGYG0003037/MGYG000303700/genomes1/MGYG000303700.gff.gz
diff --git a/tests/reference_dbs/human-vaginal-v1.0/kegg_completeness_DB/MGYG000303700_clstr_kegg_comp.tsv b/tests/reference_dbs/human-vaginal-v1.0/kegg_completeness_DB/MGYG000303700_clstr_kegg_comp.tsv
new file mode 100644
index 0000000..e7f789c
--- /dev/null
+++ b/tests/reference_dbs/human-vaginal-v1.0/kegg_completeness_DB/MGYG000303700_clstr_kegg_comp.tsv
@@ -0,0 +1,31 @@
+#module pangenome core
+M00855|Glycogen degradation, glycogen => glucose-6P 50.0 50.0
+M00549|Nucleotide sugar biosynthesis, glucose => UDP-glucose 33.33 33.33
+M00579|Phosphate acetyltransferase-acetate kinase pathway, acetyl-CoA => acetate 50.0 50.0
+M00140|C1-unit interconversion, prokaryotes 33.33 33.33
+M00002|Glycolysis, core module involving three-carbon compounds 100.0 100.0
+M00649|Multidrug resistance, efflux pump AdeABC 33.33 33.33
+M00089|Triacylglycerol biosynthesis 25.0 25.0
+M00345|Formaldehyde assimilation, ribulose monophosphate pathway 33.33 33.33
+M00909|UDP-N-acetyl-D-glucosamine biosynthesis, prokaryotes, glucose => UDP-GlcNAc 20.0 20.0
+M00001|Glycolysis (Embden-Meyerhof pathway), glucose => pyruvate 77.78 77.78
+M00565|Trehalose biosynthesis, D-glucose 1P => trehalose 33.33 33.33
+M00357|Methanogenesis, acetate => methane 10.0 10.0
+M00308|Semi-phosphorylative Entner-Doudoroff pathway, gluconate => glycerate-3P 25.0 25.0
+M00129|Ascorbate biosynthesis, animals, glucose-1P => ascorbate 14.29 14.29
+M00552|D-galactonate degradation, De Ley-Doudoroff pathway, D-galactonate => glycerate-3P 40.0 40.0
+M00049|Adenine ribonucleotide biosynthesis, IMP => ADP,ATP 25.0 25.0
+M00086|beta-Oxidation, acyl-CoA synthesis 100.0 100.0
+M00165|Reductive pentose phosphate cycle (Calvin cycle) 63.64 63.64
+M00035|Methionine degradation 25.0 0
+M00632|Galactose degradation, Leloir pathway, galactose => alpha-D-glucose-1P 25.0 25.0
+M00346|Formaldehyde assimilation, serine pathway 11.11 11.11
+M00377|Reductive acetyl-CoA pathway (Wood-Ljungdahl pathway) 14.29 14.29
+M00004|Pentose phosphate pathway (Pentose phosphate cycle) 58.33 58.33
+M00726|Cationic antimicrobial peptide (CAMP) resistance, lysyl-phosphatidylglycerol (L-PG) synthase MprF 33.33 33.33
+M00052|Pyrimidine ribonucleotide biosynthesis, UMP => UDP/UTP,CDP/CTP 33.33 33.33
+M00007|Pentose phosphate pathway, non-oxidative phase, fructose 6P => ribose 5P 75.0 75.0
+M00003|Gluconeogenesis, oxaloacetate => fructose-6P 78.57 78.57
+M00121|Heme biosynthesis, plants and bacteria, glutamate => heme 10.0 10.0
+M00854|Glycogen biosynthesis, glucose-1P => glycogen/starch 50.0 50.0
+M00344|Formaldehyde assimilation, xylulose monophosphate pathway 25.0 25.0
diff --git a/tests/reference_dbs/human-vaginal-v1.0/sourmash_species_representatives_k21.sbt.zip b/tests/reference_dbs/human-vaginal-v1.0/sourmash_species_representatives_k21.sbt.zip
new file mode 100644
index 0000000..0b15c6b
Binary files /dev/null and b/tests/reference_dbs/human-vaginal-v1.0/sourmash_species_representatives_k21.sbt.zip differ
diff --git a/tests/test_samplesheet.csv b/tests/test_samplesheet.csv
index 412a7be..b23e3f7 100644
--- a/tests/test_samplesheet.csv
+++ b/tests/test_samplesheet.csv
@@ -1,3 +1,2 @@
sample,fastq_1,fastq_2
-single_test,https://github.com/EBI-Metagenomics/shallowmapping/raw/dev/tests/data/test2_R1.fastq.gz
-paired_test,https://github.com/EBI-Metagenomics/shallowmapping/raw/dev/tests/data/test2_R1.fastq.gz,https://github.com/EBI-Metagenomics/shallowmapping/raw/dev/tests/data/test2_R2.fastq.gz
+test,https://github.com/EBI-Metagenomics/shallowmapping/raw/refs/heads/dev/tests/data/reads_MGYG000303700_1.fastq.gz,https://github.com/EBI-Metagenomics/shallowmapping/raw/refs/heads/dev/tests/data/reads_MGYG000303700_2.fastq.gz
diff --git a/workflows/shallowmapping.nf b/workflows/shallowmapping.nf
index a946719..202289e 100644
--- a/workflows/shallowmapping.nf
+++ b/workflows/shallowmapping.nf
@@ -1,39 +1,4 @@
-include { validateParameters; paramsHelp; paramsSummaryLog; fromSamplesheet; paramsSummaryMap } from 'plugin/nf-validation'
-
-def summary_params = paramsSummaryMap(workflow)
-
-validateParameters()
-
-log.info paramsSummaryLog(workflow)
-
-if (params.help) {
- log.info paramsHelp("nextflow run ebi-metagenomics-shallowmapping --help")
- exit 0
-}
-
-/*
-~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
- CONFIG FILES
-~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
-*/
-
-ch_multiqc_config = Channel.fromPath("$projectDir/assets/multiqc_config.yml", checkIfExists: true)
-ch_multiqc_custom_config = params.multiqc_config ? Channel.fromPath( params.multiqc_config, checkIfExists: true ) : Channel.empty()
-ch_multiqc_logo = params.multiqc_logo ? Channel.fromPath( params.multiqc_logo, checkIfExists: true ) : Channel.empty()
-ch_multiqc_custom_methods_description = params.multiqc_methods_description ? file(params.multiqc_methods_description, checkIfExists: true) : file("$projectDir/assets/methods_description_template.yml", checkIfExists: true)
-
-
-/*
-~~~~~~~~~~~~~~~~~
- DBs
-~~~~~~~~~~~~~~~~~
-*/
-dram_dbs = file("$params.shallow_dbs_path/external_dbs/dram_distill_dbs", checkIfExists: true)
-sourmash_db = file("$params.shallow_dbs_path/$params.biome/sourmash_species_representatives_k21.sbt.zip", checkIfExists: true)
-bwa_db = file("$params.shallow_dbs_path/$params.biome/bwa_reps.*", checkIfExists: true)
-pangenome_db = file("$params.shallow_dbs_path/$params.biome/functional_profiles_DB/", checkIfExists: true)
-kegg_comp_db = file("$params.shallow_dbs_path/$params.biome/kegg_completeness_DB/", checkIfExists: true)
-
+include { validateParameters ; paramsHelp ; paramsSummaryLog ; fromSamplesheet ; paramsSummaryMap } from 'plugin/nf-validation'
/*
~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
@@ -42,7 +7,7 @@ kegg_comp_db = file("$params.shallow_dbs_path/$params.biome/kegg_completene
*/
// QC and version modules
-include { FASTP } from '../modules/local/fastp/main'
+include { FASTP } from '../modules/nf-core/fastp/main'
include { BWAMEM2DECONTNOBAMS as HUMAN_PHIX_DECONT } from '../modules/ebi-metagenomics/bwamem2decontnobams/main'
include { BWAMEM2DECONTNOBAMS as HOST_DECONT } from '../modules/ebi-metagenomics/bwamem2decontnobams/main'
include { FASTQC as FASTQC_DECONT } from '../modules/nf-core/fastqc/main'
@@ -50,33 +15,41 @@ include { MULTIQC } from '../modules/nf-core/mu
include { CUSTOM_DUMPSOFTWAREVERSIONS } from '../modules/nf-core/custom/dumpsoftwareversions/main'
// Mapping modules
-include { SOURMASH_GATHER } from '../modules/nf-core/sourmash/gather/main'
-include { SOURMASH_SKETCH } from '../modules/nf-core/sourmash/sketch/main'
-include { POSTPROC_SOURMASHTAXO } from '../modules/local/postproc/sourmashtaxo'
-include { POSTPROC_FUNCTIONSPRED as SM_FUNC } from '../modules/local/postproc/functionspred'
-include { DRAM_DISTILL as SM_DRAM } from '../modules/local/dram/distill'
-include { KEGG_COMPLETENESS as SM_COMM_KC } from '../modules/local/kegg/completeness'
-include { KEGG_SPECIES as SM_SPEC_KC } from '../modules/local/kegg/species'
-
-include { ALIGN_BWAMEM2 } from '../modules/local/align/bwamem2_pysam'
-include { POSTPROC_BWATAXO } from '../modules/local/postproc/bwataxo'
-include { POSTPROC_FUNCTIONSPRED as BWA_FUNC } from '../modules/local/postproc/functionspred'
-include { DRAM_DISTILL as BWA_DRAM } from '../modules/local/dram/distill'
-include { KEGG_COMPLETENESS as BWA_COMM_KC } from '../modules/local/kegg/completeness'
-include { KEGG_SPECIES as BWA_SPEC_KC } from '../modules/local/kegg/species'
+include { SOURMASH_GATHER } from '../modules/nf-core/sourmash/gather/main'
+include { SOURMASH_SKETCH } from '../modules/nf-core/sourmash/sketch/main'
+include { POSTPROC_SOURMASHTAXO } from '../modules/local/postproc/sourmashtaxo'
+include { POSTPROC_FUNCTIONSPRED as SM_FUNC } from '../modules/local/postproc/functionspred'
+include { DRAM_DISTILL as SM_DRAM } from '../modules/local/dram/distill'
+include { KEGG_COMPLETENESS as SM_COMM_KC } from '../modules/local/kegg/completeness'
+include { KEGG_SPECIES as SM_SPEC_KC } from '../modules/local/kegg/species'
+
+include { ALIGN_BWAMEM2 } from '../modules/local/align/bwamem2_pysam'
+include { POSTPROC_BWATAXO } from '../modules/local/postproc/bwataxo'
+include { POSTPROC_FUNCTIONSPRED as BWA_FUNC } from '../modules/local/postproc/functionspred'
+include { DRAM_DISTILL as BWA_DRAM } from '../modules/local/dram/distill'
+include { KEGG_COMPLETENESS as BWA_COMM_KC } from '../modules/local/kegg/completeness'
+include { KEGG_SPECIES as BWA_SPEC_KC } from '../modules/local/kegg/species'
// Community results integration
-include { POSTPROC_INTEGRATOR as INTEGRA_TAXO } from '../modules/local/postproc/integrator'
-include { POSTPROC_INTEGRATOR as INTEGRA_KO } from '../modules/local/postproc/integrator'
-include { POSTPROC_INTEGRATOR as INTEGRA_PFAM } from '../modules/local/postproc/integrator'
-include { POSTPROC_INTEGRATOR as INTEGRA_MODU } from '../modules/local/postproc/integrator'
-include { DRAM_DISTILL as INTEGRA_DRAM } from '../modules/local/dram/distill'
+include { POSTPROC_INTEGRATOR as INTEGRA_TAXO } from '../modules/local/postproc/integrator'
+include { POSTPROC_INTEGRATOR as INTEGRA_KO } from '../modules/local/postproc/integrator'
+include { POSTPROC_INTEGRATOR as INTEGRA_PFAM } from '../modules/local/postproc/integrator'
+include { POSTPROC_INTEGRATOR as INTEGRA_MODU } from '../modules/local/postproc/integrator'
+include { DRAM_DISTILL } from '../modules/local/dram/distill'
+
+include { POSTPROC_INTEGRATOR as BWA_INT_TAXO } from '../modules/local/postproc/integrator'
+include { POSTPROC_INTEGRATOR as BWA_INT_KO } from '../modules/local/postproc/integrator'
+include { POSTPROC_INTEGRATOR as BWA_INT_PFAM } from '../modules/local/postproc/integrator'
+include { POSTPROC_INTEGRATOR as BWA_INT_MODU } from '../modules/local/postproc/integrator'
+include { DRAM_DISTILL as BWA_INT_DRAM } from '../modules/local/dram/distill'
-include { POSTPROC_INTEGRATOR as BWA_INT_TAXO } from '../modules/local/postproc/integrator'
-include { POSTPROC_INTEGRATOR as BWA_INT_KO } from '../modules/local/postproc/integrator'
-include { POSTPROC_INTEGRATOR as BWA_INT_PFAM } from '../modules/local/postproc/integrator'
-include { POSTPROC_INTEGRATOR as BWA_INT_MODU } from '../modules/local/postproc/integrator'
-include { DRAM_DISTILL as BWA_INT_DRAM } from '../modules/local/dram/distill'
+/*
+~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+ IMPORT SUBWORKFLOWS
+~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+*/
+include { DOWNLOAD_REFERENCES } from '../subworkflows/download_references'
+include { DOWNLOAD_DRAM_DB } from '../modules/local/dram/download_dram_db.nf'
/*
@@ -85,12 +58,34 @@ include { DRAM_DISTILL as BWA_INT_DRAM } from '../modules/local/dram/dist
~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
*/
-def multiqc_report = []
-
workflow SHALLOWMAPPING {
- ch_versions = Channel.empty()
- ch_log = Channel.empty()
- ch_multiqc_files = Channel.empty()
+
+ def multiqc_report = []
+
+ def summary_params = paramsSummaryMap(workflow)
+
+ validateParameters()
+
+ log.info(paramsSummaryLog(workflow))
+
+ if (params.help) {
+ log.info(paramsHelp("nextflow run ebi-metagenomics-shallowmapping --help"))
+ exit(0)
+ }
+
+ /*
+ ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+ CONFIG FILES
+ ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
+ */
+
+ ch_multiqc_config = Channel.fromPath("${projectDir}/assets/multiqc_config.yml", checkIfExists: true)
+ ch_multiqc_custom_config = params.multiqc_config ? Channel.fromPath(params.multiqc_config, checkIfExists: true) : Channel.empty()
+ ch_multiqc_logo = params.multiqc_logo ? Channel.fromPath(params.multiqc_logo, checkIfExists: true) : Channel.empty()
+ ch_multiqc_custom_methods_description = params.multiqc_methods_description ? file(params.multiqc_methods_description, checkIfExists: true) : file("${projectDir}/assets/methods_description_template.yml", checkIfExists: true)
+
+ ch_versions = Channel.empty()
+ ch_multiqc_files = Channel.empty()
// ---- Combine data into the reads channel ---- //
@@ -104,167 +99,182 @@ workflow SHALLOWMAPPING {
return tuple(meta + [single_end: false], reads)
}
}
- ch_reads = Channel.fromSamplesheet("input").map(groupReads) // [ meta, [raw_reads] ]
-
+ ch_reads = Channel.fromSamplesheet("input").map(groupReads)// [ meta, [raw_reads] ]
// ---- PREPROCESSING: Trimming, decontamination, and post-treatment qc ---- //
- FASTP ( ch_reads )
+ FASTP(ch_reads, [], [], [], [])
ch_versions = ch_versions.mix(FASTP.out.versions.first())
+ /* Download the reference databases */
+ DOWNLOAD_REFERENCES(params.biome, params.run_bwa)
+
// Creating channel for decontamination with human + phix genomes
- hp_ref = Channel.fromPath("${params.decont_reference_paths}/human_phix*", checkIfExists: true).collect().map { db_files ->
- [ [id: 'human_phiX'], db_files ]
- }
- HUMAN_PHIX_DECONT ( FASTP.out.reads, hp_ref )
+ HUMAN_PHIX_DECONT(FASTP.out.reads, DOWNLOAD_REFERENCES.out.human_phix_index_ch)
+
ch_versions = ch_versions.mix(HUMAN_PHIX_DECONT.out.versions.first())
// Creating channel for decontamination with host when biome != human
+
+ /*****************************************************************/
+ /* DECONTAMIONATION using the biome cannonical host organism */
+ /* For example, for cow-rumen-v1.0.1, it will use the cow genome */
+ /* MGnify hosts these genomes on our FTP, and the pipeline will */
+ /* download them from the FTP server */
+ /*****************************************************************/
def host_name = params.biome.split('-')[0]
- if ( params.biome.contains( 'human' ) ) {
- hq_reads = HUMAN_PHIX_DECONT.out.decont_reads
- } else {
- host_ref = Channel.fromPath("${params.decont_reference_paths}/${host_name}.*", checkIfExists: true).collect().map { db_files ->
- [ [id: host_name], db_files ]
- }
- HOST_DECONT ( HUMAN_PHIX_DECONT.out.decont_reads, host_ref )
+ if (params.biome.contains('human')) {
+ hq_reads = HUMAN_PHIX_DECONT.out.decont_reads
+ }
+ else {
+ // Custom reference
+ host_ref = Channel.fromPath("${params.decontamination_indexes}/${host_name}.*", checkIfExists: true)
+ .collect()
+ .map { db_files ->
+ [[id: host_name], db_files]
+ }
+
+ HOST_DECONT(HUMAN_PHIX_DECONT.out.decont_reads, host_ref)
hq_reads = HOST_DECONT.out.decont_reads
ch_versions = ch_versions.mix(HOST_DECONT.out.versions.first())
}
// QC report after decontamination
- FASTQC_DECONT ( hq_reads )
+ FASTQC_DECONT(hq_reads)
ch_versions = ch_versions.mix(FASTQC_DECONT.out.versions.first())
// ---- MAPPING READS with sourmash: sketch decont reads, mapping, and profiling ---- //
// Sketching decontaminated reads and running mapping
- SOURMASH_SKETCH ( hq_reads )
+ SOURMASH_SKETCH(hq_reads)
ch_versions = ch_versions.mix(SOURMASH_SKETCH.out.versions.first())
- SOURMASH_GATHER ( SOURMASH_SKETCH.out.signatures, sourmash_db, false, false, false, false )
+ SOURMASH_GATHER(SOURMASH_SKETCH.out.signatures, DOWNLOAD_REFERENCES.out.biome_sourmash_db, false, false, false, false)
ch_versions = ch_versions.mix(SOURMASH_GATHER.out.versions.first())
// Processing sourmash mapping output: generating taxonomic and functional profiles
- POSTPROC_SOURMASHTAXO ( SOURMASH_GATHER.out.result, "${params.shallow_dbs_path}/${params.biome}/genomes-all_metadata.tsv" )
+ POSTPROC_SOURMASHTAXO(SOURMASH_GATHER.out.result, DOWNLOAD_REFERENCES.out.biome_genomes_metadata)
ch_versions = ch_versions.mix(POSTPROC_SOURMASHTAXO.out.versions.first())
if (params.core_mode) {
- SM_FUNC ( POSTPROC_SOURMASHTAXO.out.sm_taxo, 'sm', 'core', pangenome_db, dram_dbs )
+ SM_FUNC(POSTPROC_SOURMASHTAXO.out.sm_taxo, 'sm', 'core', DOWNLOAD_REFERENCES.out.biome_pangenome_functional_anns_db, DOWNLOAD_REFERENCES.out.dram_dbs)
ch_versions = ch_versions.mix(SM_FUNC.out.versions.first())
- SM_SPEC_KC ( POSTPROC_SOURMASHTAXO.out.sm_taxo, 'sm', 'core', kegg_comp_db )
+ SM_SPEC_KC(POSTPROC_SOURMASHTAXO.out.sm_taxo, 'sm', 'core', DOWNLOAD_REFERENCES.out.biome_kegg_completeness_db)
ch_versions = ch_versions.mix(SM_SPEC_KC.out.versions.first())
- } else {
- SM_FUNC ( POSTPROC_SOURMASHTAXO.out.sm_taxo, 'sm', 'pan', pangenome_db, dram_dbs )
+ }
+ else {
+ SM_FUNC(POSTPROC_SOURMASHTAXO.out.sm_taxo, 'sm', 'pan', DOWNLOAD_REFERENCES.out.biome_pangenome_functional_anns_db, DOWNLOAD_REFERENCES.out.dram_dbs)
ch_versions = ch_versions.mix(SM_FUNC.out.versions.first())
- SM_SPEC_KC ( POSTPROC_SOURMASHTAXO.out.sm_taxo, 'sm', 'pan', kegg_comp_db )
+ SM_SPEC_KC(POSTPROC_SOURMASHTAXO.out.sm_taxo, 'sm', 'pan', DOWNLOAD_REFERENCES.out.biome_kegg_completeness_db)
ch_versions = ch_versions.mix(SM_SPEC_KC.out.versions.first())
}
- SM_DRAM ( SM_FUNC.out.dram_spec, 'sm', 'species')
+ SM_DRAM(SM_FUNC.out.dram_spec, 'sm', 'species')
ch_versions = ch_versions.mix(SM_DRAM.out.versions.first())
- SM_COMM_KC ( SM_FUNC.out.kegg_comm, 'sm' )
+ SM_COMM_KC(SM_FUNC.out.kegg_comm, 'sm')
ch_versions = ch_versions.mix(SM_COMM_KC.out.versions.first())
// ---- ANNOT INTEGRATOR: All samples matrices for taxo, kos, pfams, dram, and modules completeness ---- //
- INTEGRA_TAXO ( POSTPROC_SOURMASHTAXO.out.sm_taxo.collect{ it[1] }, 'sm_taxo' )
+ INTEGRA_TAXO(POSTPROC_SOURMASHTAXO.out.sm_taxo.collect { it[1] }, 'sm_taxo')
ch_versions = ch_versions.mix(INTEGRA_TAXO.out.versions.first())
- INTEGRA_KO ( SM_FUNC.out.kegg_comm.collect{ it[1] }, 'sm_kos' )
+ INTEGRA_KO(SM_FUNC.out.kegg_comm.collect { it[1] }, 'sm_kos')
ch_versions = ch_versions.mix(INTEGRA_KO.out.versions.first())
- INTEGRA_PFAM ( SM_FUNC.out.pfam_comm.collect{ it[1] }, 'sm_pfam' )
+ INTEGRA_PFAM(SM_FUNC.out.pfam_comm.collect { it[1] }, 'sm_pfam')
ch_versions = ch_versions.mix(INTEGRA_PFAM.out.versions.first())
- INTEGRA_MODU ( SM_COMM_KC.out.kegg_comp.collect{ it[1] }, 'sm_modules' )
+ INTEGRA_MODU(SM_COMM_KC.out.kegg_comp.collect { it[1] }, 'sm_modules')
ch_versions = ch_versions.mix(INTEGRA_MODU.out.versions.first())
- ch_dram_community = SM_FUNC.out.dram_comm.collectFile( name:'dram_community.tsv', newLine: true) { it[1] }.map { dram_summary -> [ [id: 'integrated'], dram_summary ] }
+ ch_dram_community = SM_FUNC.out.dram_comm.collectFile(name: 'dram_community.tsv', newLine: true) { it[1] }.map { dram_summary -> [[id: 'integrated'], dram_summary] }
- INTEGRA_DRAM ( ch_dram_community, 'sm', 'community' )
+ DRAM_DISTILL(ch_dram_community, 'sm', 'community')
- ch_versions = ch_versions.mix(INTEGRA_DRAM.out.versions.first())
+ ch_versions = ch_versions.mix(DRAM_DISTILL.out.versions.first())
// ---- MAPPING READS with bwamem2 (optional): mapping, cleaning output, and profiling ---- //
- if ( params.run_bwa ) {
+ if (params.run_bwa) {
- genomes_ref = Channel.fromPath( bwa_db ).collect().map { db_files ->
- [ [id: host_name ], db_files ]
- }
+ genomes_ref = Channel
+ .fromPath(DOWNLOAD_REFERENCES.out.biome_bwa_db)
+ .collect()
+ .map { db_files ->
+ [[id: host_name], db_files]
+ }
- ALIGN_BWAMEM2 ( hq_reads, genomes_ref )
+ ALIGN_BWAMEM2(hq_reads, genomes_ref)
ch_versions = ch_versions.mix(ALIGN_BWAMEM2.out.versions.first())
- POSTPROC_BWATAXO ( ALIGN_BWAMEM2.out.cov_file, "$params.shallow_dbs_path/$params.biome/genomes-all_metadata.tsv" )
+ POSTPROC_BWATAXO(ALIGN_BWAMEM2.out.cov_file, DOWNLOAD_REFERENCES.out.biome_genomes_metadata)
+
ch_versions = ch_versions.mix(POSTPROC_BWATAXO.out.versions.first())
- if ( params.core_mode ) {
- BWA_FUNC ( POSTPROC_BWATAXO.out.bwa_taxo, 'bwa', 'core', pangenome_db, dram_dbs )
+ if (params.core_mode) {
+ BWA_FUNC(POSTPROC_BWATAXO.out.bwa_taxo, 'bwa', 'core', DOWNLOAD_REFERENCES.out.biome_pangenome_functional_anns_db, DOWNLOAD_REFERENCES.out.dram_dbs)
ch_versions = ch_versions.mix(BWA_FUNC.out.versions.first())
- BWA_SPEC_KC ( POSTPROC_BWATAXO.out.bwa_taxo, 'bwa', 'core', kegg_comp_db )
+ BWA_SPEC_KC(POSTPROC_BWATAXO.out.bwa_taxo, 'bwa', 'core', DOWNLOAD_REFERENCES.out.biome_kegg_completeness_db)
ch_versions = ch_versions.mix(BWA_SPEC_KC.out.versions.first())
-
- } else {
- BWA_FUNC ( POSTPROC_BWATAXO.out.bwa_taxo, 'bwa', 'pan', pangenome_db, dram_dbs )
+ }
+ else {
+ BWA_FUNC(POSTPROC_BWATAXO.out.bwa_taxo, 'bwa', 'pan', DOWNLOAD_REFERENCES.out.biome_pangenome_functional_anns_db, DOWNLOAD_REFERENCES.out.dram_dbs)
ch_versions = ch_versions.mix(BWA_FUNC.out.versions.first())
- BWA_SPEC_KC ( POSTPROC_BWATAXO.out.bwa_taxo, 'bwa', 'pan', kegg_comp_db )
+ BWA_SPEC_KC(POSTPROC_BWATAXO.out.bwa_taxo, 'bwa', 'pan', DOWNLOAD_REFERENCES.out.biome_kegg_completeness_db)
ch_versions = ch_versions.mix(BWA_SPEC_KC.out.versions.first())
}
- BWA_DRAM (BWA_FUNC.out.dram_spec, 'bwa', 'species')
+ BWA_DRAM(BWA_FUNC.out.dram_spec, 'bwa', 'species')
ch_versions = ch_versions.mix(BWA_DRAM.out.versions.first())
- BWA_COMM_KC ( BWA_FUNC.out.kegg_comm, 'bwa' )
+ BWA_COMM_KC(BWA_FUNC.out.kegg_comm, 'bwa')
ch_versions = ch_versions.mix(BWA_COMM_KC.out.versions.first())
// ---- ANNOT INTEGRATOR: Matrices for taxo, kos, pfams, dram, and modules completeness ---- //
- BWA_INT_TAXO ( POSTPROC_BWATAXO.out.bwa_taxo.collect{ it[1] }, 'bwa_taxo' )
+ BWA_INT_TAXO(POSTPROC_BWATAXO.out.bwa_taxo.collect { it[1] }, 'bwa_taxo')
ch_versions = ch_versions.mix(BWA_INT_TAXO.out.versions.first())
- BWA_INT_KO ( BWA_FUNC.out.kegg_comm.collect{ it[1] }, 'bwa_kos' )
+ BWA_INT_KO(BWA_FUNC.out.kegg_comm.collect { it[1] }, 'bwa_kos')
ch_versions = ch_versions.mix(BWA_INT_KO.out.versions.first())
- BWA_INT_PFAM ( BWA_FUNC.out.pfam_comm.collect{ it[1] }, 'bwa_pfam' )
+ BWA_INT_PFAM(BWA_FUNC.out.pfam_comm.collect { it[1] }, 'bwa_pfam')
ch_versions = ch_versions.mix(BWA_INT_PFAM.out.versions.first())
- BWA_INT_MODU ( BWA_COMM_KC.out.kegg_comp.collect{ it[1] }, 'bwa_modules' )
+ BWA_INT_MODU(BWA_COMM_KC.out.kegg_comp.collect { it[1] }, 'bwa_modules')
ch_versions = ch_versions.mix(BWA_INT_MODU.out.versions.first())
- ch_bwa_dram_community = BWA_FUNC.out.dram_comm.collectFile(name:'dram_community.tsv', newLine: true){ it[1] }.map { dram_summary -> [ [id: 'integrated'], dram_summary ] }
- BWA_INT_DRAM ( ch_bwa_dram_community, 'bwa', 'community' )
+ ch_bwa_dram_community = BWA_FUNC.out.dram_comm.collectFile(name: 'dram_community.tsv', newLine: true) { it[1] }.map { dram_summary -> [[id: 'integrated'], dram_summary] }
+ BWA_INT_DRAM(ch_bwa_dram_community, 'bwa', 'community')
ch_versions = ch_versions.mix(BWA_INT_DRAM.out.versions.first())
}
// ---- Multiqc report ---- //
- CUSTOM_DUMPSOFTWAREVERSIONS (
+ CUSTOM_DUMPSOFTWAREVERSIONS(
ch_versions.unique().collectFile(name: 'collated_versions.yml')
)
- workflow_summary = WorkflowShallowmapping.paramsSummaryMultiqc(workflow, summary_params)
+ workflow_summary = WorkflowShallowmapping.paramsSummaryMultiqc(workflow, summary_params)
ch_workflow_summary = Channel.value(workflow_summary)
- methods_description = WorkflowShallowmapping.methodsDescriptionText(workflow, ch_multiqc_custom_methods_description, params)
+ methods_description = WorkflowShallowmapping.methodsDescriptionText(workflow, ch_multiqc_custom_methods_description, params)
ch_methods_description = Channel.value(methods_description)
ch_multiqc_files = ch_multiqc_files.mix(ch_workflow_summary.collectFile(name: 'workflow_summary_mqc.yaml'))
ch_multiqc_files = ch_multiqc_files.mix(ch_methods_description.collectFile(name: 'methods_description_mqc.yaml'))
ch_multiqc_files = ch_multiqc_files.mix(CUSTOM_DUMPSOFTWAREVERSIONS.out.mqc_yml.collect())
- ch_multiqc_files = ch_multiqc_files.mix(FASTP.out.json.collect{ it[1] }.ifEmpty([]))
- ch_multiqc_files = ch_multiqc_files.mix(FASTQC_DECONT.out.zip.collect{ it[1] }.ifEmpty([]))
+ ch_multiqc_files = ch_multiqc_files.mix(FASTP.out.json.collect { it[1] }.ifEmpty([]))
+ ch_multiqc_files = ch_multiqc_files.mix(FASTQC_DECONT.out.zip.collect { it[1] }.ifEmpty([]))
- MULTIQC (
+ MULTIQC(
ch_multiqc_files.collect(),
ch_multiqc_config.toList(),
ch_multiqc_custom_config.toList(),
- ch_multiqc_logo.toList()
+ ch_multiqc_logo.toList(),
)
multiqc_report = MULTIQC.out.report.toList()
-
}
-